Skip navigation links
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 

A

aah(Zmat) - Static method in class Jampack.Times
Computes AAH, where A is a Zmat.
AbelianGroupI - Interface in org.lsmp.djep.groupJep.interfaces
Represents a abelian (commutative) group.
about - Variable in class jplot.JPlot
 
AboutDialog - Class in jhepsim
 
AboutDialog(Component) - Constructor for class jhepsim.AboutDialog
 
AboutDialog - Class in jhplot.utils
 
AboutDialog(Component) - Constructor for class jhplot.utils.AboutDialog
 
AboutDialog - Class in jminhep.gui
About dialog
AboutDialog(MainFrame) - Constructor for class jminhep.gui.AboutDialog
 
abs(DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A[i] = Math.abs(A[i]).
abs(DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A[row,col] = Math.abs(A[row,col]).
abs - Static variable in class cern.jet.math.Functions
Function that returns Math.abs(a).
abs - Static variable in class cern.jet.math.IntFunctions
Function that returns Math.abs(a) == (a < 0) ? -a : a.
abs() - Method in class hephysics.particle.LParticle
Magnitude
abs() - Method in class hephysics.vec.Hep3Vector
Magnitude
abs(Z) - Static method in class Jampack.Z
Computes the absolute value of a Z.
abs(double[]) - Static method in class jhplot.math.ArrayMathUtils
Takes the absolute value of each component of an array.
abs(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Takes the absolute value of each component of an array.
abs(int[]) - Static method in class jhplot.math.ArrayMathUtils
Takes the absolute value of each component of an array.
abs(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Takes the absolute value of each component of an array.
ABS - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
abs(float) - Static method in class net.jafama.FastMath
 
abs(double) - Static method in class net.jafama.FastMath
 
abs(int) - Static method in class net.jafama.NumbersUtils
Possibly faster than java.lang.Math.abs(int).
abs(long) - Static method in class net.jafama.NumbersUtils
Possibly faster than java.lang.Math.abs(long).
abs(float) - Static method in class net.jafama.StrictFastMath
 
abs(double) - Static method in class net.jafama.StrictFastMath
 
abs() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
absolute value.
abs() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
absolute value.
Abs - Class in org.apache.commons.math3.analysis.function
Absolute value function.
Abs() - Constructor for class org.apache.commons.math3.analysis.function.Abs
 
abs() - Method in class org.apache.commons.math3.complex.Complex
Return the absolute value of this complex number.
abs() - Method in class org.apache.commons.math3.dfp.Dfp
Get the absolute value of instance.
abs() - Method in class org.apache.commons.math3.fraction.BigFraction
Returns the absolute value of this BigFraction.
abs() - Method in class org.apache.commons.math3.fraction.Fraction
Returns the absolute value of this fraction.
abs() - Method in interface org.apache.commons.math3.RealFieldElement
absolute value.
abs() - Method in class org.apache.commons.math3.util.Decimal64
absolute value.
abs(int) - Static method in class org.apache.commons.math3.util.FastMath
Absolute value.
abs(long) - Static method in class org.apache.commons.math3.util.FastMath
Absolute value.
abs(float) - Static method in class org.apache.commons.math3.util.FastMath
Absolute value.
abs(double) - Static method in class org.apache.commons.math3.util.FastMath
Absolute value.
Abs - Class in org.nfunk.jep.function
 
Abs() - Constructor for class org.nfunk.jep.function.Abs
 
abs(Object) - Method in class org.nfunk.jep.function.Abs
 
abs() - Method in class org.nfunk.jep.type.Complex
Returns the absolute value of the complex number.
abs1(Z) - Static method in class Jampack.Z
Computes the 1-norm of a Z
abs2() - Method in class org.nfunk.jep.type.Complex
Returns the square of the absolute value (re*re+im*im).
absNeg(int) - Static method in class net.jafama.NumbersUtils
 
absNeg(long) - Static method in class net.jafama.NumbersUtils
 
AbstractAnnotation - Class in org.jfree.chart.annotations
An abstract implementation of the Annotation interface, containing a mechanism for registering change listeners.
AbstractBin - Class in cern.hep.aida.bin
Abstract base class for all arbitrary-dimensional bins consumes double elements.
AbstractBin1D - Class in cern.hep.aida.bin
Abstract base class for all 1-dimensional bins consumes double elements.
AbstractBlock - Class in org.jfree.chart.block
A convenience class for creating new classes that implement the Block interface.
AbstractBooleanList - Class in cern.colt.list
Abstract base class for resizable lists holding boolean elements; abstract.
AbstractByteArrayOutputStream - Class in org.apache.commons.io.output
This is the base class for implementing an output stream in which the data is written into a byte array.
AbstractByteArrayOutputStream() - Constructor for class org.apache.commons.io.output.AbstractByteArrayOutputStream
 
AbstractByteList - Class in cern.colt.list
Abstract base class for resizable lists holding byte elements; abstract.
AbstractCategoryItemLabelGenerator - Class in org.jfree.chart.labels
A base class that can be used to create a label or tooltip generator that can be assigned to a CategoryItemRenderer.
AbstractCategoryItemRenderer - Class in org.jfree.chart.renderer.category
An abstract base class that you can use to implement a new CategoryItemRenderer.
AbstractCharacterFilterReader - Class in org.apache.commons.io.input
A filter reader that filters out characters where subclasses decide which characters to filter out.
AbstractCharList - Class in cern.colt.list
Abstract base class for resizable lists holding char elements; abstract.
AbstractCollection - Class in cern.colt.list
Abstract base class for resizable collections holding objects or primitive data types such as int, float, etc.
AbstractContinousDistribution - Class in cern.jet.random
Abstract base class for all continous distributions.
AbstractContinuousRandomVariable - Class in jhplot.math.num.random
Base continuous random variable that provides a {@link RNG) instance as a source for uniform random numbers.
AbstractConvergenceChecker<PAIR> - Class in org.apache.commons.math3.optim
Base class for all convergence checker implementations.
AbstractConvergenceChecker(double, double) - Constructor for class org.apache.commons.math3.optim.AbstractConvergenceChecker
Build an instance with a specified thresholds.
AbstractConvergenceChecker<PAIR> - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
AbstractConvergenceChecker() - Constructor for class org.apache.commons.math3.optimization.AbstractConvergenceChecker
Deprecated.
in 3.1 (to be removed in 4.0). Convergence thresholds are problem-dependent. As this class is intended for users who want to set their own convergence criterion instead of relying on an algorithm's default procedure, they should also set the thresholds appropriately (cf. MATH-798).
AbstractConvergenceChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.AbstractConvergenceChecker
Deprecated.
Build an instance with a specified thresholds.
AbstractCurveFitter - Class in org.apache.commons.math3.fitting
Base class that contains common code for fitting parametric univariate real functions y = f(pi;x), where x is the independent variable and the pi are the parameters.
AbstractCurveFitter() - Constructor for class org.apache.commons.math3.fitting.AbstractCurveFitter
 
AbstractDataset - Class in org.jfree.data.general
An abstract implementation of the Dataset interface, containing a mechanism for registering change listeners.
AbstractDescriptor - Class in org.jlab.groot.tree
 
AbstractDescriptor() - Constructor for class org.jlab.groot.tree.AbstractDescriptor
 
AbstractDialLayer - Class in org.jfree.chart.plot.dial
A base class that can be used to implement a DialLayer.
AbstractDifferentiableOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated.
As of 3.1 (to be removed in 4.0).
AbstractDifferentiableUnivariateSolver - Class in org.apache.commons.math3.analysis.solvers
Deprecated.
AbstractDiscreteDistribution - Class in cern.jet.random
Abstract base class for all discrete distributions.
AbstractDiscreteRandomVariable - Class in jhplot.math.num.random
Base continuous random variable that provides a {@link RNG) instance as a source for uniform random numbers.
AbstractDistribution - Class in cern.jet.random
Abstract base class for all random distributions.
AbstractDoubleIntMap - Class in cern.colt.map
Abstract base class for hash maps holding (key,value) associations of type (double-->int).
AbstractDoubleList - Class in cern.colt.list
Abstract base class for resizable lists holding double elements; abstract.
AbstractEvaluation - Class in org.apache.commons.math3.fitting.leastsquares
An implementation of LeastSquaresProblem.Evaluation that is designed for extension.
AbstractFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode
Base class managing common boilerplate for all integrators.
AbstractFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Basic implementation of FieldMatrix methods regardless of the underlying storage.
AbstractFieldStepInterpolator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.sampling
This abstract class represents an interpolator over the last step during an ODE integration.
AbstractFileFilter - Class in org.apache.commons.io.filefilter
An abstract class which implements the Java FileFilter and FilenameFilter interfaces via the IOFileFilter interface.
AbstractFileFilter() - Constructor for class org.apache.commons.io.filefilter.AbstractFileFilter
 
AbstractFloatList - Class in cern.colt.list
Abstract base class for resizable lists holding float elements; abstract.
AbstractFormat - Class in org.apache.commons.math3.fraction
Common part shared by both FractionFormat and BigFractionFormat.
AbstractFormatter - Class in cern.colt.matrix.impl
Abstract base class for flexible, well human readable matrix print formatting.
AbstractIntDoubleMap - Class in cern.colt.map
Abstract base class for hash maps holding (key,value) associations of type (int-->double).
AbstractIntegerDistribution - Class in org.apache.commons.math3.distribution
Base class for integer-valued discrete distributions.
AbstractIntegrator - Class in org.apache.commons.math3.ode
Base class managing common boilerplate for all integrators.
AbstractIntegrator(String) - Constructor for class org.apache.commons.math3.ode.AbstractIntegrator
Build an instance.
AbstractIntervalXYDataset - Class in org.jfree.data.xy
An base class that you can use to create new implementations of the IntervalXYDataset interface.
AbstractIntervalXYDataset() - Constructor for class org.jfree.data.xy.AbstractIntervalXYDataset
 
AbstractIntIntMap - Class in cern.colt.map
Abstract base class for hash maps holding (key,value) associations of type (int-->int).
AbstractIntList - Class in cern.colt.list
Abstract base class for resizable lists holding int elements; abstract.
AbstractIntObjectMap - Class in cern.colt.map
Abstract base class for hash maps holding (key,value) associations of type (int-->Object).
AbstractJetFinder - Class in hep.physics.jet
Base class for jet finders
AbstractLeastSquaresOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector.jacobian
Deprecated.
All classes and interfaces in this package are deprecated. The optimizers that were provided here were moved to the org.apache.commons.math3.fitting.leastsquares package (cf. MATH-1008).
AbstractLeastSquaresOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated.
As of 3.1 (to be removed in 4.0).
AbstractLinearOptimizer - Class in org.apache.commons.math3.optimization.linear
Deprecated.
As of 3.1 (to be removed in 4.0).
AbstractList - Class in cern.colt.list
Abstract base class for resizable lists holding objects or primitive data types such as int, float, etc.
AbstractListChromosome<T> - Class in org.apache.commons.math3.genetics
Chromosome represented by an immutable list of a fixed length.
AbstractListChromosome(List<T>) - Constructor for class org.apache.commons.math3.genetics.AbstractListChromosome
Constructor, copying the input representation.
AbstractListChromosome(T[]) - Constructor for class org.apache.commons.math3.genetics.AbstractListChromosome
Constructor, copying the input representation.
AbstractListChromosome(List<T>, boolean) - Constructor for class org.apache.commons.math3.genetics.AbstractListChromosome
Constructor.
AbstractLongList - Class in cern.colt.list
Abstract base class for resizable lists holding long elements; abstract.
AbstractLongObjectMap - Class in cern.colt.map
Abstract base class for hash maps holding (key,value) associations of type (long-->Object).
AbstractMap - Class in cern.colt.map
Abstract base class for hash maps holding objects or primitive data types such as int, float, etc.
AbstractMatrix - Class in cern.colt.matrix.impl
Abstract base class for arbitrary-dimensional matrices holding objects or primitive data types such as int, float, etc.
AbstractMatrix1D - Class in cern.colt.matrix.impl
Abstract base class for 1-d matrices (aka vectors) holding objects or primitive data types such as int, double, etc.
AbstractMatrix2D - Class in cern.colt.matrix.impl
Abstract base class for 2-d matrices holding objects or primitive data types such as int, double, etc.
AbstractMatrix3D - Class in cern.colt.matrix.impl
Abstract base class for 3-d matrices holding objects or primitive data types such as int, double, etc.
AbstractMouseHandlerFX - Class in org.jfree.chart.fx.interaction
A base class that can be used to implement the MouseHandlerFX interface.
AbstractMouseHandlerFX(String, boolean, boolean, boolean, boolean) - Constructor for class org.jfree.chart.fx.interaction.AbstractMouseHandlerFX
Creates a new instance.
AbstractMultipleLinearRegression - Class in org.apache.commons.math3.stat.regression
Abstract base class for implementations of MultipleLinearRegression.
AbstractMultipleLinearRegression() - Constructor for class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
 
AbstractMultivariateRealDistribution - Class in org.apache.commons.math3.distribution
Base class for multivariate probability distributions.
AbstractOptimizationProblem<PAIR> - Class in org.apache.commons.math3.optim
Base class for implementing optimization problems.
AbstractOverlay - Class in org.jfree.chart.panel
A base class for implementing overlays for a ChartPanel.
AbstractOverlay() - Constructor for class org.jfree.chart.panel.AbstractOverlay
Default constructor.
AbstractParameterizable - Class in org.apache.commons.math3.ode
This abstract class provides boilerplate parameters list.
AbstractPieItemLabelGenerator - Class in org.jfree.chart.labels
A base class used for generating pie chart item labels.
AbstractPieLabelDistributor - Class in org.jfree.chart.plot
A base class for handling the distribution of pie section labels.
AbstractPieLabelDistributor() - Constructor for class org.jfree.chart.plot.AbstractPieLabelDistributor
Creates a new instance.
AbstractPNode - Class in org.lsmp.djep.sjep
Default methods, when more specific methods do not work.
AbstractPNode(PolynomialCreator) - Constructor for class org.lsmp.djep.sjep.AbstractPNode
 
AbstractPolynomialSolver - Class in org.apache.commons.math3.analysis.solvers
Base class for solvers.
AbstractRandomGenerator - Class in org.apache.commons.math3.random
Abstract class implementing the RandomGenerator interface.
AbstractRandomGenerator() - Constructor for class org.apache.commons.math3.random.AbstractRandomGenerator
Construct a RandomGenerator.
AbstractRealDistribution - Class in org.apache.commons.math3.distribution
Base class for probability distributions on the reals.
AbstractRealMatrix - Class in org.apache.commons.math3.linear
Basic implementation of RealMatrix methods regardless of the underlying storage.
AbstractRegion<S extends Space,T extends Space> - Class in org.apache.commons.math3.geometry.partitioning
Abstract class for all regions, independently of geometry type or dimension.
AbstractRegion(Hyperplane<S>[], double) - Constructor for class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Build a convex region from an array of bounding hyperplanes.
AbstractRenderer - Class in org.jfree.chart.renderer
Base class providing common services for renderers.
AbstractRenderer() - Constructor for class org.jfree.chart.renderer.AbstractRenderer
Default constructor.
AbstractRewrite - Class in org.lsmp.djep.rewrite
Basic implementation for a RewriteRule.
AbstractRewrite(XJep) - Constructor for class org.lsmp.djep.rewrite.AbstractRewrite
Constructor with reference to XJep object.
AbstractScalarDifferentiableOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated.
As of 3.1 (to be removed in 4.0).
AbstractSeriesDataset - Class in org.jfree.data.general
An abstract implementation of the SeriesDataset interface, containing a mechanism for registering change listeners.
AbstractShortList - Class in cern.colt.list
Abstract base class for resizable lists holding short elements; abstract.
AbstractSimplex - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
This class implements the simplex concept.
AbstractSimplex - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
AbstractStepInterpolator - Class in org.apache.commons.math3.ode.sampling
This abstract class represents an interpolator over the last step during an ODE integration.
AbstractStorelessUnivariateStatistic - Class in org.apache.commons.math3.stat.descriptive
Abstract implementation of the StorelessUnivariateStatistic interface.
AbstractStorelessUnivariateStatistic() - Constructor for class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
 
AbstractSubHyperplane<S extends Space,T extends Space> - Class in org.apache.commons.math3.geometry.partitioning
This class implements the dimension-independent parts of SubHyperplane.
AbstractUnivariateDifferentiableSolver - Class in org.apache.commons.math3.analysis.solvers
Provide a default implementation for several functions useful to generic solvers.
AbstractUnivariateSolver - Class in org.apache.commons.math3.analysis.solvers
Base class for solvers.
AbstractUnivariateStatistic - Class in org.apache.commons.math3.stat.descriptive
Abstract base class for all implementations of the UnivariateStatistic interface.
AbstractUnivariateStatistic() - Constructor for class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
 
AbstractWell - Class in org.apache.commons.math3.random
This abstract class implements the WELL class of pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
AbstractXYAnnotation - Class in org.jfree.chart.annotations
The interface that must be supported by annotations that are to be added to an XYPlot.
AbstractXYDataset - Class in org.jfree.data.xy
An base class that you can use to create new implementations of the XYDataset interface.
AbstractXYDataset() - Constructor for class org.jfree.data.xy.AbstractXYDataset
 
AbstractXYItemLabelGenerator - Class in org.jfree.chart.labels
A base class for creating item label generators.
AbstractXYItemRenderer - Class in org.jfree.chart.renderer.xy
A base class that can be used to create new XYItemRenderer implementations.
AbstractXYZDataset - Class in org.jfree.data.xy
An base class that you can use to create new implementations of the XYZDataset interface.
AbstractXYZDataset() - Constructor for class org.jfree.data.xy.AbstractXYZDataset
 
accept(Object) - Method in interface hep.physics.filter.Predicate
 
accept(File) - Method in class jhplot.utils.ExtensionFileFilter
 
accept(File) - Method in class org.apache.commons.io.filefilter.AbstractFileFilter
Checks to see if the File should be accepted by this filter.
accept(File, String) - Method in class org.apache.commons.io.filefilter.AbstractFileFilter
Checks to see if the File should be accepted by this filter.
accept(File) - Method in class org.apache.commons.io.filefilter.AgeFileFilter
Checks to see if the last modification of the file matches cutoff favorably.
accept(File) - Method in class org.apache.commons.io.filefilter.AndFileFilter
Checks to see if the File should be accepted by this filter.
accept(File, String) - Method in class org.apache.commons.io.filefilter.AndFileFilter
Checks to see if the File should be accepted by this filter.
accept(File) - Method in class org.apache.commons.io.filefilter.CanExecuteFileFilter
Checks to see if the file can be executed.
accept(File) - Method in class org.apache.commons.io.filefilter.CanReadFileFilter
Checks to see if the file can be read.
accept(File) - Method in class org.apache.commons.io.filefilter.CanWriteFileFilter
Checks to see if the file can be written to.
accept(File) - Method in class org.apache.commons.io.filefilter.DelegateFileFilter
Checks the filter.
accept(File, String) - Method in class org.apache.commons.io.filefilter.DelegateFileFilter
Checks the filter.
accept(File) - Method in class org.apache.commons.io.filefilter.DirectoryFileFilter
Checks to see if the file is a directory.
accept(File) - Method in class org.apache.commons.io.filefilter.EmptyFileFilter
Checks to see if the file is empty.
accept(File) - Method in class org.apache.commons.io.filefilter.FalseFileFilter
Returns false.
accept(File, String) - Method in class org.apache.commons.io.filefilter.FalseFileFilter
Returns false.
accept(File) - Method in class org.apache.commons.io.filefilter.FileFileFilter
Checks to see if the file is a file.
accept(File) - Method in class org.apache.commons.io.filefilter.HiddenFileFilter
Checks to see if the file is hidden.
accept(File) - Method in interface org.apache.commons.io.filefilter.IOFileFilter
Checks to see if the File should be accepted by this filter.
accept(File, String) - Method in interface org.apache.commons.io.filefilter.IOFileFilter
Checks to see if the File should be accepted by this filter.
accept(File) - Method in class org.apache.commons.io.filefilter.MagicNumberFileFilter
Accepts the provided file if the file contains the file filter's magic number at the specified offset.
accept(File) - Method in class org.apache.commons.io.filefilter.NameFileFilter
Checks to see if the file name matches.
accept(File, String) - Method in class org.apache.commons.io.filefilter.NameFileFilter
Checks to see if the file name matches.
accept(File) - Method in class org.apache.commons.io.filefilter.NotFileFilter
Returns the logical NOT of the underlying filter's return value for the same File.
accept(File, String) - Method in class org.apache.commons.io.filefilter.NotFileFilter
Returns the logical NOT of the underlying filter's return value for the same arguments.
accept(File) - Method in class org.apache.commons.io.filefilter.OrFileFilter
Checks to see if the File should be accepted by this filter.
accept(File, String) - Method in class org.apache.commons.io.filefilter.OrFileFilter
Checks to see if the File should be accepted by this filter.
accept(File) - Method in class org.apache.commons.io.filefilter.PrefixFileFilter
Checks to see if the file name starts with the prefix.
accept(File, String) - Method in class org.apache.commons.io.filefilter.PrefixFileFilter
Checks to see if the file name starts with the prefix.
accept(File, String) - Method in class org.apache.commons.io.filefilter.RegexFileFilter
Checks to see if the file name matches one of the regular expressions.
accept(File) - Method in class org.apache.commons.io.filefilter.SizeFileFilter
Checks to see if the size of the file is favorable.
accept(File) - Method in class org.apache.commons.io.filefilter.SuffixFileFilter
Checks to see if the file name ends with the suffix.
accept(File, String) - Method in class org.apache.commons.io.filefilter.SuffixFileFilter
Checks to see if the file name ends with the suffix.
accept(File) - Method in class org.apache.commons.io.filefilter.TrueFileFilter
Returns true.
accept(File, String) - Method in class org.apache.commons.io.filefilter.TrueFileFilter
Returns true.
accept(File, String) - Method in class org.apache.commons.io.filefilter.WildcardFileFilter
Checks to see if the file name matches one of the wildcards.
accept(File) - Method in class org.apache.commons.io.filefilter.WildcardFileFilter
Checks to see if the file name matches one of the wildcards.
accept(File, String) - Method in class org.apache.commons.io.filefilter.WildcardFilter
Deprecated.
Checks to see if the file name matches one of the wildcards.
accept(File) - Method in class org.apache.commons.io.filefilter.WildcardFilter
Deprecated.
Checks to see if the file name matches one of the wildcards.
accept(T) - Method in interface org.apache.commons.io.function.IOConsumer
Performs this operation on the given argument.
accept(Class<?>...) - Method in class org.apache.commons.io.serialization.ValidatingObjectInputStream
Accept the specified classes for deserialization, unless they are otherwise rejected.
accept(String...) - Method in class org.apache.commons.io.serialization.ValidatingObjectInputStream
Accept the wildcard specified classes for deserialization, unless they are otherwise rejected.
accept(Pattern) - Method in class org.apache.commons.io.serialization.ValidatingObjectInputStream
Accept class names that match the supplied pattern for deserialization, unless they are otherwise rejected.
accept(ClassNameMatcher) - Method in class org.apache.commons.io.serialization.ValidatingObjectInputStream
Accept class names where the supplied ClassNameMatcher matches for deserialization, unless they are otherwise rejected.
acceptCatchingErrors(Node, Object) - Method in class org.lsmp.djep.xjep.ErrorCatchingVisitor
calls jjtAccept inside a try catch block, adding the error if necessary
accepts(double) - Method in class org.jfree.data.statistics.SimpleHistogramBin
Returns true if the specified value belongs in the bin, and false otherwise.
accumulator - Variable in class jplot3d.JSurface
 
AccumulatorPathVisitor - Class in org.apache.commons.io.file
Accumulates normalized paths during visitation.
AccumulatorPathVisitor(Counters.PathCounters) - Constructor for class org.apache.commons.io.file.AccumulatorPathVisitor
Constructs a new instance.
acos - Static variable in class cern.jet.math.Functions
Function that returns Math.acos(a).
acos(ValueErr) - Method in class jhplot.math.ValueErr
Inverse cosine of a value with error
acos(double) - Static method in class net.jafama.FastMath
 
acos(double) - Static method in class net.jafama.StrictFastMath
 
acos() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Arc cosine operation.
acos(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute arc cosine of a derivative structure.
acos() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Arc cosine operation.
Acos - Class in org.apache.commons.math3.analysis.function
Arc-cosine function.
Acos() - Constructor for class org.apache.commons.math3.analysis.function.Acos
 
acos() - Method in class org.apache.commons.math3.complex.Complex
Compute the inverse cosine of this complex number.
acos() - Method in class org.apache.commons.math3.dfp.Dfp
Arc cosine operation.
acos(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the arc-cosine of the argument.
acos() - Method in interface org.apache.commons.math3.RealFieldElement
Arc cosine operation.
acos() - Method in class org.apache.commons.math3.util.Decimal64
Arc cosine operation.
acos(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the arc cosine of a number.
acos(double) - Static method in class org.jlab.groot.math.FunctionFactory
Fast acos using 8 term polynomial approximation from Abramowitz and Stegun, pg.
acos(Object) - Method in class org.nfunk.jep.function.ArcCosine
 
acos() - Method in class org.nfunk.jep.type.Complex
 
acosh(double) - Static method in class graph.SpecialFunction
 
acosh(double) - Static method in class jhplot.math.num.special.Trigonometric
acosh(double) - Static method in class net.jafama.FastMath
Some properties of acosh(x) = log(x + sqrt(x^2 - 1)): 1) defined on [1,+Infinity[ 2) result in ]0,+Infinity[ (by convention, since cosh(x) = cosh(-x)) 3) acosh(1) = 0 4) acosh(1+epsilon) ~= log(1 + sqrt(2*epsilon)) ~= sqrt(2*epsilon) 5) lim(acosh(x),x->+Infinity) = +Infinity (y increasing logarithmically slower than x)
acosh(double) - Static method in class net.jafama.StrictFastMath
Some properties of acosh(x) = log(x + sqrt(x^2 - 1)): 1) defined on [1,+Infinity[ 2) result in ]0,+Infinity[ (by convention, since cosh(x) = cosh(-x)) 3) acosh(1) = 0 4) acosh(1+epsilon) ~= log(1 + sqrt(2*epsilon)) ~= sqrt(2*epsilon) 5) lim(acosh(x),x->+Infinity) = +Infinity (y increasing logarithmically slower than x)
acosh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Inverse hyperbolic cosine operation.
acosh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute inverse hyperbolic cosine of a derivative structure.
acosh() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Inverse hyperbolic cosine operation.
Acosh - Class in org.apache.commons.math3.analysis.function
Hyperbolic arc-cosine function.
Acosh() - Constructor for class org.apache.commons.math3.analysis.function.Acosh
 
acosh() - Method in class org.apache.commons.math3.dfp.Dfp
Inverse hyperbolic cosine operation.
acosh() - Method in interface org.apache.commons.math3.RealFieldElement
Inverse hyperbolic cosine operation.
acosh() - Method in class org.apache.commons.math3.util.Decimal64
Inverse hyperbolic cosine operation.
acosh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the inverse hyperbolic cosine of a number.
acosh(Object) - Method in class org.nfunk.jep.function.ArcCosineH
 
acosh() - Method in class org.nfunk.jep.type.Complex
 
acosh1p(double) - Static method in class net.jafama.FastMath
Much more accurate than acosh(1+value), for arguments (and results) close to zero.
acosh1p(double) - Static method in class net.jafama.StrictFastMath
Much more accurate than acosh(1+value), for arguments (and results) close to zero.
acosInRange(double) - Static method in class net.jafama.FastMath
If value is not NaN and is outside [-1,1] range, closest value in this range is used.
acosInRange(double) - Static method in class net.jafama.StrictFastMath
If value is not NaN and is outside [-1,1] range, closest value in this range is used.
action(Event, Object) - Method in class graph.G2Dint
Handle the Action Events.
Action - Enum in org.apache.commons.math3.ode.events
Enumerate for actions to be performed when an event occurs during ODE integration.
actionPerformed(ActionEvent) - Method in class jhplot.stat.limit.LimitCalculatorGui
 
actionPerformed(ActionEvent) - Method in class jhplot.stat.limit.LimitCalculatorGui.myFrame
 
actionPerformed() - Method in class jplot.Utils.LabeledComboBox
 
actionPerformed() - Method in class jplot.Utils.LabeledTextField
 
actionPerformed(ActionEvent) - Method in class org.jfree.chart.ChartPanel
Handles action events generated by the popup menu.
actionPerformed(ActionEvent) - Method in class org.jfree.chart.editor.DefaultLogAxisEditor
Handles actions from within the property panel.
actionPerformed(ActionEvent) - Method in class org.jfree.chart.editor.DefaultPolarPlotEditor
Handles actions from within the property panel.
actionPerformed(ActionEvent) - Method in class org.jfree.chart.PolarChartPanel
Handles action events generated by the popup menu.
actionPerformed(ActionEvent) - Method in class org.jlab.groot.base.AxisAttributes.AxisAttributesPane
 
actionPerformed(ActionEvent) - Method in class org.jlab.groot.base.DatasetAttributes.DatasetAttributesPane
 
actionPerformed(ActionEvent) - Method in class org.jlab.groot.base.PadAttributes.PadAttributesPane
 
actionPerformed(ActionEvent) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
actionPerformed(ActionEvent) - Method in class org.jlab.groot.graphics.EmbeddedCanvasGroup
 
actionPerformed(ActionEvent) - Method in class org.jlab.groot.graphics.EmbeddedCanvasTabbed
 
actionPerformed(ActionEvent) - Method in class org.jlab.groot.matrix.GridStudio
 
actionPerformed(ActionEvent) - Method in class org.jlab.groot.studio.StudioDesktop
 
actionPerformed(ActionEvent) - Method in class org.jlab.groot.studio.StudioUI
 
actionPerformed(ActionEvent) - Method in class org.lsmp.djepExamples.DJepApplet
Called when the Calculate button is pressed.
actionPerformed(ActionEvent) - Method in class org.nfunk.jepexamples.Fractal
 
actionTreeNode(TreePath[], int) - Method in interface org.jlab.groot.tree.TreeProvider
 
actionTreeNode(TreePath[], int) - Method in class org.jlab.groot.tree.TreeTextFile
 
AdamsBashforthFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements explicit Adams-Bashforth integrators for Ordinary Differential Equations.
AdamsBashforthFieldIntegrator(Field<T>, int, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsBashforthFieldIntegrator
Build an Adams-Bashforth integrator with the given order and step control parameters.
AdamsBashforthFieldIntegrator(Field<T>, int, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsBashforthFieldIntegrator
Build an Adams-Bashforth integrator with the given order and step control parameters.
AdamsBashforthIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements explicit Adams-Bashforth integrators for Ordinary Differential Equations.
AdamsBashforthIntegrator(int, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsBashforthIntegrator
Build an Adams-Bashforth integrator with the given order and step control parameters.
AdamsBashforthIntegrator(int, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsBashforthIntegrator
Build an Adams-Bashforth integrator with the given order and step control parameters.
AdamsFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
Base class for Adams-Bashforth and Adams-Moulton integrators.
AdamsFieldIntegrator(Field<T>, String, int, int, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsFieldIntegrator
Build an Adams integrator with the given order and step control parameters.
AdamsFieldIntegrator(Field<T>, String, int, int, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsFieldIntegrator
Build an Adams integrator with the given order and step control parameters.
AdamsIntegrator - Class in org.apache.commons.math3.ode.nonstiff
Base class for Adams-Bashforth and Adams-Moulton integrators.
AdamsIntegrator(String, int, int, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
Build an Adams integrator with the given order and step control parameters.
AdamsIntegrator(String, int, int, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
Build an Adams integrator with the given order and step control parameters.
AdamsMoultonFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements implicit Adams-Moulton integrators for Ordinary Differential Equations.
AdamsMoultonFieldIntegrator(Field<T>, int, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsMoultonFieldIntegrator
Build an Adams-Moulton integrator with the given order and error control parameters.
AdamsMoultonFieldIntegrator(Field<T>, int, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsMoultonFieldIntegrator
Build an Adams-Moulton integrator with the given order and error control parameters.
AdamsMoultonIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements implicit Adams-Moulton integrators for Ordinary Differential Equations.
AdamsMoultonIntegrator(int, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsMoultonIntegrator
Build an Adams-Moulton integrator with the given order and error control parameters.
AdamsMoultonIntegrator(int, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsMoultonIntegrator
Build an Adams-Moulton integrator with the given order and error control parameters.
AdamsNordsieckFieldTransformer<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
Transformer to Nordsieck vectors for Adams integrators.
AdamsNordsieckTransformer - Class in org.apache.commons.math3.ode.nonstiff
Transformer to Nordsieck vectors for Adams integrators.
adaptive(F1D, double, double) - Static method in class jhplot.math.Numeric
In adaptive quadrature we estimate the area under a curve in the interval from a to b twice, one using Q1 and once using Q2.
AdaptiveIntegrator - Class in jhplot.math.num.integration
An implementation of adaptive quadrature.
AdaptiveIntegrator(Function) - Constructor for class jhplot.math.num.integration.AdaptiveIntegrator
Create an integrator for the given function.
AdaptiveIntegrator(Function, int, double) - Constructor for class jhplot.math.num.integration.AdaptiveIntegrator
Create an integrator for the given function.
AdaptiveStepsizeFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This abstract class holds the common part of all adaptive stepsize integrators for Ordinary Differential Equations.
AdaptiveStepsizeFieldIntegrator(Field<T>, String, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
Build an integrator with the given stepsize bounds.
AdaptiveStepsizeFieldIntegrator(Field<T>, String, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
Build an integrator with the given stepsize bounds.
AdaptiveStepsizeIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This abstract class holds the common part of all adaptive stepsize integrators for Ordinary Differential Equations.
AdaptiveStepsizeIntegrator(String, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Build an integrator with the given stepsize bounds.
AdaptiveStepsizeIntegrator(String, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Build an integrator with the given stepsize bounds.
add(double) - Method in class cern.colt.buffer.DoubleBuffer
Adds the specified element to the receiver.
add(double, double) - Method in class cern.colt.buffer.DoubleBuffer2D
Adds the specified point (x,y) to the receiver.
add(double, double, double) - Method in class cern.colt.buffer.DoubleBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(int) - Method in class cern.colt.buffer.IntBuffer
Adds the specified element to the receiver.
add(int, int) - Method in class cern.colt.buffer.IntBuffer2D
Adds the specified point (x,y) to the receiver.
add(int, int, int) - Method in class cern.colt.buffer.IntBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(Object) - Method in class cern.colt.buffer.ObjectBuffer
Adds the specified element to the receiver.
add(boolean) - Method in class cern.colt.list.AbstractBooleanList
Appends the specified element to the end of this list.
add(byte) - Method in class cern.colt.list.AbstractByteList
Appends the specified element to the end of this list.
add(char) - Method in class cern.colt.list.AbstractCharList
Appends the specified element to the end of this list.
add(double) - Method in class cern.colt.list.AbstractDoubleList
Appends the specified element to the end of this list.
add(float) - Method in class cern.colt.list.AbstractFloatList
Appends the specified element to the end of this list.
add(int) - Method in class cern.colt.list.AbstractIntList
Appends the specified element to the end of this list.
add(long) - Method in class cern.colt.list.AbstractLongList
Appends the specified element to the end of this list.
add(short) - Method in class cern.colt.list.AbstractShortList
Appends the specified element to the end of this list.
add(int, Object) - Method in class cern.colt.list.adapter.DoubleListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(int, Object) - Method in class cern.colt.list.adapter.FloatListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(int, Object) - Method in class cern.colt.list.adapter.IntListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(int, Object) - Method in class cern.colt.list.adapter.LongListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(int, Object) - Method in class cern.colt.list.adapter.ObjectListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(boolean) - Method in class cern.colt.list.BooleanArrayList
Appends the specified element to the end of this list.
add(byte) - Method in class cern.colt.list.ByteArrayList
Appends the specified element to the end of this list.
add(char) - Method in class cern.colt.list.CharArrayList
Appends the specified element to the end of this list.
add(long) - Method in class cern.colt.list.DistinctNumberList
Appends the specified element to the end of this list.
add(double) - Method in class cern.colt.list.DoubleArrayList
Appends the specified element to the end of this list.
add(float) - Method in class cern.colt.list.FloatArrayList
Appends the specified element to the end of this list.
add(int) - Method in class cern.colt.list.IntArrayList
Appends the specified element to the end of this list.
add(long) - Method in class cern.colt.list.LongArrayList
Appends the specified element to the end of this list.
add(long) - Method in class cern.colt.list.MinMaxNumberList
Appends the specified element to the end of this list.
add(Object) - Method in class cern.colt.list.ObjectArrayList
Appends the specified element to the end of this list.
add(short) - Method in class cern.colt.list.ShortArrayList
Appends the specified element to the end of this list.
add(double) - Method in class cern.hep.aida.bin.AbstractBin1D
Adds the specified element to the receiver.
add(double) - Method in class cern.hep.aida.bin.DynamicBin1D
Adds the specified element to the receiver.
add(double) - Method in class cern.hep.aida.bin.StaticBin1D
Adds the specified element to the receiver.
add(double) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Adds a value to the receiver.
add(LCObject) - Method in class hep.lcio.implementation.event.ILCCollection
 
add(float) - Method in class hep.lcio.implementation.event.ILCFloatVec
 
add(int) - Method in class hep.lcio.implementation.event.ILCIntVec
 
add(String) - Method in class hep.lcio.implementation.event.ILCStrVec
 
add(Matrix, Matrix) - Static method in class hep.physics.matrix.MatrixOp
Add two matrices together.
add(Hep3Vector, Hep3Vector) - Static method in class hep.physics.vec.VecOp
 
add(HepLorentzVector, HepLorentzVector) - Static method in class hep.physics.vec.VecOp
 
add(ParticleD) - Method in class hephysics.jet.ParticleD
Add to this particle another particle.
add(ParticleD, int) - Method in class hephysics.jet.ParticleD
Add to this particle another particle.
add(ParticleF) - Method in class hephysics.jet.ParticleF
Add to this particle and recalculate all characteristics.
add(HEParticle) - Method in class hephysics.particle.HEParticle
Add 2 particles
add(LParticle) - Method in class hephysics.particle.LParticle
Add 2 particle
add(Hep3Vector, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Add 2 vectors and return a new object
add(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Add a vector
add(HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Add 2 Lorentz vectors
add(HepLorentzVector, HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Add 2 vectors
add(Hep3Vector, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
add(LorentzVector, LorentzVector) - Static method in class j4np.physics.LorentzVector
 
add(LorentzVector) - Method in class j4np.physics.LorentzVector
 
add(double, double, double, double) - Method in class j4np.physics.LorentzVector
 
add(Vector3) - Method in class j4np.physics.Vector3
 
add(double, double, double) - Method in class j4np.physics.Vector3
 
add(F1D) - Method in class jhplot.HChart
Add a F1D function to the canvas.
add(H1D) - Method in class jhplot.HChart
Add a H1D histogram to the chart.
add(P1D) - Method in class jhplot.HChart
Draw data from a P1D.
add(HLabel) - Method in class jhplot.HPlot
Add a label to the Canvas.
add(HKey) - Method in class jhplot.HPlot
Add a key to the Canvas.
add(HMLabel) - Method in class jhplot.HPlot
Add a multiline label to the Canvas.
add(HLabelEq) - Method in class jhplot.HPlot
Add a LaTeX equation to the canvas.
add(HShape) - Method in class jhplot.HPlot
Add a shape primitive to the Canvas.
add(ArrayList) - Method in class jhplot.HPlotJas
Add all data as a list.
add(int, H1D) - Method in class jhplot.io.CFBook
add H1D histogram to CFBook
add(int, H2D) - Method in class jhplot.io.CFBook
add H2D histogram to CFBook
add(int, P1D) - Method in class jhplot.io.CFBook
add P1D histogram to CFBook
add(double[], double, double[], int) - Static method in class jhplot.math.ArrayMathUtils
Adds to an array w, a times v where a is a scalar.
add(double[], double) - Static method in class jhplot.math.ArrayMathUtils
Adds a scalar to every element in the array.
add(double[], double[]) - Static method in class jhplot.math.ArrayMathUtils
Adds the two arrays together (componentwise).
add(int[], double, int[], int) - Static method in class jhplot.math.ArrayMathUtils
Adds to an array w, a times v where a is a scalar.
add(int[], int) - Static method in class jhplot.math.ArrayMathUtils
Adds a scalar to every element in the array.
add(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Adds the two arrays together (componentwise).
add(double[][], double) - Static method in class jhplot.math.DoubleArray
Adds a single value to a matrix, e.g.
add(double[][], double[][]) - Static method in class jhplot.math.DoubleArray
Adds a matrix to another matrix, which should be of the same dimension.
add(double) - Method in class jhplot.math.num.DoubleArray
Adds an element to the end of this expandable array.
add(double, double) - Method in class jhplot.P1D
Adds values of a plot-point pair (X,Y).
add(double, double, double) - Method in class jhplot.P1D
Adds the values of a plot-point pair (X,Y).
add(double, double, double, double) - Method in class jhplot.P1D
Add values of a plot-point pair (X,Y).
add(double, double, double, double, double, double) - Method in class jhplot.P1D
Adds the values of a plot-point pair (X,Y).
add(double, double, double, double, double, double, double, double, double, double) - Method in class jhplot.P1D
Adds the values of a plot-point pair (x,y).
add(double, double, double) - Method in class jhplot.P2D
Adds values of a plot-point pair (X,Y,Z).
add(double, double, double, double, double, double) - Method in class jhplot.P3D
Adds values of a plot-point pair (X,dX,Y,dY,Z,dZ).
add(double[]) - Method in class jhplot.PND
Adds (appends) the specified element to the end of this list.
add(P0D) - Method in class jhplot.PND
Adds (appends) P0D to the end of this list.
add(int[]) - Method in class jhplot.PNI
Adds (appends) the specified element to the end of this list.
add(P0I) - Method in class jhplot.PNI
Adds (appends) P0D to the end of this list.
add(DataPoint) - Method in class jminhep.cluster.DataHolder
Add a data point to the holder
add(double[]) - Method in class jminhep.cluster.DataHolder
Add a new instance to data holder in form of array
add(String, String) - Method in class jplot.XMLWrite
Set an attribute of a setting.
add(long) - Method in interface org.apache.commons.io.file.Counters.Counter
Adds the given number to this counter.
add(byte) - Method in class org.apache.commons.io.input.buffer.CircularByteBuffer
Adds a new byte to the buffer, which will eventually be returned by following invocations of CircularByteBuffer.read().
add(byte[], int, int) - Method in class org.apache.commons.io.input.buffer.CircularByteBuffer
Adds the given bytes to the buffer.
add(ObservableInputStream.Observer) - Method in class org.apache.commons.io.input.ObservableInputStream
Adds an Observer.
add(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'+' operator.
add(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute this + a.
add(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Perform addition of two derivative structures.
add(SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute this + a.
add(double) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
'+' operator.
Add - Class in org.apache.commons.math3.analysis.function
Add the two operands.
Add() - Constructor for class org.apache.commons.math3.analysis.function.Add
 
add(UnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Adds functions.
add(UnivariateDifferentiableFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Adds functions.
add(DifferentiableUnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
add(PolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Add a polynomial to the instance.
add(Complex) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this + addend).
add(double) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this + addend), with addend interpreted as a real number.
add(Quaternion, Quaternion) - Static method in class org.apache.commons.math3.complex.Quaternion
Computes the sum of two quaternions.
add(Quaternion) - Method in class org.apache.commons.math3.complex.Quaternion
Computes the sum of the instance and another quaternion.
add(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Add x to this.
add(double) - Method in class org.apache.commons.math3.dfp.Dfp
'+' operator.
add(T) - Method in interface org.apache.commons.math3.FieldElement
Compute this + a.
add(double, double) - Method in class org.apache.commons.math3.fitting.WeightedObservedPoints
Adds a point to the sample.
add(double, double, double) - Method in class org.apache.commons.math3.fitting.WeightedObservedPoints
Adds a point to the sample.
add(WeightedObservedPoint) - Method in class org.apache.commons.math3.fitting.WeightedObservedPoints
Adds a point to the sample.
add(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
Adds the value of this fraction to the passed BigInteger, returning the result in reduced form.
add(int) - Method in class org.apache.commons.math3.fraction.BigFraction
Adds the value of this fraction to the passed integer, returning the result in reduced form.
add(long) - Method in class org.apache.commons.math3.fraction.BigFraction
Adds the value of this fraction to the passed long, returning the result in reduced form.
add(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
Adds the value of this fraction to another, returning the result in reduced form.
add(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
Adds the value of this fraction to another, returning the result in reduced form.
add(int) - Method in class org.apache.commons.math3.fraction.Fraction
Add an integer to the fraction.
add(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Add a vector to the instance.
add(double, Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Add a scaled vector to the instance.
add(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a vector to the instance.
add(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a vector to the instance.
add(T, FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a scaled vector to the instance.
add(T, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a scaled vector to the instance.
add(double, FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a scaled vector to the instance.
add(double, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a scaled vector to the instance.
add(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Add a vector to the instance.
add(double, Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Add a scaled vector to the instance.
add(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Add a vector to the instance.
add(double, Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Add a scaled vector to the instance.
add(BSPTree<S>) - Method in class org.apache.commons.math3.geometry.partitioning.NodesSet
Add a node if not already known.
add(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Add a vector to the instance.
add(double, Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Add a scaled vector to the instance.
add(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Compute the sum of this and m.
add(RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the sum of this and m.
add(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Add m to this matrix.
add(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Compute the sum of this and m.
add(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the sum of this and v.
add(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the sum of this and v.
add(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Compute the sum of this vector and v.
add(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Compute the sum of this and m.
add(BlockFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Compute the sum of this and m.
add(RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the sum of this and m.
add(BlockRealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Compute the sum of this matrix and m.
add(DiagonalMatrix) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Compute the sum of this and m.
add(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Compute the sum of this and m.
add(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Compute the sum of this and v.
add(OpenMapRealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Compute the sum of this matrix and m.
add(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Compute the sum of this vector and v.
add(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Optimized method to add two OpenMapRealVectors.
add(RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the sum of this and m.
add(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Compute the sum of this vector and v.
add(SparseFieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Optimized method to add sparse vectors.
add(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Compute the sum of this and v.
add(double) - Method in interface org.apache.commons.math3.RealFieldElement
'+' operator.
add(BigReal) - Method in class org.apache.commons.math3.util.BigReal
Compute this + a.
add(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute this + a.
add(double) - Method in class org.apache.commons.math3.util.Decimal64
'+' operator.
add(String, double, double) - Method in class org.freehep.math.minuit.MnApplication
add free parameter
add(String, double, double, double, double) - Method in class org.freehep.math.minuit.MnApplication
add limited parameter
add(String, double) - Method in class org.freehep.math.minuit.MnApplication
add const parameter
add(String, double, double) - Method in class org.freehep.math.minuit.MnUserParameters
Add free parameter name, value, error
add(String, double, double, double, double) - Method in class org.freehep.math.minuit.MnUserParameters
Add limited parameter name, value, lower bound, upper bound
add(String, double) - Method in class org.freehep.math.minuit.MnUserParameters
Add const parameter name, value
add(String, double, double) - Method in class org.freehep.math.minuit.MnUserParameterState
add free parameter name, value, error
add(String, double, double, double, double) - Method in class org.freehep.math.minuit.MnUserParameterState
add limited parameter name, value, lower bound, upper bound
add(String, double) - Method in class org.freehep.math.minuit.MnUserParameterState
add const parameter name, value
add(Axis, RectangleEdge) - Method in class org.jfree.chart.axis.AxisCollection
Adds an axis to the collection.
add(double, RectangleEdge) - Method in class org.jfree.chart.axis.AxisSpace
Adds space to the top, bottom, left or right edge of the plot area.
add(TickUnit) - Method in class org.jfree.chart.axis.TickUnits
Adds a tick unit to the collection.
add(Block, Object) - Method in interface org.jfree.chart.block.Arrangement
Adds a block and a key which can be used to determine the position of the block in the arrangement.
add(Block) - Method in class org.jfree.chart.block.BlockContainer
Adds a block to the container.
add(Block, Object) - Method in class org.jfree.chart.block.BlockContainer
Adds a block to the container.
add(Block, Object) - Method in class org.jfree.chart.block.BorderArrangement
Adds a block to the arrangement manager at the specified edge.
add(Block, Object) - Method in class org.jfree.chart.block.CenterArrangement
Adds a block to be managed by this instance.
add(Block, Object) - Method in class org.jfree.chart.block.ColumnArrangement
Adds a block to be managed by this instance.
add(Block, Object) - Method in class org.jfree.chart.block.FlowArrangement
Adds a block to be managed by this instance.
add(Block, Object) - Method in class org.jfree.chart.block.GridArrangement
Adds a block and a key which can be used to determine the position of the block in the arrangement.
add(ChartEntity) - Method in interface org.jfree.chart.entity.EntityCollection
Adds an entity to the collection.
add(ChartEntity) - Method in class org.jfree.chart.entity.StandardEntityCollection
Adds an entity to the collection.
add(LegendItem) - Method in class org.jfree.chart.LegendItemCollection
Adds a legend item to the collection.
add(CategoryPlot) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Adds a subplot to the combined chart and sends a PlotChangeEvent to all registered listeners.
add(CategoryPlot, int) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Adds a subplot to the combined chart and sends a PlotChangeEvent to all registered listeners.
add(XYPlot) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Adds a subplot (with a default 'weight' of 1) and sends a PlotChangeEvent to all registered listeners.
add(XYPlot, int) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Adds a subplot with the specified weight and sends a PlotChangeEvent to all registered listeners.
add(CategoryPlot) - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Adds a subplot (with a default 'weight' of 1) and sends a PlotChangeEvent to all registered listeners.
add(CategoryPlot, int) - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Adds a subplot and sends a PlotChangeEvent to all registered listeners.
add(XYPlot) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Adds a subplot, with a default 'weight' of 1.
add(XYPlot, int) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Adds a subplot with a particular weight (greater than or equal to one).
add(Number, Paint) - Method in class org.jfree.chart.renderer.LookupPaintScale
add(double, Paint) - Method in class org.jfree.chart.renderer.LookupPaintScale
Adds an entry to the lookup table.
add(Outlier) - Method in class org.jfree.chart.renderer.OutlierList
Adds an outlier to the list.
add(Outlier) - Method in class org.jfree.chart.renderer.OutlierListCollection
Appends the specified element as a new OutlierList to the end of this list if it does not overlap an outlier in an existing list.
add(Task) - Method in class org.jfree.data.gantt.TaskSeries
Adds a task to the series and sends a SeriesChangeEvent to all registered listeners.
add(TaskSeries) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Adds a series to the dataset and sends a DatasetChangeEvent to all registered listeners.
add(SeriesDataset) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Adds one SeriesDataset to the combination.
add(SeriesDataset[]) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Adds an array of SeriesDataset's to the combination.
add(SeriesDataset, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Adds one series from a SeriesDataset to the combination.
add(List, Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Adds a list of values relating to one box-and-whisker entity to the table.
add(BoxAndWhiskerItem, Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Adds a list of values relating to one Box and Whisker entity to the table.
add(Date, BoxAndWhiskerItem) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Adds an item to the dataset and sends a DatasetChangeEvent to all registered listeners.
add(List, Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Adds a list of values to the dataset (null and Double.NaN items are automatically removed) and sends a DatasetChangeEvent to all registered listeners.
add(double, double, Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Adds a mean and standard deviation to the table.
add(Number, Number, Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Adds a mean and standard deviation to the table.
add(RegularTimePeriod, double, double, double, double) - Method in class org.jfree.data.time.ohlc.OHLCSeries
Adds a data item to the series.
add(OHLCItem) - Method in class org.jfree.data.time.ohlc.OHLCSeries
Adds a data item to the series.
add(TimePeriodValue) - Method in class org.jfree.data.time.TimePeriodValues
Adds a data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(TimePeriod, double) - Method in class org.jfree.data.time.TimePeriodValues
Adds a new data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(TimePeriod, Number) - Method in class org.jfree.data.time.TimePeriodValues
Adds a new data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(TimeSeriesDataItem) - Method in class org.jfree.data.time.TimeSeries
Adds a data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(TimeSeriesDataItem, boolean) - Method in class org.jfree.data.time.TimeSeries
Adds a data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(RegularTimePeriod, double) - Method in class org.jfree.data.time.TimeSeries
Adds a new data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(RegularTimePeriod, double, boolean) - Method in class org.jfree.data.time.TimeSeries
Adds a new data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(RegularTimePeriod, Number) - Method in class org.jfree.data.time.TimeSeries
Adds a new data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(RegularTimePeriod, Number, boolean) - Method in class org.jfree.data.time.TimeSeries
Adds a new data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(TimePeriod, double, Comparable) - Method in class org.jfree.data.time.TimeTableXYDataset
Adds a new data item to the dataset and sends a DatasetChangeEvent to all registered listeners.
add(TimePeriod, Number, Comparable, boolean) - Method in class org.jfree.data.time.TimeTableXYDataset
Adds a new data item to the dataset and, if requested, sends a DatasetChangeEvent to all registered listeners.
add(double, double, String) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Adds a data item to this dataset and sends a DatasetChangeEvent to all registered listeners.
add(Number, Number, String, boolean) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Adds a data item to this dataset and, if requested, sends a DatasetChangeEvent to all registered listeners.
add(double, double, double, double) - Method in class org.jfree.data.xy.VectorSeries
Adds a data item to the series.
add(VectorDataItem, boolean) - Method in class org.jfree.data.xy.VectorSeries
Adds a data item to the series and, if requested, sends a SeriesChangeEvent to all registered listeners.
add(double, double, double, double) - Method in class org.jfree.data.xy.XIntervalSeries
Adds a data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(XIntervalDataItem, boolean) - Method in class org.jfree.data.xy.XIntervalSeries
Adds a data item to the series and, if requested, sends a SeriesChangeEvent to all registered listeners.
add(double, double, double, double, double, double) - Method in class org.jfree.data.xy.XYIntervalSeries
Adds a data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(XYIntervalDataItem, boolean) - Method in class org.jfree.data.xy.XYIntervalSeries
Adds a data item to the series and, if requested, sends a SeriesChangeEvent to all registered listeners.
add(XYDataItem) - Method in class org.jfree.data.xy.XYSeries
Adds a data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(double, double) - Method in class org.jfree.data.xy.XYSeries
Adds a data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(double, double, boolean) - Method in class org.jfree.data.xy.XYSeries
Adds a data item to the series and, if requested, sends a SeriesChangeEvent to all registered listeners.
add(double, Number) - Method in class org.jfree.data.xy.XYSeries
Adds a data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(double, Number, boolean) - Method in class org.jfree.data.xy.XYSeries
Adds a data item to the series and, if requested, sends a SeriesChangeEvent to all registered listeners.
add(Number, Number) - Method in class org.jfree.data.xy.XYSeries
Adds a new data item to the series (in the correct position if the autoSort flag is set for the series) and sends a SeriesChangeEvent to all registered listeners.
add(Number, Number, boolean) - Method in class org.jfree.data.xy.XYSeries
Adds new data to the series and, if requested, sends a SeriesChangeEvent to all registered listeners.
add(XYDataItem, boolean) - Method in class org.jfree.data.xy.XYSeries
Adds a data item to the series and, if requested, sends a SeriesChangeEvent to all registered listeners.
add(double, double, double, double) - Method in class org.jfree.data.xy.YIntervalSeries
Adds a data item to the series and sends a SeriesChangeEvent to all registered listeners.
add(YIntervalDataItem, boolean) - Method in class org.jfree.data.xy.YIntervalSeries
Adds a data item to the series and, if requested, sends a SeriesChangeEvent to all registered listeners.
add(AttributeType, int) - Method in class org.jlab.groot.base.Attributes
 
add(double) - Method in class org.jlab.groot.data.DataVector
Add value to the vector and ensure that the vector is ordered.
add(String, T) - Method in class org.jlab.groot.data.Directory
Add an object to current directory.
add(H1F) - Method in class org.jlab.groot.data.H1F
 
add(H1F, H1F) - Static method in class org.jlab.groot.data.H1F
Adds two histograms.
add(H2F) - Method in class org.jlab.groot.data.H2F
 
add(int, String) - Method in class org.jlab.groot.group.DataGroupDescriptor
 
add(StatNumber) - Method in class org.jlab.groot.math.StatNumber
Adds two StatNumber objects.
add(Object, Object) - Method in class org.lsmp.djep.groupJep.function.GAdd
 
add(Number, Number) - Method in interface org.lsmp.djep.groupJep.GroupI
Get sum of the numbers
add(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.BigReals
 
add(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
add(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Integers
 
add(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.PermutationGroup
 
add(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Quaternions
 
add(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
add(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Reals
 
add(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Zn
 
add(Permutation) - Method in class org.lsmp.djep.groupJep.values.Permutation
 
add(Polynomial) - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
add(Rational) - Method in class org.lsmp.djep.groupJep.values.Rational
 
ADD - Static variable in class org.lsmp.djep.rpe.RpEval
 
add(PNodeI) - Method in class org.lsmp.djep.sjep.AbstractPNode
 
add(PNodeI) - Method in class org.lsmp.djep.sjep.Monomial
 
add(PNodeI) - Method in class org.lsmp.djep.sjep.MutiablePolynomial
 
add(PNodeI) - Method in class org.lsmp.djep.sjep.PConstant
 
add(PNodeI) - Method in interface org.lsmp.djep.sjep.PNodeI
Adds a node to this one.
add(PNodeI) - Method in class org.lsmp.djep.sjep.Polynomial
 
add(Polynomial) - Method in class org.lsmp.djep.sjep.Polynomial
 
add(Object, Object) - Method in class org.lsmp.djep.vectorJep.function.MAdd
Adds two objects.
add(MVector, MVector) - Method in class org.lsmp.djep.vectorJep.function.MAdd
Adds two vectors.
add(Matrix, Matrix) - Method in class org.lsmp.djep.vectorJep.function.MAdd
Adds two matrices.
add(Tensor, Tensor) - Method in class org.lsmp.djep.vectorJep.function.MAdd
Adds two tensors.
Add - Class in org.nfunk.jep.function
Addition function.
Add() - Constructor for class org.nfunk.jep.function.Add
 
add(Object, Object) - Method in class org.nfunk.jep.function.Add
Adds two numbers together.
add(Number, Number) - Method in class org.nfunk.jep.function.Add
 
add(Complex, Complex) - Method in class org.nfunk.jep.function.Add
 
add(Complex, Number) - Method in class org.nfunk.jep.function.Add
 
add(Complex) - Method in class org.nfunk.jep.type.Complex
Adds the complex number with another complex value.
addActionListener(ActionListener) - Method in class net.java.dev.colorchooser.ColorChooser
Registers ActionListener to receive events.
addActiveSubdetector(String) - Method in class hep.lcio.implementation.event.ILCRunHeader
 
addAll(Iterable<BSPTree<S>>) - Method in class org.apache.commons.math3.geometry.partitioning.NodesSet
Add nodes if they are not already known.
addAll(EntityCollection) - Method in interface org.jfree.chart.entity.EntityCollection
Adds the entities from another collection to this collection.
addAll(EntityCollection) - Method in class org.jfree.chart.entity.StandardEntityCollection
Adds all the entities from the specified collection.
addAll(LegendItemCollection) - Method in class org.jfree.chart.LegendItemCollection
Adds the legend items from another collection to this collection.
addAllAlphaQCD(Iterable<? extends Float>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQCD = 13;
addAllAlphaQED(Iterable<? extends Float>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQED = 11;
addAllBarcode(Iterable<? extends Integer>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
addAllBarcode(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
addAllBarcode(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
addAllBtag(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Btag = 5 [packed = true];
addAllBtag(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Btag = 5 [packed = true];
addAllBtag(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Btag = 5 [packed = true];
addAllCharge(Iterable<? extends Integer>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
addAllCharge(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
addAllCharge(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Charge = 7 [packed = true];
addAllCharge(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint32 Charge = 4 [packed = true];
addAllCharge(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Charge = 7 [packed = true];
addAllCharge(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Charge = 7 [packed = true];
addAllCharge(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint32 Charge = 4 [packed = true];
addAllCharge(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
addAllCharge(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Charge = 4 [packed = true];
addAllDa(Iterable<? extends Double>) - Method in class promc.io.PEventFile.HEvent.Builder
repeated double da = 3 [packed = true];
addAllDa(Iterable<? extends Double>) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated double da = 3 [packed = true];
addAllDaughter1(Iterable<? extends Integer>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
addAllDaughter1(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
addAllDaughter1(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
addAllDaughter2(Iterable<? extends Integer>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
addAllDaughter2(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
addAllDaughter2(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
addAllDeltaEta(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
addAllDeltaEta(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
addAllDeltaEta(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
addAllDeltaPhi(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
addAllDeltaPhi(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
addAllDeltaPhi(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
addAllEdges(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double edges = 7 [packed = true];
addAllEnergy(Iterable<? extends Float>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float energy = 19 [packed = true];
addAllEnergy(Iterable<? extends Long>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 energy = 19 [packed = true];
addAllEnergy(Iterable<? extends Long>) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Energy = 3 [packed = true];
addAllEnergy(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Energy = 4 [packed = true];
addAllEntries(Iterable<? extends Integer>) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated int32 entries = 6 [packed = true];
addAllEntries(Iterable<? extends Integer>) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated int32 entries = 6 [packed = true];
addAllEntry(Iterable<? extends PEventFile.HEvent.Entry>) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
addAllErrors(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double errors = 3 [packed = true];
addAllErrors(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double errors = 3 [packed = true];
addAllEta(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Eta = 2 [packed = true];
addAllEta(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Eta = 2 [packed = true];
addAllEta(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Eta = 2 [packed = true];
addAllEta(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Eta = 2 [packed = true];
addAllEta(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Eta = 2 [packed = true];
addAllEta(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Eta = 20 [packed = true];
addAllEta(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Eta = 2 [packed = true];
addAllEta(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Eta = 2 [packed = true];
addAllEtaOuter(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 EtaOuter = 11 [packed = true];
addAllFdata(Iterable<? extends Float>) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 17;
addAllFdata(Iterable<? extends Double>) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated double fdata = 15 [packed = true];
addAllFdata(Iterable<? extends Float>) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 3;
addAllGroup(Iterable<? extends PEventFile.HEvent.Group>) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
addAllHadOverEem(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
addAllHadOverEem(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
addAllHadOverEem(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
addAllHeights(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double heights = 2 [packed = true];
addAllHeights(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double heights = 2 [packed = true];
addAllId(Iterable<? extends Integer>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
addAllId(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
addAllId(Iterable<? extends Integer>) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
addAllId(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
addAllID1(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID1 = 4 [packed = true];
addAllID2(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID2 = 5 [packed = true];
addAllIda(Iterable<? extends Long>) - Method in class promc.io.PEventFile.HEvent.Builder
repeated int64 ida = 4 [packed = true];
addAllIda(Iterable<? extends Long>) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated int64 ida = 2 [packed = true];
addAllIdata(Iterable<? extends Long>) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 18;
addAllIdata(Iterable<? extends Long>) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 16 [packed = true];
addAllIdata(Iterable<? extends Long>) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 4;
addAllMass(Iterable<? extends Float>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float mass = 4 [packed = true];
addAllMass(Iterable<? extends Long>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
addAllMass(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 Mass = 4 [packed = true];
addAllMass(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 Mass = 4 [packed = true];
addAllMass(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 Mass = 4 [packed = true];
addAllMass(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
addAllMeans(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double means = 4 [packed = true];
addAllMeansX(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansX = 4 [packed = true];
addAllMeansY(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansY = 7 [packed = true];
addAllMET(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated uint64 MET = 1 [packed = true];
addAllMetaFloat(Iterable<? extends ProMCHeaderFile.ProMCHeader.MetaFloat>) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addAllMetaFloat(Iterable<? extends ProMCStatFile.ProMCStat.MetaFloat>) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
addAllMetaFloat(Iterable<? extends ProMCHeaderFile.ProMCHeader.MetaFloat>) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addAllMetaFloat(Iterable<? extends ProMCHeaderFile.ProMCHeader.MetaFloat>) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addAllMetaFloat(Iterable<? extends ProMCHeaderFile.ProMCHeader.MetaFloat>) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addAllMetaInt(Iterable<? extends ProMCHeaderFile.ProMCHeader.MetaInt>) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addAllMetaInt(Iterable<? extends ProMCStatFile.ProMCStat.MetaInt>) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
addAllMetaInt(Iterable<? extends ProMCHeaderFile.ProMCHeader.MetaInt>) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addAllMetaInt(Iterable<? extends ProMCHeaderFile.ProMCHeader.MetaInt>) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addAllMetaInt(Iterable<? extends ProMCHeaderFile.ProMCHeader.MetaInt>) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addAllMother1(Iterable<? extends Integer>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
addAllMother1(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
addAllMother1(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
addAllMother2(Iterable<? extends Integer>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
addAllMother2(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
addAllMother2(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
addAllMPI(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 MPI = 3 [packed = true];
addAllNumber(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 Number = 1 [packed = true];
addAllOf(DoubleArrayList) - Method in class cern.colt.buffer.DoubleBuffer
Adds all elements of the specified list to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList) - Method in class cern.colt.buffer.DoubleBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList) - Method in interface cern.colt.buffer.DoubleBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList, DoubleArrayList) - Method in class cern.colt.buffer.DoubleBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList, DoubleArrayList) - Method in interface cern.colt.buffer.DoubleBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(DoubleArrayList) - Method in interface cern.colt.buffer.DoubleBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(IntArrayList) - Method in class cern.colt.buffer.IntBuffer
Adds all elements of the specified list to the receiver.
addAllOf(IntArrayList, IntArrayList) - Method in class cern.colt.buffer.IntBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(IntArrayList, IntArrayList) - Method in interface cern.colt.buffer.IntBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.buffer.IntBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(IntArrayList, IntArrayList, IntArrayList) - Method in interface cern.colt.buffer.IntBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(IntArrayList) - Method in interface cern.colt.buffer.IntBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(ObjectArrayList) - Method in class cern.colt.buffer.ObjectBuffer
Adds all elements of the specified list to the receiver.
addAllOf(ObjectArrayList) - Method in interface cern.colt.buffer.ObjectBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(DoubleArrayList) - Method in class cern.colt.list.AbstractDoubleList
Appends all elements of the specified list to the receiver.
addAllOf(IntArrayList) - Method in class cern.colt.list.AbstractIntList
Appends all elements of the specified list to the receiver.
addAllOf(Collection) - Method in class cern.colt.list.AbstractList
Appends all of the elements of the specified Collection to the receiver.
addAllOf(DoubleArrayList) - Method in class cern.hep.aida.bin.AbstractBin1D
Adds all values of the specified list to the receiver.
addAllOf(DoubleArrayList) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Adds all values of the specified list to the receiver.
addAllOfFromTo(AbstractBooleanList, int, int) - Method in class cern.colt.list.AbstractBooleanList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractByteList, int, int) - Method in class cern.colt.list.AbstractByteList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractCharList, int, int) - Method in class cern.colt.list.AbstractCharList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractDoubleList, int, int) - Method in class cern.colt.list.AbstractDoubleList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractFloatList, int, int) - Method in class cern.colt.list.AbstractFloatList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractIntList, int, int) - Method in class cern.colt.list.AbstractIntList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractLongList, int, int) - Method in class cern.colt.list.AbstractLongList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractShortList, int, int) - Method in class cern.colt.list.AbstractShortList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(long[], int, int) - Method in class cern.colt.list.MinMaxNumberList
Appends the elements elements[from] (inclusive), ..., elements[to] (inclusive) to the receiver.
addAllOfFromTo(ObjectArrayList, int, int) - Method in class cern.colt.list.ObjectArrayList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.hep.aida.bin.AbstractBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.hep.aida.bin.DynamicBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.hep.aida.bin.MightyStaticBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.hep.aida.bin.QuantileBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.hep.aida.bin.StaticBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOutofrange(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double outofrange = 10 [packed = true];
addAllParticleData(Iterable<? extends ProMCHeaderFile.ProMCHeader.ParticleData>) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addAllParticleData(Iterable<? extends ProMCHeaderFile.ProMCHeader.ParticleData>) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addAllParticleData(Iterable<? extends ProMCHeaderFile.ProMCHeader.ParticleData>) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addAllParticleData(Iterable<? extends ProMCHeaderFile.ProMCHeader.ParticleData>) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addAllPDF1(Iterable<? extends Float>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF1 = 6 [packed = true];
addAllPDF2(Iterable<? extends Float>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF2 = 7 [packed = true];
addAllPdgId(Iterable<? extends Integer>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
addAllPdgId(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
addAllPdgId(Iterable<? extends Integer>) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
addAllPdgId(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
addAllPhi(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Phi = 3 [packed = true];
addAllPhi(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Phi = 3 [packed = true];
addAllPhi(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Phi = 3 [packed = true];
addAllPhi(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Phi = 3 [packed = true];
addAllPhi(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated sint64 Phi = 3 [packed = true];
addAllPhi(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Phi = 3 [packed = true];
addAllPhi(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Phi = 21 [packed = true];
addAllPhi(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Phi = 3 [packed = true];
addAllPhi(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Phi = 3 [packed = true];
addAllPhiOuter(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 PhiOuter = 12 [packed = true];
addAllProcessData(Iterable<? extends ProMCStatFile.ProMCStat.ProcessData>) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addAllProcessData(Iterable<? extends ProMCStatFile.ProMCStat.ProcessData>) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addAllProcessData(Iterable<? extends ProMCStatFile.ProMCStat.ProcessData>) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addAllProcessData(Iterable<? extends ProMCStatFile.ProMCStat.ProcessData>) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addAllProcessID(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ProcessID = 2 [packed = true];
addAllPT(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 PT = 1 [packed = true];
addAllPT(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated uint64 PT = 1 [packed = true];
addAllPT(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 PT = 1 [packed = true];
addAllPT(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 PT = 1 [packed = true];
addAllPT(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated uint64 PT = 1 [packed = true];
addAllPT(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 PT = 19 [packed = true];
addAllPT(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated uint64 PT = 1 [packed = true];
addAllPT(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated uint64 PT = 1 [packed = true];
addAllPx(Iterable<? extends Float>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Px = 5 [packed = true];
addAllPx(Iterable<? extends Long>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
addAllPx(Iterable<? extends Long>) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 4 [packed = true];
addAllPx(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
addAllPy(Iterable<? extends Float>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Py = 6 [packed = true];
addAllPy(Iterable<? extends Long>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
addAllPy(Iterable<? extends Long>) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 5 [packed = true];
addAllPy(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
addAllPz(Iterable<? extends Float>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Pz = 7 [packed = true];
addAllPz(Iterable<? extends Long>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
addAllPz(Iterable<? extends Long>) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 6 [packed = true];
addAllPz(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
addAllRmses(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double rmses = 5 [packed = true];
addAllRmsesX(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesX = 5 [packed = true];
addAllRmsesY(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesY = 8 [packed = true];
addAllScale(Iterable<? extends Float>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float Scale = 12;
addAllScalePDF(Iterable<? extends Float>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float ScalePDF = 10;
addAllStatus(Iterable<? extends Integer>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
addAllStatus(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
addAllStatus(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
addAllSummary(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double summary = 9 [packed = true];
addAllT(Iterable<? extends Float>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float T = 16 [packed = true];
addAllT(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
addAllT(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
addAllTauTag(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 TauTag = 6 [packed = true];
addAllTauTag(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 TauTag = 6 [packed = true];
addAllTautag(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Tautag = 6 [packed = true];
addAllValue(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.P0D.Builder
repeated double value = 2 [packed = true];
addAllValue(Iterable<? extends Long>) - Method in class promc.io.PBufFile.Record.P0I.Builder
repeated int64 value = 2 [packed = true];
addAllValue(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.PND.Builder
repeated double value = 2 [packed = true];
addAllValue(Iterable<? extends Integer>) - Method in class promc.io.PBufFile.Record.PNI.Builder
repeated int32 value = 2 [packed = true];
addAllWeight(Iterable<? extends Float>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float weight = 17 [packed = true];
addAllWeight(Iterable<? extends Long>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
addAllWeight(Iterable<? extends Long>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
addAllX(Iterable<? extends Float>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float X = 13 [packed = true];
addAllX(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double x = 2 [packed = true];
addAllX(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double x = 2 [packed = true];
addAllX(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double x = 2 [packed = true];
addAllX(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
addAllX(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
addAllX(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 X = 5 [packed = true];
addAllX1(Iterable<? extends Float>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X1 = 8;
addAllX2(Iterable<? extends Float>) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X2 = 9;
addAllXleft(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xleft = 4 [packed = true];
addAllXOuter(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 XOuter = 8 [packed = true];
addAllXright(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xright = 5 [packed = true];
addAllXsysleft(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysleft = 8 [packed = true];
addAllXsysright(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysright = 9 [packed = true];
addAllY(Iterable<? extends Float>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Y = 14 [packed = true];
addAllY(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double y = 3 [packed = true];
addAllY(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double y = 3 [packed = true];
addAllY(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double y = 3 [packed = true];
addAllY(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
addAllY(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
addAllY(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Y = 6 [packed = true];
addAllYlower(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ylower = 7 [packed = true];
addAllYOuter(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 YOuter = 9 [packed = true];
addAllYsyslower(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysyslower = 11 [packed = true];
addAllYsysupper(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysysupper = 10 [packed = true];
addAllYupper(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double yupper = 6 [packed = true];
addAllZ(Iterable<? extends Float>) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Z = 15 [packed = true];
addAllZ(Iterable<? extends Double>) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double z = 4 [packed = true];
addAllZ(Iterable<? extends Integer>) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
addAllZ(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
addAllZ(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Z = 7 [packed = true];
addAllZOuter(Iterable<? extends Integer>) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 ZOuter = 10 [packed = true];
addAlphaQCD(float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQCD = 13;
addAlphaQED(float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQED = 11;
addAnchoredComponent(JComponent, int, int, int) - Method in class jplot.panels.PanelGridUI
 
addAnchoredComponent(JComponent, int, int, int, int, int) - Method in class jplot.panels.PanelGridUI
 
addAndAverage(P1D[]) - Method in class jhplot.P1D
Return P1D array with weighted average of several measurements.
addAndCheck(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Add two integers, checking for overflow.
addAndCheck(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Add two long integers, checking for overflow.
addAndOrUpdate(TimeSeries) - Method in class org.jfree.data.time.TimeSeries
Adds or updates data from one series to another.
addAnnotation(CategoryAnnotation) - Method in class org.jfree.chart.plot.CategoryPlot
Adds an annotation to the plot and sends a PlotChangeEvent to all registered listeners.
addAnnotation(CategoryAnnotation, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Adds an annotation to the plot and, if requested, sends a PlotChangeEvent to all registered listeners.
addAnnotation(XYAnnotation) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Adds an annotation to the plot.
addAnnotation(XYAnnotation) - Method in class org.jfree.chart.plot.XYPlot
Adds an annotation to the plot and sends a PlotChangeEvent to all registered listeners.
addAnnotation(XYAnnotation, boolean) - Method in class org.jfree.chart.plot.XYPlot
Adds an annotation to the plot and, if requested, sends a PlotChangeEvent to all registered listeners.
addAnnotation(XYAnnotation) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Adds an annotation and sends a RendererChangeEvent to all registered listeners.
addAnnotation(XYAnnotation, Layer) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Adds an annotation to the specified layer and sends a RendererChangeEvent to all registered listeners.
addAnnotation(XYAnnotation) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Adds an annotation and sends a RendererChangeEvent to all registered listeners.
addAnnotation(XYAnnotation, Layer) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Adds an annotation to the specified layer.
addAttributeListener(ActionListener) - Method in class org.jlab.groot.base.AxisAttributes.AxisAttributesPane
 
addAttributeListener(ActionListener) - Method in class org.jlab.groot.base.DatasetAttributes.DatasetAttributesPane
 
addBarcode(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
addBarcode(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
addBarcode(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
addBaseTimelineException(long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Adds a segment relative to the baseTimeline as an exception.
addBaseTimelineException(Date) - Method in class org.jfree.chart.axis.SegmentedTimeline
Adds a segment relative to the baseTimeline as an exception.
addBaseTimelineExclusions(long, long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Adds all excluded segments from the BaseTimeline as exceptions to our timeline.
addBin(SimpleHistogramBin) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Adds a bin to the dataset.
addBin(int[]) - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
addBin(DataVector, int[]) - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
addBinContent(int, double, int[]) - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
addBranch(Branch) - Method in class org.jlab.groot.tree.Tree
 
addBranch(String, String, String) - Method in class org.jlab.groot.tree.Tree
add Branch with name description and units
addBtag(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Btag = 5 [packed = true];
addBtag(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Btag = 5 [packed = true];
addBtag(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Btag = 5 [packed = true];
addCanvas() - Method in class org.jlab.groot.graphics.EmbeddedCanvasTabbed
 
addCanvas(String) - Method in class org.jlab.groot.graphics.EmbeddedCanvasTabbed
 
addCanvas() - Method in class org.jlab.groot.ui.TBrowser
 
addCategoryLabelToolTip(Comparable, String) - Method in class org.jfree.chart.axis.CategoryAxis
Adds a tooltip to the specified category and sends an AxisChangeEvent to all registered listeners.
addCategoryLabelURL(Comparable, String) - Method in class org.jfree.chart.axis.CategoryAxis
Adds a URL (to be used in image maps) to the specified category and sends an AxisChangeEvent to all registered listeners.
addChangeListener(ChangeListener) - Method in interface jplot3d.SurfaceModel
 
addChangeListener(ChangeListener) - Method in class jplot3d.SurfaceModelCanvas
 
addChangeListener(AnnotationChangeListener) - Method in class org.jfree.chart.annotations.AbstractAnnotation
Registers an object to receive notification of changes to the annotation.
addChangeListener(AnnotationChangeListener) - Method in interface org.jfree.chart.annotations.Annotation
Registers an object for notification of changes to the annotation.
addChangeListener(AxisChangeListener) - Method in class org.jfree.chart.axis.Axis
Registers an object for notification of changes to the axis.
addChangeListener(ChartChangeListener) - Method in class org.jfree.chart.JFreeChart
Registers an object for notification of changes to the chart.
addChangeListener(OverlayChangeListener) - Method in class org.jfree.chart.panel.AbstractOverlay
Registers an object for notification of changes to the overlay.
addChangeListener(OverlayChangeListener) - Method in interface org.jfree.chart.panel.Overlay
Registers a change listener with the overlay.
addChangeListener(DialLayerChangeListener) - Method in class org.jfree.chart.plot.dial.AbstractDialLayer
Registers an object for notification of changes to the dial layer.
addChangeListener(DialLayerChangeListener) - Method in interface org.jfree.chart.plot.dial.DialLayer
Registers a listener with this layer, so that it receives notification of changes to this layer.
addChangeListener(MarkerChangeListener) - Method in class org.jfree.chart.plot.Marker
Registers an object for notification of changes to the marker.
addChangeListener(PlotChangeListener) - Method in class org.jfree.chart.plot.Plot
Registers an object for notification of changes to the plot.
addChangeListener(RendererChangeListener) - Method in class org.jfree.chart.renderer.AbstractRenderer
Registers an object to receive notification of changes to the renderer.
addChangeListener(RendererChangeListener) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Adds a change listener.
addChangeListener(RendererChangeListener) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Adds a change listener.
addChangeListener(RendererChangeListener) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Add a renderer change listener.
addChangeListener(TitleChangeListener) - Method in class org.jfree.chart.title.Title
Registers an object for notification of changes to the title.
addChangeListener(DatasetChangeListener) - Method in class org.jfree.data.general.AbstractDataset
Registers an object to receive notification of changes to the dataset.
addChangeListener(DatasetChangeListener) - Method in interface org.jfree.data.general.Dataset
Registers an object for notification of changes to the dataset.
addChangeListener(SeriesChangeListener) - Method in class org.jfree.data.general.Series
Registers an object with this series, to receive notification whenever the series changes.
addChannel(H1D, H1D, H1D) - Method in class jhplot.stat.DataSource
Adds a channel with signal, background and data given as input.
addChannel(P1D, P1D, P1D) - Method in class jhplot.stat.DataSource
Adds a channel with signal, background and data given as input.
addChannel(DataKeeper, DataKeeper, DataKeeper, double, double, double, String) - Method in class jhplot.stat.DataSource
Adds a channel with signal, background and data given as input.
addChannel(DataKeeper, DataKeeper, DataKeeper) - Method in class jhplot.stat.DataSource
Adds a channel with signal, background and data given as input.
addChannel(H1D, H1D, H1D, double, double, double, String) - Method in class jhplot.stat.DataSource
Adds a channel with signal, background and data given as input.
addChannel(P1D, P1D, P1D, double, double, double, String) - Method in class jhplot.stat.DataSource
Adds a channel with signal, background and data given as input.
addCharge(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
addCharge(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
addCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Charge = 7 [packed = true];
addCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint32 Charge = 4 [packed = true];
addCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Charge = 7 [packed = true];
addCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Charge = 7 [packed = true];
addCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint32 Charge = 4 [packed = true];
addCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
addCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Charge = 4 [packed = true];
addChart(String) - Method in class org.jfree.chart.servlet.ChartDeleter
Add a chart to be deleted when the session expires
addChartMouseListener(ChartMouseListener) - Method in class org.jfree.chart.ChartPanel
Adds a listener to the list of objects listening for chart mouse events.
addChartMouseListener(ChartMouseListenerFX) - Method in class org.jfree.chart.fx.ChartCanvas
Registers a listener to receive ChartMouseEvent notifications.
addChartMouseListener(ChartMouseListenerFX) - Method in class org.jfree.chart.fx.ChartViewer
Registers a listener to receive ChartMouseEvent notifications from this viewer.
addChartMouseListener(ChartMouseListenerFX) - Method in class org.jfree.chart.fx.ChartViewerSkin
Registers a listener to receive ChartMouseEvent notifications from the chart viewer.
addChromosome(Chromosome) - Method in class org.apache.commons.math3.genetics.ListPopulation
Add the given chromosome to the population.
addChromosome(Chromosome) - Method in interface org.apache.commons.math3.genetics.Population
Add the given chromosome to the population.
addChromosomes(Collection<Chromosome>) - Method in class org.apache.commons.math3.genetics.ListPopulation
Add a Collection of chromosomes to this Population.
addCluster(Cluster) - Method in interface hep.lcio.event.ReconstructedParticle
Add a cluster that has been used to create this particle.
addCluster(Cluster) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
addCollection(LCCollection, String) - Method in interface hep.lcio.event.LCEvent
Adds a collection with the given name (has to be a valid C/C++ variable name).
addCollection(LCCollection, String) - Method in class hep.lcio.implementation.event.ILCEvent
 
addColumn(int, LinePars) - Method in class jplot.DataFile
Adds a column to the vector of columns.
addCommand(String) - Method in class org.jlab.groot.io.ArgumentParser
 
addCommand(String, String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
addCommandHandler(CommandHandler) - Method in class hep.lcio.util.CommandLineTool
Add a @see CommandHandler to the CommandLineTool.
addComp(Component) - Method in class jhplot.gui.GHPanel
Add a component to the main panel
addComplex() - Method in class org.lsmp.djep.xjep.XJep
 
addComplex() - Method in class org.nfunk.jep.JEP
Call this function if you want to parse expressions which involve complex numbers.
addComponent(JComponent, int, int) - Method in class jplot.panels.PanelGridUI
 
addComponent(JComponent, int, int, int, int) - Method in class jplot.panels.PanelGridUI
 
addComponent(JComponent, int, int, int, int, int, int) - Method in class jplot.panels.PanelGridUI
 
addConstant(String, Object) - Method in class org.nfunk.jep.JEP
Adds a constant.
addConstant(String, Object) - Method in class org.nfunk.jep.SymbolTable
Create a constant variable with the given name and value.
addConstituent(int) - Method in class hephysics.jet.ParticleD
 
addCornerTextItem(String) - Method in class org.jfree.chart.plot.PolarPlot
Add text to be displayed in the lower right hand corner and sends a PlotChangeEvent to all registered listeners.
addCut() - Method in class org.jlab.groot.studio.StudioUI
 
addCut(String, String, ITree) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
addCut(TreeCut) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
addCut(String, String, List<String>) - Method in class org.jlab.groot.tree.TreeSelector
 
addCut(TreeCut) - Method in class org.jlab.groot.tree.TreeSelector
 
addDa(double) - Method in class promc.io.PEventFile.HEvent.Builder
repeated double da = 3 [packed = true];
addDa(double) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated double da = 3 [packed = true];
addData(ExpData) - Method in class jhplot.stat.limit.StatConfidence
Add experimental data
addData(String) - Method in class jplot.XMLWrite
Adds data to the buffer.
addData(double, double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Adds the observation (x,y) to the regression data set.
addData(double[][]) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Adds the observations represented by the elements in data.
addDataset(ValueDataset) - Method in class org.jfree.chart.plot.CompassPlot
Adds a dataset to the compass.
addDataset(ValueDataset, MeterNeedle) - Method in class org.jfree.chart.plot.CompassPlot
Adds a dataset to the compass.
addDataSet(IDataSet...) - Method in class org.jlab.groot.data.TDirectory
 
addDataSet(IDataSet, int) - Method in class org.jlab.groot.group.DataGroup
 
addDataSet(IDataSet) - Method in class org.jlab.groot.tree.AbstractDescriptor
 
addDataVector(DataVector) - Method in class org.jlab.groot.data.DataVector
 
addDaughter(MCParticle) - Method in class hep.lcio.implementation.event.IMCParticle
 
addDaughter(Particle) - Method in class hep.physics.particle.BasicParticle
Adds a child to this particle.
addDaughter1(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
addDaughter1(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
addDaughter1(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
addDaughter2(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
addDaughter2(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
addDaughter2(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
addDeltaEta(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
addDeltaEta(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
addDeltaEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
addDeltaPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
addDeltaPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
addDeltaPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
addDescriptor(int) - Method in class org.jlab.groot.studio.StudioUI
 
addDescriptor(DatasetDescriptor) - Method in class org.jlab.groot.tree.TreeAnalyzer
 
addDiffRule(DiffRulesI) - Method in class org.lsmp.djep.djep.DJep
Adds a rule with instruction on how to differentiate a function.
addDomainCrosshair(Crosshair) - Method in class org.jfree.chart.panel.CrosshairOverlay
Adds a crosshair against the domain axis and sends an OverlayChangeEvent to all registered listeners.
addDomainMarker(CategoryMarker) - Method in class org.jfree.chart.plot.CategoryPlot
Adds a marker for display (in the foreground) against the domain axis and sends a PlotChangeEvent to all registered listeners.
addDomainMarker(CategoryMarker, Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Adds a marker for display against the domain axis and sends a PlotChangeEvent to all registered listeners.
addDomainMarker(int, CategoryMarker, Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Adds a marker for display by a particular renderer and sends a PlotChangeEvent to all registered listeners.
addDomainMarker(int, CategoryMarker, Layer, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Adds a marker for display by a particular renderer and, if requested, sends a PlotChangeEvent to all registered listeners.
addDomainMarker(Marker) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Adds a marker for the domain axis.
addDomainMarker(Marker) - Method in class org.jfree.chart.plot.XYPlot
Adds a marker for the domain axis and sends a PlotChangeEvent to all registered listeners.
addDomainMarker(Marker, Layer) - Method in class org.jfree.chart.plot.XYPlot
Adds a marker for the domain axis in the specified layer and sends a PlotChangeEvent to all registered listeners.
addDomainMarker(int, Marker, Layer) - Method in class org.jfree.chart.plot.XYPlot
Adds a marker for a specific dataset/renderer and sends a PlotChangeEvent to all registered listeners.
addDomainMarker(int, Marker, Layer, boolean) - Method in class org.jfree.chart.plot.XYPlot
Adds a marker for a specific dataset/renderer and, if requested, sends a PlotChangeEvent to all registered listeners.
addEdges(double) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double edges = 7 [packed = true];
addElement(LCObject) - Method in interface hep.lcio.event.LCCollection
Adds the given element to (end of) the collection.
addElement(LCObject) - Method in class hep.lcio.implementation.event.ILCCollection
 
addElement(double) - Method in interface org.apache.commons.math3.util.DoubleArray
Adds an element to the end of this expandable array
addElement(double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Adds an element to the end of this expandable array.
addElementRolling(double) - Method in interface org.apache.commons.math3.util.DoubleArray
Adds an element to the end of the array and removes the first element in the array.
addElementRolling(double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Adds an element to the end of the array and removes the first element in the array.
addElements(double[]) - Method in interface org.apache.commons.math3.util.DoubleArray
Adds elements to the end of this expandable array
addElements(double[]) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Adds several element to the end of this expandable array.
addEncoded(int, String) - Method in class org.jlab.groot.group.DataGroupDescriptor
 
addEnergy(float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float energy = 19 [packed = true];
addEnergy(long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 energy = 19 [packed = true];
addEnergy(long) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Energy = 3 [packed = true];
addEnergy(long) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Energy = 4 [packed = true];
addEntries(int) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated int32 entries = 6 [packed = true];
addEntries(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated int32 entries = 6 [packed = true];
addEntry(PEventFile.HEvent.Entry) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
addEntry(int, PEventFile.HEvent.Entry) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
addEntry(PEventFile.HEvent.Entry.Builder) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
addEntry(int, PEventFile.HEvent.Entry.Builder) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
addEntryBuilder() - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
addEntryBuilder(int) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
addError(Exception) - Method in class org.lsmp.djep.xjep.ErrorCatchingVisitor
Adds an error message to the list of errors.
addErrors(double) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double errors = 3 [packed = true];
addErrors(double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double errors = 3 [packed = true];
addEta(long) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Eta = 2 [packed = true];
addEta(long) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Eta = 2 [packed = true];
addEta(long) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Eta = 2 [packed = true];
addEta(long) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Eta = 2 [packed = true];
addEta(long) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Eta = 2 [packed = true];
addEta(long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Eta = 20 [packed = true];
addEta(long) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Eta = 2 [packed = true];
addEta(long) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Eta = 2 [packed = true];
addEtaOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 EtaOuter = 11 [packed = true];
addEventHandler(FieldEventHandler<T>, double, double, int) - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Add an event handler to the integrator.
addEventHandler(FieldEventHandler<T>, double, double, int, BracketedRealFieldUnivariateSolver<T>) - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int, UnivariateSolver) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Add an event handler to the integrator.
addEventHandler(FieldEventHandler<T>, double, double, int) - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Add an event handler to the integrator.
addEventHandler(FieldEventHandler<T>, double, double, int, BracketedRealFieldUnivariateSolver<T>) - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int, UnivariateSolver) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int, UnivariateSolver) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Add an event handler to the integrator.
addExact(int, int) - Static method in class org.apache.commons.math3.util.FastMath
Add two numbers, detecting overflows.
addExact(long, long) - Static method in class org.apache.commons.math3.util.FastMath
Add two numbers, detecting overflows.
addException(long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Adds a segment as an exception.
addException(long, long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Adds a segment range as an exception.
addException(Date) - Method in class org.jfree.chart.axis.SegmentedTimeline
Adds a segment as an exception.
addExceptions(List) - Method in class org.jfree.chart.axis.SegmentedTimeline
Adds a list of dates as segment exceptions.
addFdata(float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 17;
addFdata(double) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated double fdata = 15 [packed = true];
addFdata(float) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 3;
addFileFilter(IOFileFilter) - Method in class org.apache.commons.io.filefilter.AndFileFilter
Adds the specified file filter to the list of file filters at the end of the list.
addFileFilter(IOFileFilter) - Method in interface org.apache.commons.io.filefilter.ConditionalFileFilter
Adds the specified file filter to the list of file filters at the end of the list.
addFileFilter(IOFileFilter) - Method in class org.apache.commons.io.filefilter.OrFileFilter
Adds the specified file filter to the list of file filters at the end of the list.
addFiles(String, List<String>) - Static method in class org.jlab.groot.data.TDirectory
 
addFilledComponent(JComponent, int, int) - Method in class jplot.panels.PanelGridUI
 
addFilledComponent(JComponent, int, int, int) - Method in class jplot.panels.PanelGridUI
 
addFilledComponent(JComponent, int, int, int, int, int) - Method in class jplot.panels.PanelGridUI
 
addFlag(String, String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
addFunc(String, String, String, String, int) - Method in class fitter.Fitter
add a new user function with the name and tooltip
addFunc(String, String, String, String) - Method in class jhplot.HFit
Add a user 1D function in form of a string.
addFunc(String, IFunction) - Method in class jhplot.HFitter
Add a new function to catalog.
addFunction() - Method in class jplot3dp.ModelView.FunctionsList
 
addFunction(String, PostfixMathCommandI) - Method in class org.nfunk.jep.JEP
Adds a new function to the parser.
addGraph(int, int, Component) - Method in class jhplot.gui.GHFrame
Add a graph or any component in the location given by i1 and i2.
addGraph(int, int, Component) - Method in class jhplot.gui.GHPanel
Add a graph or any component in the location given by i1 and i2
addGroup(String, int, String) - Method in class org.jlab.groot.data.TDirectory
 
addGroup(PEventFile.HEvent.Group) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
addGroup(int, PEventFile.HEvent.Group) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
addGroup(PEventFile.HEvent.Group.Builder) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
addGroup(int, PEventFile.HEvent.Group.Builder) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
addGroupBuilder() - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
addGroupBuilder(int) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
addGroupDescriptor(String, int, int) - Method in class org.jlab.groot.data.TDirectory
 
addHadOverEem(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
addHadOverEem(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
addHadOverEem(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
addHeights(double) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double heights = 2 [packed = true];
addHeights(double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double heights = 2 [packed = true];
addId(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
addId(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
addId(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
addId(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
addID1(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID1 = 4 [packed = true];
addID2(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID2 = 5 [packed = true];
addIda(long) - Method in class promc.io.PEventFile.HEvent.Builder
repeated int64 ida = 4 [packed = true];
addIda(long) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated int64 ida = 2 [packed = true];
addIdata(long) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 18;
addIdata(long) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 16 [packed = true];
addIdata(long) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 4;
addImportMenuItem(JMenuItem) - Method in class org.jlab.groot.studio.StudioUI
 
addInPlace(SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Add in place.
addInterval(MeterInterval) - Method in class org.jfree.chart.plot.MeterPlot
Adds an interval and sends a PlotChangeEvent to all registered listeners.
addItem(String) - Method in class jplot.DataFile
Adds an item to the vector.
addItem(Comparable, Comparable, Number) - Method in class org.jfree.data.xml.CategoryDatasetHandler
Adds an item to the dataset.
addItem(Comparable, Number) - Method in class org.jfree.data.xml.CategorySeriesHandler
Adds an item to the temporary storage for the series.
addItem(Comparable, Number) - Method in class org.jfree.data.xml.PieDatasetHandler
Adds an item to the dataset under construction.
addIterationListener(IterationListener) - Method in class org.apache.commons.math3.util.IterationManager
Attaches a listener to this manager.
AdditionDiffRule - Class in org.lsmp.djep.djep.diffRules
Differentiates a addition with respect to var.
AdditionDiffRule(String) - Constructor for class org.lsmp.djep.djep.diffRules.AdditionDiffRule
 
ADDITIVE_MODE - Static variable in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
As of 3.1. Please use ResizableDoubleArray.ExpansionMode.ADDITIVE instead.
AdditiveExpression() - Method in class org.nfunk.jep.Parser
 
addKeyWord(String, int) - Method in class graph.ScanString
Add a keyword/token pair to the table of keywords to scan for.
addKeyWord(String, int) - Method in class graph.ScanWord
Add a keyword/token pair.
addLabel(GraphLabel) - Method in class jplot.GraphSettings
Adds a label to the list of graph labels.
addLayer(DialLayer) - Method in class org.jfree.chart.plot.dial.DialPlot
Adds a layer to the plot and sends a PlotChangeEvent to all registered listeners.
addLegend(LegendTitle) - Method in class org.jfree.chart.JFreeChart
Adds a legend to the plot and sends a ChartChangeEvent to all registered listeners.
addLine(int, int, int, int) - Method in class jplot3d.LineAccumulator
Adds a line to the accumulator.
addLink(Neuron, Neuron) - Method in class org.apache.commons.math3.ml.neuralnet.Network
Adds a link from neuron a to neuron b.
addListener(FileAlterationListener) - Method in class org.apache.commons.io.monitor.FileAlterationObserver
Adds a file system listener.
AddMarker(int, int, boolean[], int[], int[]) - Method in class graph.Markers
Add the definition of a new marker.
AddMarker(int, boolean[], int[], int[]) - Method in class graph.Markers
Add the definition of a new marker.
addMarker(IntervalMarker) - Method in class org.jfree.chart.axis.MarkerAxisBand
Adds a marker to the band.
addMass(float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float mass = 4 [packed = true];
addMass(long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
addMass(long) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 Mass = 4 [packed = true];
addMass(long) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 Mass = 4 [packed = true];
addMass(long) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 Mass = 4 [packed = true];
addMass(long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
addMCParticleContribution(MCParticle, float, float, int) - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
addMCParticleContribution(MCParticle, float, float, int, float[]) - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
addMCParticleContributions(ISimCalorimeterHit, SimCalorimeterHit, float) - Static method in class hep.lcio.util.MergeUtil
Add MCParticle contributions from an overlay hit to a target hit.
addMeans(double) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double means = 4 [packed = true];
addMeansX(double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansX = 4 [packed = true];
addMeansY(double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansY = 7 [packed = true];
addMessage(Localizable, Object...) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Adds a message.
addMET(long) - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated uint64 MET = 1 [packed = true];
addMetaFloat(ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(ProMCStatFile.ProMCStat.MetaFloat) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
addMetaFloat(int, ProMCStatFile.ProMCStat.MetaFloat) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
addMetaFloat(ProMCStatFile.ProMCStat.MetaFloat.Builder) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
addMetaFloat(int, ProMCStatFile.ProMCStat.MetaFloat.Builder) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
addMetaFloat(ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloatBuilder() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloatBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloatBuilder() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
addMetaFloatBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
addMetaFloatBuilder() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloatBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloatBuilder() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloatBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloatBuilder() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaFloatBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
addMetaInt(ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(ProMCStatFile.ProMCStat.MetaInt) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
addMetaInt(int, ProMCStatFile.ProMCStat.MetaInt) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
addMetaInt(ProMCStatFile.ProMCStat.MetaInt.Builder) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
addMetaInt(int, ProMCStatFile.ProMCStat.MetaInt.Builder) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
addMetaInt(ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaIntBuilder() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaIntBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaIntBuilder() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
addMetaIntBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
addMetaIntBuilder() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaIntBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaIntBuilder() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaIntBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaIntBuilder() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMetaIntBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
addMother1(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
addMother1(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
addMother1(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
addMother2(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
addMother2(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
addMother2(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
addMouseHandler(MouseHandlerFX) - Method in class org.jfree.chart.fx.ChartCanvas
Adds a mouse handler to the list of available handlers (handlers that are candidates to take the position of live handler).
addMPI(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 MPI = 3 [packed = true];
addNumber(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 Number = 1 [packed = true];
addObject(Comparable, Object) - Method in class org.jfree.data.KeyedObjects
Adds a new object to the collection, or overwrites an existing object.
addObject(Object, Comparable, Comparable) - Method in class org.jfree.data.KeyedObjects2D
Adds an object to the table.
addObject(Object) - Method in class org.jlab.groot.tree.DynamicTree
Add child to the currently selected node.
addObject(DefaultMutableTreeNode, Object) - Method in class org.jlab.groot.tree.DynamicTree
 
addObject(DefaultMutableTreeNode, Object, boolean) - Method in class org.jlab.groot.tree.DynamicTree
 
addObservation(double[], double) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Adds an observation to the regression model.
addObservation(double[], double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Adds one observation to the regression model.
addObservation(double[], double) - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Adds one observation to the regression model.
addObservation(double) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Adds an observation to the dataset (by incrementing the item count for the appropriate bin).
addObservation(double, boolean) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Adds an observation to the dataset (by incrementing the item count for the appropriate bin).
addObservations(double[][], double[]) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Adds multiple observations to the model.
addObservations(double[][], double[]) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Adds a series of observations to the regression model.
addObservations(double[][], double[]) - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Adds a series of observations to the regression model.
addObservations(double[]) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Adds a set of values to the dataset and sends a DatasetChangeEvent to all registered listeners.
addObservedPoint(double, double) - Method in class org.apache.commons.math3.fitting.CurveFitter
Deprecated.
Add an observed (x,y) point to the sample with unit weight.
addObservedPoint(double, double, double) - Method in class org.apache.commons.math3.fitting.CurveFitter
Deprecated.
Add an observed weighted (x,y) point to the sample.
addObservedPoint(WeightedObservedPoint) - Method in class org.apache.commons.math3.fitting.CurveFitter
Deprecated.
Add an observed weighted (x,y) point to the sample.
addObservedPoint(double, double) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated.
Add an observed (x,y) point to the sample with unit weight.
addObservedPoint(double, double, double) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated.
Add an observed weighted (x,y) point to the sample.
addObservedPoint(WeightedObservedPoint) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated.
Add an observed weighted (x,y) point to the sample.
addObserver(FileAlterationObserver) - Method in class org.apache.commons.io.monitor.FileAlterationMonitor
Adds a file system observer to this monitor.
addObserver(Observer) - Method in class org.nfunk.jep.SymbolTable
Adds an observer which will be notified when a new variable is created.
addObserverToExistingVariables(Observer) - Method in class org.nfunk.jep.SymbolTable
Adds an observer to all variables currently in the SymbolTable.
addOptionalParameter(String, String, String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
addOrUpdate(RegularTimePeriod, double) - Method in class org.jfree.data.time.TimeSeries
Adds or updates an item in the times series and sends a SeriesChangeEvent to all registered listeners.
addOrUpdate(RegularTimePeriod, Number) - Method in class org.jfree.data.time.TimeSeries
Adds or updates an item in the times series and sends a SeriesChangeEvent to all registered listeners.
addOrUpdate(TimeSeriesDataItem) - Method in class org.jfree.data.time.TimeSeries
Adds or updates an item in the times series and sends a SeriesChangeEvent to all registered listeners.
addOrUpdate(double, double) - Method in class org.jfree.data.xy.XYSeries
Adds or updates an item in the series and sends a SeriesChangeEvent to all registered listeners.
addOrUpdate(Number, Number) - Method in class org.jfree.data.xy.XYSeries
Adds or updates an item in the series and sends a SeriesChangeEvent to all registered listeners.
addOrUpdate(XYDataItem) - Method in class org.jfree.data.xy.XYSeries
Adds or updates an item in the series and sends a SeriesChangeEvent to all registered listeners.
addOutofrange(double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double outofrange = 10 [packed = true];
addOverlay(Overlay) - Method in class org.jfree.chart.ChartPanel
Add an overlay to the panel.
addPadding(double) - Method in class org.jlab.groot.math.Dimension1D
 
addPadding(double, double) - Method in class org.jlab.groot.math.Dimension1D
 
addParameter(String) - Method in class org.jlab.groot.math.Func1D
 
addParameter(UserParameter) - Method in class org.jlab.groot.math.Func1D
 
addParameterJacobianProvider(ParameterJacobianProvider) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Add a parameter Jacobian provider.
addParticle(ReconstructedParticle) - Method in interface hep.lcio.event.ReconstructedParticle
Add a particle that has been used to create this particle.
addParticle(ReconstructedParticle) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
addParticle(PDGParticle) - Static method in class j4np.physics.PDGDatabase
 
addParticle(String, int, double, int) - Static method in class j4np.physics.PDGDatabase
 
addParticleData(ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleDataBuilder() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleDataBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleDataBuilder() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleDataBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleDataBuilder() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleDataBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleDataBuilder() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleDataBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
addParticleID(ParticleID) - Method in interface hep.lcio.event.ReconstructedParticle
Add a ParticleID object.
addParticleID(ParticleID) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
addPDF1(float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF1 = 6 [packed = true];
addPDF2(float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF2 = 7 [packed = true];
addPdgId(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
addPdgId(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
addPdgId(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
addPdgId(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
addPhi(long) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Phi = 3 [packed = true];
addPhi(long) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Phi = 3 [packed = true];
addPhi(long) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Phi = 3 [packed = true];
addPhi(long) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Phi = 3 [packed = true];
addPhi(long) - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated sint64 Phi = 3 [packed = true];
addPhi(long) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Phi = 3 [packed = true];
addPhi(long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Phi = 21 [packed = true];
addPhi(long) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Phi = 3 [packed = true];
addPhi(long) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Phi = 3 [packed = true];
addPhiOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 PhiOuter = 12 [packed = true];
addPieLabelRecord(PieLabelRecord) - Method in class org.jfree.chart.plot.AbstractPieLabelDistributor
Adds a label record.
addPlotter(IDataSetPlotter) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
addPoint(double, double) - Method in class jhplot.stat.LinReg
Add a point to the data and redo the regression
addPoint(double, double) - Method in class jplot.DataArray
Adds the values of a plot-point pair (x,y).
addPoint(double, double, double, double) - Method in class jplot.DataArray
Adds the values of a plot-point pair (x,y).
addPoint(double, double, double, double, double, double) - Method in class jplot.DataArray
Adds the values of a plot-point pair (x,y).
addPoint(double, double, double, double, double, double, double, double, double, double) - Method in class jplot.DataArray
Adds the values of a plot-point pair (x,y).
addPoint(double, double, boolean) - Method in class jplot.DataArray
Adds the values of a plot-point pair (x,y).
addPoint(double, double, double) - Method in class jplot.DataArray2D
Adds the values of a plot-point pair (x,y,z).
addPoint(double, double, double, double, double, double) - Method in class jplot.DataArray3D
Adds the values of a plot-point pair (x,y,z).
addPoint(T) - Method in class org.apache.commons.math3.ml.clustering.Cluster
Add a point to this cluster.
addPoint(T) - Method in class org.apache.commons.math3.stat.clustering.Cluster
Deprecated.
Add a point to this cluster.
addPoint(double, double, double, double) - Method in class org.jlab.groot.data.GraphErrors
 
addPointer(DialPointer) - Method in class org.jfree.chart.plot.dial.DialPlot
Adds a pointer to the plot and sends a PlotChangeEvent to all registered listeners.
addPrimitive(HShape) - Method in class jplot.GraphSettings
Adds a primitive to the list of graph labels.
addProcessData(ProMCStatFile.ProMCStat.ProcessData) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(int, ProMCStatFile.ProMCStat.ProcessData) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(int, ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(ProMCStatFile.ProMCStat.ProcessData) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(int, ProMCStatFile.ProMCStat.ProcessData) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(int, ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(ProMCStatFile.ProMCStat.ProcessData) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(int, ProMCStatFile.ProMCStat.ProcessData) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(int, ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(ProMCStatFile.ProMCStat.ProcessData) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(int, ProMCStatFile.ProMCStat.ProcessData) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessData(int, ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessDataBuilder() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessDataBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessDataBuilder() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessDataBuilder(int) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessDataBuilder() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessDataBuilder(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessDataBuilder() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessDataBuilder(int) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
addProcessID(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ProcessID = 2 [packed = true];
addProgressListener(ChartProgressListener) - Method in class org.jfree.chart.JFreeChart
Registers an object for notification of progress events relating to the chart.
addPropertyChangeListener(PropertyChangeListener) - Method in interface jplot3d.SurfaceModel
 
addPropertyChangeListener(String, PropertyChangeListener) - Method in interface jplot3d.SurfaceModel
 
addPropertyChangeListener(PropertyChangeListener) - Method in class jplot3d.SurfaceModelCanvas
 
addPropertyChangeListener(String, PropertyChangeListener) - Method in class jplot3d.SurfaceModelCanvas
 
addPropertyChangeListener(PropertyChangeListener) - Method in class org.jfree.chart.plot.Crosshair
Adds a property change listener.
addPropertyChangeListener(PropertyChangeListener) - Method in class org.jfree.data.general.Series
Adds a property change listener to the series.
addPT(long) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 PT = 1 [packed = true];
addPT(long) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated uint64 PT = 1 [packed = true];
addPT(long) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 PT = 1 [packed = true];
addPT(long) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 PT = 1 [packed = true];
addPT(long) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated uint64 PT = 1 [packed = true];
addPT(long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 PT = 19 [packed = true];
addPT(long) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated uint64 PT = 1 [packed = true];
addPT(long) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated uint64 PT = 1 [packed = true];
addPx(float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Px = 5 [packed = true];
addPx(long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
addPx(long) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 4 [packed = true];
addPx(long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
addPy(float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Py = 6 [packed = true];
addPy(long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
addPy(long) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 5 [packed = true];
addPy(long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
addPz(float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Pz = 7 [packed = true];
addPz(long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
addPz(long) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 6 [packed = true];
addPz(long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
addQuick(double, double, double) - Method in class jhplot.P1D
Adds the values of a plot-point pair (X,Y).
addQuick(double, double, double, double) - Method in class jhplot.P1D
Add values of a plot-point pair (X,Y).
addQuick(double, double, double, double, double, double) - Method in class jhplot.P1D
Adds the values of a plot-point pair (X,Y).
addQuick(double, double, double, double, double, double, double, double, double, double) - Method in class jhplot.P1D
Adds the values of a plot-point pair (x,y).
addRangeCrosshair(Crosshair) - Method in class org.jfree.chart.panel.CrosshairOverlay
Adds a crosshair against the range axis and sends an OverlayChangeEvent to all registered listeners.
addRangeMarker(Marker) - Method in class org.jfree.chart.plot.CategoryPlot
Adds a marker for display (in the foreground) against the range axis and sends a PlotChangeEvent to all registered listeners.
addRangeMarker(Marker, Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Adds a marker for display against the range axis and sends a PlotChangeEvent to all registered listeners.
addRangeMarker(int, Marker, Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Adds a marker for display by a particular renderer and sends a PlotChangeEvent to all registered listeners.
addRangeMarker(int, Marker, Layer, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Adds a marker for display by a particular renderer and sends a PlotChangeEvent to all registered listeners.
addRangeMarker(Marker) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Adds a marker for the range axis.
addRangeMarker(Marker) - Method in class org.jfree.chart.plot.XYPlot
Adds a marker for the range axis and sends a PlotChangeEvent to all registered listeners.
addRangeMarker(Marker, Layer) - Method in class org.jfree.chart.plot.XYPlot
Adds a marker for the range axis in the specified layer and sends a PlotChangeEvent to all registered listeners.
addRangeMarker(int, Marker, Layer) - Method in class org.jfree.chart.plot.XYPlot
Adds a marker for a specific dataset/renderer and sends a PlotChangeEvent to all registered listeners.
addRangeMarker(int, Marker, Layer, boolean) - Method in class org.jfree.chart.plot.XYPlot
Adds a marker for a specific dataset/renderer and, if requested, sends a PlotChangeEvent to all registered listeners.
addRaw(String, double, double, double, boolean, int) - Method in class fitter.SEditor
 
addRenderingHints(Map<?, ?>) - Method in class org.jfree.chart.fx.FXGraphics2D
Adds all the supplied rendering hints.
addRequiredParameter(String, String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
addResourcePath(String) - Static method in class jminhep.utils.ResourceLoader
 
addRmses(double) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double rmses = 5 [packed = true];
addRmsesX(double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesX = 5 [packed = true];
addRmsesY(double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesY = 8 [packed = true];
addRow(double[]) - Method in class org.jlab.groot.tree.TreeFile
 
addRow(List<LatexText>) - Method in class org.jlab.groot.ui.PaveText
 
addSamplePoint(T, T[]...) - Method in class org.apache.commons.math3.analysis.interpolation.FieldHermiteInterpolator
Add a sample point.
addSamplePoint(double, double[]...) - Method in class org.apache.commons.math3.analysis.interpolation.HermiteInterpolator
Add a sample point.
addScale(int, DialScale) - Method in class org.jfree.chart.plot.dial.DialPlot
Adds a dial scale to the plot and sends a PlotChangeEvent to all registered listeners.
addScale(float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float Scale = 12;
addScalePDF(float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float ScalePDF = 10;
addSecondaryEquations(SecondaryEquations) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Add a set of secondary equations to be integrated along with the primary set.
addSecondaryEquations(FieldSecondaryEquations<T>) - Method in class org.apache.commons.math3.ode.FieldExpandableODE
Add a set of secondary equations to be integrated along with the primary set.
addSeries(Comparable, double[], int) - Method in class org.jfree.data.statistics.HistogramDataset
Adds a series to the dataset, using the specified number of bins, and sends a DatasetChangeEvent to all registered listeners.
addSeries(Comparable, double[], int, double, double) - Method in class org.jfree.data.statistics.HistogramDataset
Adds a series to the dataset.
addSeries(float[], int, Comparable) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Adds a series to the dataset.
addSeries(OHLCSeries) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Adds a series to the collection and sends a DatasetChangeEvent to all registered listeners.
addSeries(TimePeriodValues) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Adds a series to the collection.
addSeries(TimeSeries) - Method in class org.jfree.data.time.TimeSeriesCollection
Adds a series to the collection and sends a DatasetChangeEvent to all registered listeners.
addSeries(Comparable, double[][]) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Adds a series or if a series with the same key already exists replaces the data for that series, then sends a DatasetChangeEvent to all registered listeners.
addSeries(XYSeries) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Adds a series to the collection and sends a DatasetChangeEvent to all registered listeners.
addSeries(Comparable, double[][]) - Method in class org.jfree.data.xy.DefaultXYDataset
Adds a series or if a series with the same key already exists replaces the data for that series, then sends a DatasetChangeEvent to all registered listeners.
addSeries(Comparable, double[][]) - Method in class org.jfree.data.xy.DefaultXYZDataset
Adds a series or if a series with the same key already exists replaces the data for that series, then sends a DatasetChangeEvent to all registered listeners.
addSeries(MatrixSeries) - Method in class org.jfree.data.xy.MatrixSeriesCollection
Adds a series to the collection.
addSeries(VectorSeries) - Method in class org.jfree.data.xy.VectorSeriesCollection
Adds a series to the collection and sends a DatasetChangeEvent to all registered listeners.
addSeries(XIntervalSeries) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Adds a series to the collection and sends a DatasetChangeEvent to all registered listeners.
addSeries(XYIntervalSeries) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Adds a series to the collection and sends a DatasetChangeEvent to all registered listeners.
addSeries(XYSeries) - Method in class org.jfree.data.xy.XYSeriesCollection
Adds a series to the collection and sends a DatasetChangeEvent to all registered listeners.
addSeries(YIntervalSeries) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Adds a series to the collection and sends a DatasetChangeEvent to all registered listeners.
addSeriesLabel(int, String) - Method in class org.jfree.chart.labels.MultipleXYSeriesLabelGenerator
Adds an extra label for the specified series.
addSet(String, DataHolder) - Method in class jminhep.gui.Plotter
Add series
addSettings(String) - Method in class jplot.XMLWrite
Add a value (or eventually a sub-set of valid XML stuff) to the current buffer.
addSpecialRule(Operator, PrintVisitor.PrintRulesI) - Method in class org.lsmp.djep.xjep.PrintVisitor
Adds a special print rule to be added for a given operator.
addStandardConstants(JEP) - Method in interface org.lsmp.djep.groupJep.GroupI
adds the standard constants for this group
addStandardConstants() - Method in class org.lsmp.djep.groupJep.GroupJep
 
addStandardConstants(JEP) - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
addStandardConstants(JEP) - Method in class org.lsmp.djep.groupJep.groups.Group
adds the standard constants for this group.
addStandardConstants(JEP) - Method in class org.lsmp.djep.groupJep.groups.Quaternions
 
addStandardConstants() - Method in class org.lsmp.djep.xjep.XJep
 
addStandardConstants() - Method in class org.nfunk.jep.JEP
Adds the constants pi and e to the parser.
addStandardDiffRules() - Method in class org.lsmp.djep.djep.DJep
Adds the standard set of differentation rules.
addStandardFunctions(JEP) - Method in interface org.lsmp.djep.groupJep.GroupI
adds the standard function for this group
addStandardFunctions() - Method in class org.lsmp.djep.groupJep.GroupJep
 
addStandardFunctions(JEP) - Method in class org.lsmp.djep.groupJep.groups.Group
adds the standard function for this group By default does nothing.
addStandardFunctions(JEP) - Static method in class org.lsmp.djep.jama.JamaUtil
 
addStandardFunctions() - Method in class org.lsmp.djep.matrixJep.MatrixJep
 
addStandardFunctions() - Method in class org.lsmp.djep.vectorJep.VectorJep
 
addStandardFunctions() - Method in class org.lsmp.djep.xjep.XJep
 
addStandardFunctions() - Method in class org.nfunk.jep.JEP
Adds the standard functions to the parser.
addStatus(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
addStatus(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
addStatus(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
addStepHandler(FieldStepHandler<T>) - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Add a step handler to this integrator.
addStepHandler(StepHandler) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Add a step handler to this integrator.
addStepHandler(FieldStepHandler<T>) - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Add a step handler to this integrator.
addStepHandler(StepHandler) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Add a step handler to this integrator.
addStepHandler(StepHandler) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Add a step handler to this integrator.
addString(AttributeType, String) - Method in class org.jlab.groot.base.Attributes
 
addSubCategory(Comparable) - Method in class org.jfree.chart.axis.SubCategoryAxis
Adds a sub-category to the axis and sends an AxisChangeEvent to all registered listeners.
addSubLabel(Comparable, String) - Method in class org.jfree.chart.axis.ExtendedCategoryAxis
Adds a sublabel for a category.
addSubplotInfo(PlotRenderingInfo) - Method in class org.jfree.chart.plot.PlotRenderingInfo
Adds the info for a subplot.
addSubtask(Task) - Method in class org.jfree.data.gantt.Task
Adds a sub-task to the task.
addSubtitle(Title) - Method in class org.jfree.chart.JFreeChart
Adds a chart subtitle, and notifies registered listeners that the chart has been modified.
addSubtitle(int, Title) - Method in class org.jfree.chart.JFreeChart
Adds a subtitle at a particular position in the subtitle list, and sends a ChartChangeEvent to all registered listeners.
addSubtitle(Title) - Method in class org.jfree.chart.plot.JThermometer
Adds a subtitle to the chart.
addSubtitle(String) - Method in class org.jfree.chart.plot.JThermometer
Adds a subtitle to the chart.
addSubtitle(String, Font) - Method in class org.jfree.chart.plot.JThermometer
Adds a subtitle to the chart.
addSummary(double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double summary = 9 [packed = true];
addT(float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float T = 16 [packed = true];
addT(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
addT(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
addTauTag(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 TauTag = 6 [packed = true];
addTauTag(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 TauTag = 6 [packed = true];
addTautag(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Tautag = 6 [packed = true];
addText(String...) - Method in class org.jlab.groot.ui.PaveText
 
addToDate(Date, TimeZone) - Method in class org.jfree.chart.axis.DateTickUnit
Calculates a new date by adding this unit to the base date.
addToDate(Date) - Method in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of JFreeChart 1.0.10, this method is deprecated - you should use DateTickUnit.addToDate(Date, TimeZone) instead.
addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Change an entry at the specified index.
addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, double) - Method in class org.apache.commons.math3.linear.RealVector
Change an entry at the specified index.
addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Change an entry in the specified row and column.
addToolTipSeries(List) - Method in class org.jfree.chart.labels.CustomXYToolTipGenerator
Adds a list of tooltips for a series.
addTrack(Track) - Method in interface hep.lcio.event.ReconstructedParticle
Add a track that has been used to create this particle.
addTrack(Track) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
addTreeModelListener(TreeModelListener) - Method in class root.RootHistogramTreeModel
 
addURLs(Map) - Method in class org.jfree.chart.urls.CustomPieURLGenerator
Adds a map containing (key, URL) mappings where each key is an instance of Comparable (corresponding to the key for an item in a pie dataset) and each URL is a String representing a URL fragment.
addURLSeries(List) - Method in class org.jfree.chart.urls.CustomCategoryURLGenerator
Adds a list of URLs.
addURLSeries(List) - Method in class org.jfree.chart.urls.CustomXYURLGenerator
Adds a list of URLs.
addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Adds the value to the dataset.
addValue(double[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Add an n-tuple to the data
addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Add a value to the data
addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Adds the value to the dataset.
addValue(double[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Add an n-tuple to the data
addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Add a value to the data
addValue(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
Adds 1 to the frequency count for v.
addValue(int) - Method in class org.apache.commons.math3.stat.Frequency
Adds 1 to the frequency count for v.
addValue(long) - Method in class org.apache.commons.math3.stat.Frequency
Adds 1 to the frequency count for v.
addValue(char) - Method in class org.apache.commons.math3.stat.Frequency
Adds 1 to the frequency count for v.
addValue(Number, Comparable, Comparable) - Method in class org.jfree.data.category.DefaultCategoryDataset
Adds a value to the table.
addValue(double, Comparable, Comparable) - Method in class org.jfree.data.category.DefaultCategoryDataset
Adds a value to the table.
addValue(Comparable, double) - Method in class org.jfree.data.DefaultKeyedValues
Updates an existing value, or adds a new value to the collection.
addValue(Comparable, Number) - Method in class org.jfree.data.DefaultKeyedValues
Adds a new value to the collection, or updates an existing value.
addValue(Number, Comparable, Comparable) - Method in class org.jfree.data.DefaultKeyedValues2D
Adds a value to the table.
addValue(Number, Comparable, Comparable) - Method in class org.jfree.data.general.WaferMapDataset
Sets a value in the dataset.
addValue(int, int, int) - Method in class org.jfree.data.general.WaferMapDataset
Adds a value to the dataset.
addValue(int, int, float) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Adds a value to a series.
addValue(double) - Method in class promc.io.PBufFile.Record.P0D.Builder
repeated double value = 2 [packed = true];
addValue(long) - Method in class promc.io.PBufFile.Record.P0I.Builder
repeated int64 value = 2 [packed = true];
addValue(double) - Method in class promc.io.PBufFile.Record.PND.Builder
repeated double value = 2 [packed = true];
addValue(int) - Method in class promc.io.PBufFile.Record.PNI.Builder
repeated int32 value = 2 [packed = true];
addVariable(String, double) - Method in class org.nfunk.jep.JEP
Adds a new variable to the parser, or updates the value of an existing variable.
addVariable(String, double, double) - Method in class org.nfunk.jep.JEP
Adds a new complex variable to the parser, or updates the value of an existing variable.
addVariable(String, Object) - Method in class org.nfunk.jep.JEP
Adds a new variable to the parser as an object, or updates the value of an existing variable.
addVariable(String, Object) - Method in class org.nfunk.jep.SymbolTable
Creates a new variable with given value.
addVetoableChangeListener(VetoableChangeListener) - Method in class org.jfree.data.general.Series
Adds a vetoable property change listener to the series.
addWeight(float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float weight = 17 [packed = true];
addWeight(long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
addWeight(long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
addX(float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float X = 13 [packed = true];
addX(double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double x = 2 [packed = true];
addX(double) - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double x = 2 [packed = true];
addX(double) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double x = 2 [packed = true];
addX(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
addX(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
addX(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 X = 5 [packed = true];
addX1(float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X1 = 8;
addX2(float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X2 = 9;
addXleft(double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xleft = 4 [packed = true];
addXOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 XOuter = 8 [packed = true];
addXright(double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xright = 5 [packed = true];
addXsysleft(double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysleft = 8 [packed = true];
addXsysright(double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysright = 9 [packed = true];
addY(float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Y = 14 [packed = true];
addY(double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double y = 3 [packed = true];
addY(double) - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double y = 3 [packed = true];
addY(double) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double y = 3 [packed = true];
addY(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
addY(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
addY(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Y = 6 [packed = true];
addYlower(double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ylower = 7 [packed = true];
addYOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 YOuter = 9 [packed = true];
addYsyslower(double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysyslower = 11 [packed = true];
addYsysupper(double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysysupper = 10 [packed = true];
addYupper(double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double yupper = 6 [packed = true];
addZ(float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Z = 15 [packed = true];
addZ(double) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double z = 4 [packed = true];
addZ(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
addZ(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
addZ(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Z = 7 [packed = true];
addZOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 ZOuter = 10 [packed = true];
adjustBaseIndex(Zmat) - Static method in class Jampack.Parameters
Adjust the base index of a Zmat to make it conform to the default.
adjustBaseIndex(Zdiagmat) - Static method in class Jampack.Parameters
Adjust the base index of a Zdiagmat to make it conform to the default.
adjustBeginLineColumn(int, int) - Method in class jplot3dp.MathParser.SimpleCharStream
Method to adjust line and column numbers for the start of a token.
adjustBeginLineColumn(int, int) - Method in class org.nfunk.jep.JavaCharStream
Method to adjust line and column numbers for the start of a token.
adjustedLog10(double) - Method in class org.jfree.chart.axis.LogarithmicAxis
Returns an adjusted log10 value for graphing purposes.
adjustedPow10(double) - Method in class org.jfree.chart.axis.LogarithmicAxis
Returns an adjusted power of 10 value for graphing purposes.
advance() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap.Iterator
Advance iterator one step further.
advance() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap.Iterator
Advance iterator one step further.
advanceTime() - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Adjust the array offset as needed when a new time-period is added: Increments the indices "oldestAt" and "newestAt", mod(array length), zeroes the series values at newestAt, returns the new TimePeriod.
afile - Static variable in class jminhep.gui.MainFrame
 
after(SegmentedTimeline.Segment) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns true if this segment is wholly after another segment.
AgeFileFilter - Class in org.apache.commons.io.filefilter
Filters files based on a cutoff time, can filter either newer files or files equal to or older.
AgeFileFilter(long) - Constructor for class org.apache.commons.io.filefilter.AgeFileFilter
Constructs a new age file filter for files equal to or older than a certain cutoff
AgeFileFilter(long, boolean) - Constructor for class org.apache.commons.io.filefilter.AgeFileFilter
Constructs a new age file filter for files on any one side of a certain cutoff.
AgeFileFilter(Date) - Constructor for class org.apache.commons.io.filefilter.AgeFileFilter
Constructs a new age file filter for files older than (at or before) a certain cutoff date.
AgeFileFilter(Date, boolean) - Constructor for class org.apache.commons.io.filefilter.AgeFileFilter
Constructs a new age file filter for files on any one side of a certain cutoff date.
AgeFileFilter(File) - Constructor for class org.apache.commons.io.filefilter.AgeFileFilter
Constructs a new age file filter for files older than (at or before) a certain File (whose last modification time will be used as reference).
AgeFileFilter(File, boolean) - Constructor for class org.apache.commons.io.filefilter.AgeFileFilter
Constructs a new age file filter for files on any one side of a certain File (whose last modification time will be used as reference).
ageFileFilter(long) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that returns true if the file was last modified before or at the specified cutoff time.
ageFileFilter(long, boolean) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that filters files based on a cutoff time.
ageFileFilter(Date) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that returns true if the file was last modified before or at the specified cutoff date.
ageFileFilter(Date, boolean) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that filters files based on a cutoff date.
ageFileFilter(File) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that returns true if the file was last modified before or at the same time as the specified reference file.
ageFileFilter(File, boolean) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that filters files based on a cutoff reference file.
aggregate(DoubleMatrix2D, BinFunction1D[], DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Applies the given aggregation functions to each column and stores the results in a the result matrix.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix1D
Applies a function to each cell and aggregates the results.
aggregate(DoubleMatrix1D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix1D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix2D
Applies a function to each cell and aggregates the results.
aggregate(DoubleMatrix2D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix2D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix3D
Applies a function to each cell and aggregates the results.
aggregate(DoubleMatrix3D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix3D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix1D
Applies a function to each cell and aggregates the results.
aggregate(ObjectMatrix1D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix1D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix2D
Applies a function to each cell and aggregates the results.
aggregate(ObjectMatrix2D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix2D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix3D
Applies a function to each cell and aggregates the results.
aggregate(ObjectMatrix3D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix3D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.hep.aida.bin.DynamicBin1D
Applies a function to each element and aggregates the results.
aggregate(Collection<? extends StatisticalSummary>) - Static method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Computes aggregate summary statistics.
AggregateSummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
An aggregator for SummaryStatistics from several data sets or data set partitions.
AggregateSummaryStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Initializes a new AggregateSummaryStatistics with default statistics implementations.
AggregateSummaryStatistics(SummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Initializes a new AggregateSummaryStatistics with the specified statistics object as a prototype for contributing statistics and for the internal aggregate statistics.
AggregateSummaryStatistics(SummaryStatistics, SummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Initializes a new AggregateSummaryStatistics with the specified statistics object as a prototype for contributing statistics and for the internal aggregate statistics.
AgrestiCoullInterval - Class in org.apache.commons.math3.stat.interval
Implements the Agresti-Coull method for creating a binomial proportion confidence interval.
AgrestiCoullInterval() - Constructor for class org.apache.commons.math3.stat.interval.AgrestiCoullInterval
 
aha(Zmat) - Static method in class Jampack.Times
Computes AHA, where A is a Zmat.
ahib(Zltmat, Zmat) - Static method in class Jampack.Solve
Solves LHX = B, where L is a Zltmat and B is a Zmat.
ahib(Zutmat, Zmat) - Static method in class Jampack.Solve
Solves UHX = B, where U is a Zutmat and B is a Zmat.
ahib(Zmat, Zmat) - Static method in class Jampack.Solve
Solve AHX = B, where A is a Zmat and B is a Zmat.
aib(Zltmat, Zmat) - Static method in class Jampack.Solve
Solves LX = B, where L is a Zltmat and B is a Zmat.
aib(Zutmat, Zmat) - Static method in class Jampack.Solve
Solves UX = B, where U is a Zutmat and B is a Zmat.
aib(Zmat, Zmat) - Static method in class Jampack.Solve
Solves AX = B, where A is a Zmat and B is a Zmat.
aib(Zpsdmat, Zmat) - Static method in class Jampack.Solve
Solves AX = B, where A is a Zpsdmat and B is a Zmat.
AkimaSplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Computes a cubic spline interpolation for the data set using the Akima algorithm, as originally formulated by Hiroshi Akima in his 1970 paper "A New Method of Interpolation and Smooth Curve Fitting Based on Local Procedures." J.
AkimaSplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.AkimaSplineInterpolator
 
AklToussaintHeuristic - Class in org.apache.commons.math3.geometry.euclidean.twod.hull
A simple heuristic to improve the performance of convex hull algorithms.
Algebra - Class in cern.colt.matrix.linalg
Linear algebraic matrix operations operating on DoubleMatrix2D; concentrates most functionality of this package.
Algebra() - Constructor for class cern.colt.matrix.linalg.Algebra
Constructs a new instance with an equality tolerance given by Property.DEFAULT.tolerance().
Algebra(double) - Constructor for class cern.colt.matrix.linalg.Algebra
Constructs a new instance with the given equality tolerance.
ALGEBRAIC - Static variable in class graph.TextLine
Format to use when parsing a double
AlgebraicExtension - Class in org.lsmp.djep.groupJep.groups
An Algebraic Extension of a Ring.
AlgebraicExtension(RingI, Polynomial) - Constructor for class org.lsmp.djep.groupJep.groups.AlgebraicExtension
Create the ring K(t) where t is a solution of the monic polynomial p.
AlgebraicExtensionElement - Class in org.lsmp.djep.groupJep.values
An element of the algrabraic extension K(t).
AlgebraicExtensionElement(AlgebraicExtension, Number[]) - Constructor for class org.lsmp.djep.groupJep.values.AlgebraicExtensionElement
An element of the algebraic extension K(t).
ALIGN_BOTTOM - Static variable in class org.jlab.groot.ui.LatexText
 
ALIGN_CENTER - Static variable in class org.jlab.groot.ui.LatexText
 
ALIGN_LEFT - Static variable in class org.jlab.groot.ui.LatexText
 
ALIGN_RIGTH - Static variable in class org.jlab.groot.ui.LatexText
 
ALIGN_TOP - Static variable in class org.jlab.groot.ui.LatexText
 
ALL - Static variable in class hep.lcio.util.ObjectComparator
 
allDerivatives() - Method in class org.lsmp.djep.djep.DVariable
Enumerate all the derivatives of this variable.
allEntries() - Method in class cern.hep.aida.ref.Histogram1D
 
allEntries() - Method in class cern.hep.aida.ref.Histogram2D
 
allEntries() - Method in class cern.hep.aida.ref.Histogram3D
 
allEntries() - Method in interface colt.hep.aida.IHistogram
Number of all entries in all (both in-range and under/overflow) bins in the histogram.
allEntries() - Method in class jhplot.H1D
Get number of all entries
allEntries() - Method in class jhplot.H2D
Get number of all entries
allEntries() - Method in class jhplot.HProf1D
Get number of all entries
allEntries() - Method in class jhplot.HProf2D
Get number of all entries
ALLENTRIES_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
ALLENTRIES_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
allocate(int) - Method in class jplot.DataArray
Allocation of memory for the data points.
allocateBlas(int, Blas) - Static method in class cern.colt.matrix.linalg.SmpBlas
Sets the public global variable SmpBlas.smpBlas to a blas using a maximum of maxThreads threads, each executing the given sequential algorithm; maxThreads is normally the number of CPUs.
ALLOWED_OPERATOR_CHARS - Static variable in class jhplot.math.exp4j.operator.Operator
The set of allowed operator chars
AllowedSolution - Enum in org.apache.commons.math3.analysis.solvers
The kinds of solutions that a (bracketed univariate real) root-finding algorithm may accept as solutions.
AllTests - Class in org.lsmp.djepJUnit
 
AllTests() - Constructor for class org.lsmp.djepJUnit.AllTests
 
AllTests - Class in org.nfunk.jeptesting
 
AllTests() - Constructor for class org.nfunk.jeptesting.AllTests
 
allUpdate() - Method in class jplot.DataArray
update all min and max.
ALPHA_QCD_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
ALPHA_QCD_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
ALPHA_QED_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
ALPHA_QED_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
alpha_rcl2 - Static variable in class cern.clhep.PhysicalConstants
 
ALPHAQCD_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
ALPHAQED_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
AlternativeHypothesis - Enum in org.apache.commons.math3.stat.inference
Represents an alternative hypothesis for a hypothesis test.
ampere - Static variable in class cern.clhep.Units
 
amu - Static variable in class cern.clhep.PhysicalConstants
 
amu_c2 - Static variable in class cern.clhep.PhysicalConstants
 
analF() - Method in class jhplot.HPlot
Return IAnalysisFactory associated with the plot
Analyse - Class in jminhep.clcontrol
 
Analyse() - Constructor for class jminhep.clcontrol.Analyse
 
analyseSet() - Method in class jminhep.cluster.DataHolder
Analyse the data holder by calculating min and max.
AnalysisJob - Class in hep.lcio.example
 
AnalysisJob() - Constructor for class hep.lcio.example.AnalysisJob
 
AnchorHandlerFX - Class in org.jfree.chart.fx.interaction
Handles mouse clicks on the ChartCanvas by updating the anchor and redrawing the chart.
AnchorHandlerFX(String) - Constructor for class org.jfree.chart.fx.interaction.AnchorHandlerFX
Creates a new instance.
and(BitMatrix) - Method in class cern.colt.bitvector.BitMatrix
Performs a logical AND of the receiver with another bit matrix.
and(BitVector) - Method in class cern.colt.bitvector.BitVector
Performs a logical AND of the receiver with another bit vector (A = A & B).
and - Static variable in class cern.jet.math.IntFunctions
Function that returns a & b.
and(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a & b.
and(IOFileFilter...) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that ANDs the specified filters.
AND - Static variable in class org.lsmp.djep.rpe.RpEval
 
AND - Static variable in class org.nfunk.jep.function.Logical
 
AND - Static variable in interface org.nfunk.jep.ParserConstants
 
AndExpression() - Method in class org.nfunk.jep.Parser
 
AndFileFilter - Class in org.apache.commons.io.filefilter
A FileFilter providing conditional AND logic across a list of file filters.
AndFileFilter() - Constructor for class org.apache.commons.io.filefilter.AndFileFilter
Constructs a new instance of AndFileFilter.
AndFileFilter(List<IOFileFilter>) - Constructor for class org.apache.commons.io.filefilter.AndFileFilter
Constructs a new instance of AndFileFilter with the specified list of filters.
AndFileFilter(IOFileFilter, IOFileFilter) - Constructor for class org.apache.commons.io.filefilter.AndFileFilter
Constructs a new file filter that ANDs the result of two other filters.
andFileFilter(IOFileFilter, IOFileFilter) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
andNot(BitMatrix) - Method in class cern.colt.bitvector.BitMatrix
Clears all of the bits in receiver whose corresponding bit is set in the other bit matrix.
andNot(BitVector) - Method in class cern.colt.bitvector.BitVector
Clears all of the bits in receiver whose corresponding bit is set in the other bitvector (A = A \ B).
andThen(IOConsumer<? super T>) - Method in interface org.apache.commons.io.function.IOConsumer
Returns a composed IoConsumer that performs, in sequence, this operation followed by the after operation.
andThen(IOFunction<? super R, ? extends V>) - Method in interface org.apache.commons.io.function.IOFunction
Returns a composed IOFunction that first applies this function to its input, and then applies the after function to the result.
andThen(Function<? super R, ? extends V>) - Method in interface org.apache.commons.io.function.IOFunction
Returns a composed IOFunction that first applies this function to its input, and then applies the after function to the result.
andThen(IOConsumer<? super R>) - Method in interface org.apache.commons.io.function.IOFunction
Returns a composed IOFunction that first applies this function to its input, and then applies the after consumer to the result.
andThen(Consumer<? super R>) - Method in interface org.apache.commons.io.function.IOFunction
Returns a composed IOFunction that first applies this function to its input, and then applies the after consumer to the result.
angle(LParticle) - Method in class hephysics.particle.LParticle
Angle between 2 vectors in rad
angle(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Angle between 2 vectors
angle(HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Angle between 2 vectors
angle(LorentzVector) - Method in class j4np.physics.LorentzVector
 
angle(Vector3) - Method in class j4np.physics.Vector3
 
angle(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the angular separation between two vectors.
angle(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the angular separation between two vectors.
angle(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the angular separation between two vectors.
angle(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the angular separation between two vectors.
angle(Vector2D, Vector2D) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the angular separation between two vectors.
angleToValue(double) - Method in interface org.jfree.chart.plot.dial.DialScale
Converts an angle (in degrees) to a data value.
angleToValue(double) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Converts the given angle to a data value, based on this scale.
angstrom - Static variable in class cern.clhep.Units
 
Annotation - Interface in org.jfree.chart.annotations
The base interface for annotations.
annotationChanged(AnnotationChangeEvent) - Method in interface org.jfree.chart.event.AnnotationChangeListener
Receives notification of an annotation change event.
annotationChanged(AnnotationChangeEvent) - Method in class org.jfree.chart.plot.CategoryPlot
Receives notification of a change to an Annotation added to this plot.
annotationChanged(AnnotationChangeEvent) - Method in class org.jfree.chart.plot.Plot
Receives notification of a change to an Annotation added to this plot.
annotationChanged(AnnotationChangeEvent) - Method in class org.jfree.chart.plot.XYPlot
Receives notification of a change to an Annotation added to this plot.
annotationChanged(AnnotationChangeEvent) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Receives notification of a change to an Annotation added to this renderer.
AnnotationChangeEvent - Class in org.jfree.chart.event
An event that can be forwarded to any AnnotationChangeListener to signal a change to an Annotation.
AnnotationChangeEvent(Object, Annotation) - Constructor for class org.jfree.chart.event.AnnotationChangeEvent
Creates a new AnnotationChangeEvent instance.
AnnotationChangeListener - Interface in org.jfree.chart.event
The interface that must be supported by classes that wish to receive notification of changes to an Annotation.
Anova - Class in jhplot.stat
Class for performing simple 1-way ANOVA.
Anova(double[][]) - Constructor for class jhplot.stat.Anova
Creates a new Anova instance.
anovaFValue(Collection<double[]>) - Method in class org.apache.commons.math3.stat.inference.OneWayAnova
Computes the ANOVA F-value for a collection of double[] arrays.
anovaPValue(Collection<double[]>) - Method in class org.apache.commons.math3.stat.inference.OneWayAnova
Computes the ANOVA P-value for a collection of double[] arrays.
anovaPValue(Collection<SummaryStatistics>, boolean) - Method in class org.apache.commons.math3.stat.inference.OneWayAnova
Computes the ANOVA P-value for a collection of SummaryStatistics.
anovaTest(Collection<double[]>, double) - Method in class org.apache.commons.math3.stat.inference.OneWayAnova
Performs an ANOVA test, evaluating the null hypothesis that there is no difference among the means of the data categories.
AnyConstant() - Method in class org.nfunk.jep.Parser
 
AnyMatrix - Interface in org.apache.commons.math3.linear
Interface defining very basic matrix operations.
ap(Zmat, Rot, int, int, int, int) - Static method in class Jampack.Rot
Multiplies columns (ii1:ii2,jj1) and A(ii2:ii2,jj1) of a Zmat (altered) by a plane rotation.
aph(Zmat, Rot, int, int, int, int) - Static method in class Jampack.Rot
Multiplies columns (ii1:ii2,jj1) and A(ii2:ii2,jj1) of a Zmat (altered) by the conjugate transpose of plane rotation.
append(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleFactory1D
C = A||B; Constructs a new matrix which is the concatenation of two other matrices.
append(ObjectMatrix1D, ObjectMatrix1D) - Method in class cern.colt.matrix.ObjectFactory1D
C = A||B; Constructs a new matrix which is the concatenation of two other matrices.
append(double[], int) - Method in class graph.DataSet
Append data to the data set.
append(File, String) - Static method in class jhplot.math.io.ASCIIFile
 
append(char) - Method in class org.apache.commons.io.output.AppendableWriter
Appends the specified character to the underlying appendable.
append(CharSequence) - Method in class org.apache.commons.io.output.AppendableWriter
Appends the specified character sequence to the underlying appendable.
append(CharSequence, int, int) - Method in class org.apache.commons.io.output.AppendableWriter
Appends a subsequence of the specified character sequence to the underlying appendable.
append(char) - Method in class org.apache.commons.io.output.FilterCollectionWriter
 
append(CharSequence) - Method in class org.apache.commons.io.output.FilterCollectionWriter
 
append(CharSequence, int, int) - Method in class org.apache.commons.io.output.FilterCollectionWriter
 
append(char) - Method in class org.apache.commons.io.output.NullAppendable
 
append(CharSequence) - Method in class org.apache.commons.io.output.NullAppendable
 
append(CharSequence, int, int) - Method in class org.apache.commons.io.output.NullAppendable
 
append(char) - Method in class org.apache.commons.io.output.NullWriter
Does nothing - output to /dev/null.
append(CharSequence, int, int) - Method in class org.apache.commons.io.output.NullWriter
Does nothing - output to /dev/null.
append(CharSequence) - Method in class org.apache.commons.io.output.NullWriter
Does nothing - output to /dev/null.
append(char) - Method in class org.apache.commons.io.output.ProxyCollectionWriter
Invokes the delegates' append(char) methods.
append(CharSequence) - Method in class org.apache.commons.io.output.ProxyCollectionWriter
Invokes the delegates' append(CharSequence) methods.
append(CharSequence, int, int) - Method in class org.apache.commons.io.output.ProxyCollectionWriter
Invokes the delegates' append(CharSequence, int, int) methods.
append(char) - Method in class org.apache.commons.io.output.ProxyWriter
Invokes the delegate's append(char) method.
append(CharSequence, int, int) - Method in class org.apache.commons.io.output.ProxyWriter
Invokes the delegate's append(CharSequence, int, int) method.
append(CharSequence) - Method in class org.apache.commons.io.output.ProxyWriter
Invokes the delegate's append(CharSequence) method.
append(char) - Method in class org.apache.commons.io.output.StringBuilderWriter
Appends a single character to this Writer.
append(CharSequence) - Method in class org.apache.commons.io.output.StringBuilderWriter
Appends a character sequence to this Writer.
append(CharSequence, int, int) - Method in class org.apache.commons.io.output.StringBuilderWriter
Appends a portion of a character sequence to the StringBuilder.
append(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending a vector to this vector.
append(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending a vector to this vector.
append(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending a T to this vector.
append(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Construct a new vector by appending a vector to this vector.
append(ArrayRealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending a vector to this vector.
append(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Construct a new vector by appending a double to this vector.
append(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Construct a vector by appending a vector to this vector.
append(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Construct a vector by appending a T to this vector.
append(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Optimized method to append a OpenMapRealVector.
append(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Construct a new vector by appending a vector to this vector.
append(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Construct a new vector by appending a double to this vector.
append(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Construct a new vector by appending a vector to this vector.
append(double) - Method in class org.apache.commons.math3.linear.RealVector
Construct a new vector by appending a double to this vector.
append(SparseFieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Construct a vector by appending a vector to this vector.
append(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Construct a vector by appending a vector to this vector.
append(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Construct a vector by appending a T to this vector.
append(ContinuousOutputFieldModel<T>) - Method in class org.apache.commons.math3.ode.ContinuousOutputFieldModel
Append another model at the end of the instance.
append(ContinuousOutputModel) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Append another model at the end of the instance.
append(StorelessCovariance) - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
Appends sc to this, effectively aggregating the computations in sc with this.
append(SimpleRegression) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Appends data from another regression calculation to this one.
append(Node, PrintVisitor) - Method in class org.lsmp.djep.matrixJep.function.MArrayAccess
 
append(Node, PrintVisitor) - Method in class org.lsmp.djep.matrixJep.function.MList
Used to print the TensorNode with all its children.
append(String) - Method in class org.lsmp.djep.xjep.PrintVisitor
Add a string to buffer.
append(Node, PrintVisitor) - Method in interface org.lsmp.djep.xjep.PrintVisitor.PrintRulesI
The method called to append data for the rule.
AppendableOutputStream<T extends Appendable> - Class in org.apache.commons.io.output
OutputStream implementation that writes the data to an Appendable Object.
AppendableOutputStream(T) - Constructor for class org.apache.commons.io.output.AppendableOutputStream
Construct a new instance with the specified appendable.
AppendableWriter<T extends Appendable> - Class in org.apache.commons.io.output
Writer implementation that writes the data to an Appendable Object.
AppendableWriter(T) - Constructor for class org.apache.commons.io.output.AppendableWriter
Constructs a new instance with the specified appendable.
appendColumns(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
C = A||B; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumns(ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
C = A||B; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendData(float[]) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Appends new data.
appendData(float[], int, int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Appends data at specified index, for loading up with data from file(s).
appendDoubleArray(File, double[], String) - Static method in class jhplot.math.io.BinaryFile
 
appendDoubleArray(OutputStream, double[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
appendFloatArray(File, float[], String) - Static method in class jhplot.math.io.BinaryFile
 
appendFloatArray(OutputStream, float[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
appendIntArray(File, int[], String) - Static method in class jhplot.math.io.BinaryFile
 
appendIntArray(OutputStream, int[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
appendRows(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
C = A||B; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRows(ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
C = A||B; Constructs a new matrix which is the row-wise concatenation of two other matrices.
apply(boolean) - Method in interface cern.colt.function.BooleanProcedure
Applies a procedure to an argument.
apply(byte) - Method in interface cern.colt.function.ByteProcedure
Applies a procedure to an argument.
apply(char) - Method in interface cern.colt.function.CharProcedure
Applies a procedure to an argument.
apply(double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double) - Method in interface cern.colt.function.Double27Function
Applies a function to 27 arguments.
apply(double, double, double, double, double) - Method in interface cern.colt.function.Double5Function
Applies a function to two arguments.
apply(double, double, double, double, double, double, double, double, double) - Method in interface cern.colt.function.Double9Function
Applies a function to nine arguments.
apply(double, double) - Method in interface cern.colt.function.DoubleDoubleFunction
Applies a function to two arguments.
apply(double, double) - Method in interface cern.colt.function.DoubleDoubleProcedure
Applies a procedure to two arguments.
apply(double) - Method in interface cern.colt.function.DoubleFunction
Applies a function to an argument.
apply(double, int) - Method in interface cern.colt.function.DoubleIntProcedure
Applies a procedure to two arguments.
apply(double) - Method in interface cern.colt.function.DoubleProcedure
Applies a procedure to an argument.
apply(float) - Method in interface cern.colt.function.FloatProcedure
Applies a procedure to an argument.
apply(int, double) - Method in interface cern.colt.function.IntDoubleFunction
Applies a function to two arguments.
apply(int, double) - Method in interface cern.colt.function.IntDoubleProcedure
Applies a procedure to two arguments.
apply(int) - Method in interface cern.colt.function.IntFunction
Applies a function to an argument.
apply(int, int, double) - Method in interface cern.colt.function.IntIntDoubleFunction
Applies a function to three arguments.
apply(int, int, double) - Method in interface cern.colt.function.IntIntDoubleProcedure
Applies a procedure to two arguments.
apply(int, int) - Method in interface cern.colt.function.IntIntFunction
Applies a function to two arguments.
apply(int, int, int) - Method in interface cern.colt.function.IntIntIntProcedure
Applies a procedure to three arguments.
apply(int, int) - Method in interface cern.colt.function.IntIntProcedure
Applies a procedure to two arguments.
apply(int, Object) - Method in interface cern.colt.function.IntObjectProcedure
Applies a procedure to two arguments.
apply(int) - Method in interface cern.colt.function.IntProcedure
Applies a procedure to an argument.
apply(long, Object) - Method in interface cern.colt.function.LongObjectProcedure
Applies a procedure to two arguments.
apply(long) - Method in interface cern.colt.function.LongProcedure
Applies a procedure to an argument.
apply(Object) - Method in interface cern.colt.function.ObjectFunction
Applies a function to an argument.
apply(Object, Object) - Method in interface cern.colt.function.ObjectObjectFunction
Applies a function to two arguments.
apply(Object) - Method in interface cern.colt.function.ObjectProcedure
Applies a procedure to an argument.
apply(short) - Method in interface cern.colt.function.ShortProcedure
Applies a procedure to an argument.
apply(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.doublealgo.Statistic.VectorVectorFunction
Applies a function to two argument vectors.
apply(DoubleMatrix1D) - Method in interface cern.colt.matrix.DoubleMatrix1DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix2D) - Method in interface cern.colt.matrix.DoubleMatrix2DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix3D) - Method in interface cern.colt.matrix.DoubleMatrix3DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Matrix2DMatrix2DFunction
Applies a function to two arguments.
apply(ObjectMatrix1D) - Method in interface cern.colt.matrix.ObjectMatrix1DProcedure
Applies a procedure to an argument.
apply(ObjectMatrix2D) - Method in interface cern.colt.matrix.ObjectMatrix2DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix3D) - Method in interface cern.colt.matrix.ObjectMatrix3DProcedure
Applies a procedure to an argument.
apply(ObjectMatrix3D) - Method in interface cern.colt.matrix.ObjectMatrix3DProcedure
Applies a procedure to an argument.
apply(DynamicBin1D, DynamicBin1D) - Method in interface cern.hep.aida.bin.BinBinFunction1D
Applies a function to two bin arguments.
apply(DynamicBin1D) - Method in interface cern.hep.aida.bin.BinFunction1D
Applies a function to one bin argument.
apply(double) - Method in class cern.jet.math.Mult
Returns the result of the function evaluation.
apply(double, double) - Method in class cern.jet.math.PlusMult
Returns the result of the function evaluation.
apply(double) - Method in class cern.jet.random.AbstractDistribution
Equivalent to nextDouble().
apply(int) - Method in class cern.jet.random.AbstractDistribution
Equivalent to nextInt().
apply(double) - Method in class cern.jet.random.engine.RandomEngine
Equivalent to raw().
apply(int) - Method in class cern.jet.random.engine.RandomEngine
Equivalent to nextInt().
apply(double...) - Method in class jhplot.math.exp4j.function.Function
Method that does the actual calculation of the function value given the arguments
apply(double...) - Method in class jhplot.math.exp4j.operator.Operator
Apply the operation on the given operands
apply(T) - Method in interface org.apache.commons.io.function.IOFunction
Applies this function to the given argument.
apply(Point<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Transform
Transform a point of a space.
apply(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Transform
Transform an hyperplane of a space.
apply(SubHyperplane<T>, Hyperplane<S>, Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Transform
Transform a sub-hyperplane embedded in an hyperplane.
apply(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Apply the given statistic to the data associated with this set of statistics.
apply(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Apply the given statistic to the data associated with this set of statistics.
apply(JFreeChart) - Method in interface org.jfree.chart.ChartTheme
Applies this theme to the supplied chart.
apply(JFreeChart) - Method in class org.jfree.chart.StandardChartTheme
Applies this theme to the supplied chart.
apply(ASTFunNode, Node[]) - Method in class org.lsmp.djep.rewrite.CollectPowers
 
apply(ASTFunNode, Node[]) - Method in class org.lsmp.djep.rewrite.ExpandBrackets
 
apply(ASTFunNode, Node[]) - Method in class org.lsmp.djep.rewrite.ExpandPower
 
apply(ASTFunNode, Node[]) - Method in interface org.lsmp.djep.rewrite.RewriteRuleI
Rewrites the node
applyCurrentTheme(JFreeChart) - Static method in class org.jfree.chart.ChartUtilities
Applies the current theme to the specified chart.
applyInverseTo(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the rotation to a vector.
applyInverseTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the rotation to a vector.
applyInverseTo(T[], T[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the rotation to a vector stored in an array.
applyInverseTo(double[], T[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the rotation to a vector stored in an array.
applyInverseTo(Rotation, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of a rotation to a vector.
applyInverseTo(FieldRotation<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the instance to another rotation.
applyInverseTo(Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the instance to another rotation.
applyInverseTo(Rotation, FieldRotation<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of a rotation to another rotation.
applyInverseTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the inverse of the rotation to a vector.
applyInverseTo(double[], double[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the inverse of the rotation to a vector stored in an array.
applyInverseTo(Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the inverse of the instance to another rotation.
applyTo(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the rotation to a vector.
applyTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the rotation to a vector.
applyTo(T[], T[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the rotation to a vector stored in an array.
applyTo(double[], T[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the rotation to a vector stored in an array.
applyTo(Rotation, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply a rotation to a vector.
applyTo(FieldRotation<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the instance to another rotation.
applyTo(Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the instance to another rotation.
applyTo(Rotation, FieldRotation<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply a rotation to another rotation.
applyTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the rotation to a vector.
applyTo(double[], double[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the rotation to a vector stored in an array.
applyTo(Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the instance to another rotation.
applyTransform(Transform<S, T>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Transform a region.
applyTransform(Transform<S, T>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Apply a transform to the instance.
AppName - Static variable in class jplot.JPlot
 
approximateP(double, int, int) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Uses the Kolmogorov-Smirnov distribution to approximate \(P(D_{n,m} > d)\) where \(D_{n,m}\) is the 2-sample Kolmogorov-Smirnov statistic.
approximateP(double, int, int) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
Arc - Class in org.apache.commons.math3.geometry.spherical.oned
This class represents an arc on a circle.
Arc(double, double, double) - Constructor for class org.apache.commons.math3.geometry.spherical.oned.Arc
Simple constructor.
ARCCOS - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ARCCOSEC - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ARCCOSECH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ARCCOSH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ArcCosine - Class in org.nfunk.jep.function
The acos function.
ArcCosine() - Constructor for class org.nfunk.jep.function.ArcCosine
 
ArcCosineH - Class in org.nfunk.jep.function
Implements the arcCosH function.
ArcCosineH() - Constructor for class org.nfunk.jep.function.ArcCosineH
 
ARCCOT - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ARCCOTH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ArcDialFrame - Class in org.jfree.chart.plot.dial
A standard frame for the DialPlot class.
ArcDialFrame() - Constructor for class org.jfree.chart.plot.dial.ArcDialFrame
Creates a new instance of ArcDialFrame that spans 180 degrees.
ArcDialFrame(double, double) - Constructor for class org.jfree.chart.plot.dial.ArcDialFrame
Creates a new instance of ArcDialFrame that spans the arc specified.
ARCSEC - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ARCSECH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ARCSIN - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ArcSine - Class in org.nfunk.jep.function
 
ArcSine() - Constructor for class org.nfunk.jep.function.ArcSine
 
ArcSineH - Class in org.nfunk.jep.function
Implements the arcSinH function.
ArcSineH() - Constructor for class org.nfunk.jep.function.ArcSineH
 
ARCSINH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ArcsSet - Class in org.apache.commons.math3.geometry.spherical.oned
This class represents a region of a circle: a set of arcs.
ArcsSet(double) - Constructor for class org.apache.commons.math3.geometry.spherical.oned.ArcsSet
Build an arcs set representing the whole circle.
ArcsSet(double, double, double) - Constructor for class org.apache.commons.math3.geometry.spherical.oned.ArcsSet
Build an arcs set corresponding to a single arc.
ArcsSet(BSPTree<Sphere1D>, double) - Constructor for class org.apache.commons.math3.geometry.spherical.oned.ArcsSet
Build an arcs set from an inside/outside BSP tree.
ArcsSet(Collection<SubHyperplane<Sphere1D>>, double) - Constructor for class org.apache.commons.math3.geometry.spherical.oned.ArcsSet
Build an arcs set from a Boundary REPresentation (B-rep).
ArcsSet.InconsistentStateAt2PiWrapping - Exception in org.apache.commons.math3.geometry.spherical.oned
Specialized exception for inconsistent BSP tree state inconsistency.
ArcsSet.Split - Class in org.apache.commons.math3.geometry.spherical.oned
Class holding the results of the split method.
ARCTAN - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ArcTangent - Class in org.nfunk.jep.function
 
ArcTangent() - Constructor for class org.nfunk.jep.function.ArcTangent
 
ArcTangent2 - Class in org.nfunk.jep.function
atan2(y, x) Returns the angle whose tangent is y/x.
ArcTangent2() - Constructor for class org.nfunk.jep.function.ArcTangent2
 
ARCTANH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ArcTanH - Class in org.nfunk.jep.function
Implements the arcTanH function.
ArcTanH() - Constructor for class org.nfunk.jep.function.ArcTanH
 
AREA - Static variable in class org.jfree.chart.renderer.xy.XYAreaRenderer
Useful constant for specifying the type of rendering (area only).
AREA - Static variable in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Useful constant for specifying the type of rendering (area only).
AREA_AND_SHAPES - Static variable in class org.jfree.chart.renderer.xy.XYAreaRenderer
Useful constant for specifying the type of rendering (area and shapes).
AREA_AND_SHAPES - Static variable in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Useful constant for specifying the type of rendering (area and shapes).
AreaRenderer - Class in org.jfree.chart.renderer.category
A category item renderer that draws area charts.
AreaRenderer() - Constructor for class org.jfree.chart.renderer.category.AreaRenderer
Creates a new renderer.
AreaRendererEndType - Class in org.jfree.chart.renderer
An enumeration of the 'end types' for an area renderer.
arg() - Method in class jhplot.math.Complex
Argument of this Complex number (the angle in radians with the x-axis in polar coordinates).
Arg - Class in org.nfunk.jep.function
Argument of a complex number
Arg() - Constructor for class org.nfunk.jep.function.Arg
 
arg(Object) - Method in class org.nfunk.jep.function.Arg
 
arg() - Method in class org.nfunk.jep.type.Complex
Returns the argument of this complex number (Math.atan2(re,im))
ArgumentList(int, String) - Method in class org.nfunk.jep.Parser
 
ArgumentParser - Class in org.jlab.groot.io
 
ArgumentParser() - Constructor for class org.jlab.groot.io.ArgumentParser
 
ArgumentParser.ArgumentParserCommand - Class in org.jlab.groot.io
This class holds all parameters required, optional and flags for given command in the command line;
ArgumentParser.ArgumentParserItem - Class in org.jlab.groot.io
internal class implementing items to be stored in the parser.
ArgumentParserCommand() - Constructor for class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
ArgumentParserCommand(String) - Constructor for class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
ArgumentParserItem(String) - Constructor for class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
ArgumentParserItem(String, String) - Constructor for class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
ArgUtils - Class in org.apache.commons.math3.exception.util
Utility class for transforming the list of arguments passed to constructors of exceptions.
Arithmetic - Class in cern.jet.math
Arithmetic functions.
ArithmeticUtils - Class in org.apache.commons.math3.util
Some useful, arithmetics related, additions to the built-in functions in Math.
arrange(Graphics2D) - Method in class org.jfree.chart.block.AbstractBlock
Arranges the contents of the block, with no constraints, and returns the block size.
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.block.AbstractBlock
Arranges the contents of the block, within the given constraints, and returns the block size.
arrange(BlockContainer, Graphics2D, RectangleConstraint) - Method in interface org.jfree.chart.block.Arrangement
Arranges the blocks within the specified container, subject to the given constraint.
arrange(Graphics2D) - Method in interface org.jfree.chart.block.Block
Arranges the contents of the block, with no constraints, and returns the block size.
arrange(Graphics2D, RectangleConstraint) - Method in interface org.jfree.chart.block.Block
Arranges the contents of the block, within the given constraints, and returns the block size.
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.block.BlockContainer
Arranges the contents of the block, within the given constraints, and returns the block size.
arrange(BlockContainer, Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.block.BorderArrangement
Arranges the items in the specified container, subject to the given constraint.
arrange(BlockContainer, Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.block.CenterArrangement
Calculates and sets the bounds of all the items in the specified container, subject to the given constraint.
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.block.ColorBlock
Arranges the contents of the block, within the given constraints, and returns the block size.
arrange(BlockContainer, Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.block.ColumnArrangement
Calculates and sets the bounds of all the items in the specified container, subject to the given constraint.
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.block.EmptyBlock
Arranges the contents of the block, within the given constraints, and returns the block size.
arrange(BlockContainer, Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.block.FlowArrangement
Calculates and sets the bounds of all the items in the specified container, subject to the given constraint.
arrange(BlockContainer, Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.block.GridArrangement
Arranges the blocks within the specified container, subject to the given constraint.
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.block.LabelBlock
Arranges the contents of the block, within the given constraints, and returns the block size.
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.title.CompositeTitle
Arranges the contents of the block, within the given constraints, and returns the block size.
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.title.ImageTitle
Arranges the contents of the block, within the given constraints, and returns the block size.
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.title.LegendGraphic
Arranges the contents of the block, within the given constraints, and returns the block size.
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.title.LegendTitle
Arranges the contents of the block, within the given constraints, and returns the block size.
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.title.PaintScaleLegend
Arranges the contents of the block, within the given constraints, and returns the block size.
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.title.ShortTextTitle
Performs a layout for this title, subject to the supplied constraint, and returns the dimensions required for the title (if the title cannot be displayed in the available space, this method will return zero width and height for the dimensions).
arrange(Graphics2D, RectangleConstraint) - Method in class org.jfree.chart.title.TextTitle
Arranges the contents of the block, within the given constraints, and returns the block size.
Arrangement - Interface in org.jfree.chart.block
An object that is responsible for arranging a collection of Blocks within a BlockContainer.
Array2DRowFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Implementation of FieldMatrix using a FieldElement[][] array to store entries.
Array2DRowFieldMatrix(Field<T>) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Creates a matrix with no data
Array2DRowFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new FieldMatrix<T> with the supplied row and column dimensions.
Array2DRowFieldMatrix(T[][]) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new FieldMatrix<T> using the input array as the underlying data array.
Array2DRowFieldMatrix(Field<T>, T[][]) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new FieldMatrix<T> using the input array as the underlying data array.
Array2DRowFieldMatrix(T[][], boolean) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new FieldMatrix<T> using the input array as the underlying data array.
Array2DRowFieldMatrix(Field<T>, T[][], boolean) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new FieldMatrix<T> using the input array as the underlying data array.
Array2DRowFieldMatrix(T[]) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new (column) FieldMatrix<T> using v as the data for the unique column of the created matrix.
Array2DRowFieldMatrix(Field<T>, T[]) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new (column) FieldMatrix<T> using v as the data for the unique column of the created matrix.
Array2DRowRealMatrix - Class in org.apache.commons.math3.linear
Implementation of RealMatrix using a double[][] array to store entries.
Array2DRowRealMatrix() - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
Creates a matrix with no data
Array2DRowRealMatrix(int, int) - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
Create a new RealMatrix with the supplied row and column dimensions.
Array2DRowRealMatrix(double[][]) - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
Create a new RealMatrix using the input array as the underlying data array.
Array2DRowRealMatrix(double[][], boolean) - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
Create a new RealMatrix using the input array as the underlying data array.
Array2DRowRealMatrix(double[]) - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
Create a new (column) RealMatrix using v as the data for the unique column of the created matrix.
ArrayAccess - Class in org.lsmp.djep.vectorJep.function
A postfix MathCommand which facilitates the getting and setting of vector and matrix elements.
ArrayAccess() - Constructor for class org.lsmp.djep.vectorJep.function.ArrayAccess
 
ArrayAccess() - Method in class org.nfunk.jep.Parser
 
ArrayFieldVector<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
This class implements the FieldVector interface with a FieldElement array.
ArrayFieldVector(Field<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Build a 0-length vector.
ArrayFieldVector(Field<T>, int) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector of zeroes.
ArrayFieldVector(int, T) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector with preset values.
ArrayFieldVector(T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from an array, copying the input array.
ArrayFieldVector(Field<T>, T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from an array, copying the input array.
ArrayFieldVector(T[], boolean) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Create a new ArrayFieldVector using the input array as the underlying data array.
ArrayFieldVector(Field<T>, T[], boolean) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Create a new ArrayFieldVector using the input array as the underlying data array.
ArrayFieldVector(T[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from part of a array.
ArrayFieldVector(Field<T>, T[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from part of a array.
ArrayFieldVector(FieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from another vector, using a deep copy.
ArrayFieldVector(ArrayFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from another vector, using a deep copy.
ArrayFieldVector(ArrayFieldVector<T>, boolean) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from another vector.
ArrayFieldVector(ArrayFieldVector<T>, ArrayFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
ArrayFieldVector(FieldVector<T>, FieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(ArrayFieldVector<T>, T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
ArrayFieldVector(FieldVector<T>, T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(T[], ArrayFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
ArrayFieldVector(T[], FieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(T[], T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(Field<T>, T[], T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
arrayLeftDivide(Matrix) - Method in class Jama.Matrix
Element-by-element left division, C = A.\B
arrayLeftDivide(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Element-by-element left division, C = A.\B
arrayLeftDivideEquals(Matrix) - Method in class Jama.Matrix
Element-by-element left division in place, A = A.\B
arrayLeftDivideEquals(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Element-by-element left division in place, A = A.\B
ArrayMathUtils - Class in jhplot.math
Arrays are faster than object, so this class is here to take full advantage of arrays without encapsulation.
ArrayOps - Class in jminhep.utils
 
ArrayOps() - Constructor for class jminhep.utils.ArrayOps
 
ArrayReaderWriter - Class in jhplot.io
Class for reading binary data from files to multidimensional arrays and writing binary data to files from multidimensional arrays.
ArrayReaderWriter() - Constructor for class jhplot.io.ArrayReaderWriter
 
ArrayRealVector - Class in org.apache.commons.math3.linear
This class implements the RealVector interface with a double array.
ArrayRealVector() - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Build a 0-length vector.
ArrayRealVector(int) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector of zeroes.
ArrayRealVector(int, double) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector with preset values.
ArrayRealVector(double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from an array, copying the input array.
ArrayRealVector(double[], boolean) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Create a new ArrayRealVector using the input array as the underlying data array.
ArrayRealVector(double[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from part of a array.
ArrayRealVector(Double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from an array.
ArrayRealVector(Double[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from part of an array.
ArrayRealVector(RealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from another vector, using a deep copy.
ArrayRealVector(ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from another vector, using a deep copy.
ArrayRealVector(ArrayRealVector, boolean) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from another vector.
ArrayRealVector(ArrayRealVector, ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(ArrayRealVector, RealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(RealVector, ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(ArrayRealVector, double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(double[], ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(double[], double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
arrayRightDivide(Matrix) - Method in class Jama.Matrix
Element-by-element right division, C = A./B
arrayRightDivide(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Element-by-element right division, C = A./B
arrayRightDivideEquals(Matrix) - Method in class Jama.Matrix
Element-by-element right division in place, A = A./B
arrayRightDivideEquals(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Element-by-element right division in place, A = A./B
Arrays - Class in cern.colt
Array manipulations; complements java.util.Arrays.
ArrayString - Class in jhplot.math.io
BSD License
ArrayString() - Constructor for class jhplot.math.io.ArrayString
 
arrayTimes(Matrix) - Method in class Jama.Matrix
Element-by-element multiplication, C = A.*B
arrayTimes(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Element-by-element multiplication, C = A.*B
arrayTimesEquals(Matrix) - Method in class Jama.Matrix
Element-by-element multiplication in place, A = A.*B
arrayTimesEquals(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Element-by-element multiplication in place, A = A.*B
Arrow - Class in jhplot.shapes
Build an arrow.
Arrow(double, double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.Arrow
Build an arrow
Arrow(double, double, double, double) - Constructor for class jhplot.shapes.Arrow
Build an arrow in
ARROW - Static variable in class jhplot.shapes.HShape
 
arrowCoords(int, int, int, int, int, int) - Method in class jplot.GraphGeneral
 
ArrowNeedle - Class in org.jfree.chart.needle
A needle in the shape of an arrow.
ArrowNeedle(boolean) - Constructor for class org.jfree.chart.needle.ArrowNeedle
Constructs a new arrow needle.
as - Variable in class jplot3dp.ModelView
 
as3Vector(Matrix) - Static method in class hep.physics.matrix.MatrixOp
Convenience method to turn a 3 row column matrix into a vector.
asByte(int) - Static method in class net.jafama.NumbersUtils
Not defining an asByte(long) method, since asByte((int)aLong) works.
ascending(int) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with cells having ascending values.
ascending(int, int) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with cells having ascending values.
ascending(int, int, int) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with cells having ascending values.
ASCENDING - Static variable in class org.jfree.data.DomainOrder
Ascending order.
ASCIIFile - Class in jhplot.math.io
BSD License
ASCIIFile(File) - Constructor for class jhplot.math.io.ASCIIFile
 
asFileFilter(FileFilter) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns an IOFileFilter that wraps the FileFilter instance.
asFileFilter(FilenameFilter) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns an IOFileFilter that wraps the FilenameFilter instance.
asFourVector() - Method in class hep.physics.particle.BasicParticle
 
asFourVector() - Method in interface hep.physics.particle.Particle
Return this particles momentum and energy as a 4-vector
asin - Static variable in class cern.jet.math.Functions
Function that returns Math.asin(a).
asin(ValueErr) - Method in class jhplot.math.ValueErr
Inverse sine of a value with error
asin(double) - Static method in class net.jafama.FastMath
 
asin(double) - Static method in class net.jafama.StrictFastMath
 
asin() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Arc sine operation.
asin(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute arc sine of a derivative structure.
asin() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Arc sine operation.
Asin - Class in org.apache.commons.math3.analysis.function
Arc-sine function.
Asin() - Constructor for class org.apache.commons.math3.analysis.function.Asin
 
asin() - Method in class org.apache.commons.math3.complex.Complex
Compute the inverse sine of this complex number.
asin() - Method in class org.apache.commons.math3.dfp.Dfp
Arc sine operation.
asin(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the arc-sine of the argument.
asin() - Method in interface org.apache.commons.math3.RealFieldElement
Arc sine operation.
asin() - Method in class org.apache.commons.math3.util.Decimal64
Arc sine operation.
asin(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the arc sine of a number.
asin(double) - Static method in class org.jlab.groot.math.FunctionFactory
Fast asin using 8 term polynomial approximation from Abramowitz and Stegun, pg.
asin(Object) - Method in class org.nfunk.jep.function.ArcSine
 
asin() - Method in class org.nfunk.jep.type.Complex
 
asin_4(double) - Static method in class org.jlab.groot.math.FunctionFactory
Fast asin using 4 term polynomial approximation from Abramowitz and Stegun, pg.
asinh(double) - Static method in class graph.SpecialFunction
 
asinh(double) - Static method in class jhplot.math.num.special.Trigonometric
Returns the inverse hyperbolic sine of x.
asinh(ValueErr) - Method in class jhplot.math.ValueErr
Inverse hyperbolic sine of a value with error
asinh(double) - Method in class jhplot.math.ValueErr
Inverse hyperbolic sine of a double number
asinh(double) - Static method in class net.jafama.FastMath
Some properties of asinh(x) = log(x + sqrt(x^2 + 1)) 1) defined on ]-Infinity,+Infinity[ 2) result in ]-Infinity,+Infinity[ 3) asinh(x) = -asinh(-x) (implies asinh(0) = 0) 4) asinh(epsilon) ~= epsilon 5) lim(asinh(x),x->+Infinity) = +Infinity (y increasing logarithmically slower than x)
asinh(double) - Static method in class net.jafama.StrictFastMath
Some properties of asinh(x) = log(x + sqrt(x^2 + 1)) 1) defined on ]-Infinity,+Infinity[ 2) result in ]-Infinity,+Infinity[ 3) asinh(x) = -asinh(-x) (implies asinh(0) = 0) 4) asinh(epsilon) ~= epsilon 5) lim(asinh(x),x->+Infinity) = +Infinity (y increasing logarithmically slower than x)
asinh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Inverse hyperbolic sine operation.
asinh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute inverse hyperbolic sine of a derivative structure.
asinh() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Inverse hyperbolic sine operation.
Asinh - Class in org.apache.commons.math3.analysis.function
Hyperbolic arc-sine function.
Asinh() - Constructor for class org.apache.commons.math3.analysis.function.Asinh
 
asinh() - Method in class org.apache.commons.math3.dfp.Dfp
Inverse hyperbolic sine operation.
asinh() - Method in interface org.apache.commons.math3.RealFieldElement
Inverse hyperbolic sine operation.
asinh() - Method in class org.apache.commons.math3.util.Decimal64
Inverse hyperbolic sine operation.
asinh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the inverse hyperbolic sine of a number.
asinh(Object) - Method in class org.nfunk.jep.function.ArcSineH
 
asinh() - Method in class org.nfunk.jep.type.Complex
 
asinInRange(double) - Static method in class net.jafama.FastMath
If value is not NaN and is outside [-1,1] range, closest value in this range is used.
asinInRange(double) - Static method in class net.jafama.StrictFastMath
If value is not NaN and is outside [-1,1] range, closest value in this range is used.
asInt(long) - Static method in class net.jafama.NumbersUtils
 
asList() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build an ordered list of intervals representing the instance.
asList() - Method in class org.apache.commons.math3.geometry.spherical.oned.ArcsSet
Build an ordered list of arcs representing the instance.
asPackedArray(boolean) - Method in class hep.physics.matrix.SymmetricMatrix
Returns the matrix as a packed array
asPackedArray(boolean) - Method in class hephysics.matrix.SymmetricMatrix
Returns the matrix as a packed array
assertPolynomialEquals(String, String) - Method in class org.lsmp.djepJUnit.SJepTest
 
assign(DoubleFunction) - Method in class cern.colt.map.AbstractIntDoubleMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractIntDoubleMap) - Method in class cern.colt.map.AbstractIntDoubleMap
Clears the receiver, then adds all (key,value) pairs of othervalues to it.
assign(DoubleFunction) - Method in class cern.colt.map.OpenIntDoubleHashMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractIntDoubleMap) - Method in class cern.colt.map.OpenIntDoubleHashMap
Clears the receiver, then adds all (key,value) pairs of othervalues to it.
assign(double[]) - Method in class cern.colt.matrix.DoubleMatrix1D
Sets all cells to the state specified by values.
assign(double) - Method in class cern.colt.matrix.DoubleMatrix1D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix1D, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(DoubleMatrix1D, DoubleDoubleFunction, IntArrayList) - Method in class cern.colt.matrix.DoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(double[][]) - Method in class cern.colt.matrix.DoubleMatrix2D
Sets all cells to the state specified by values.
assign(double) - Method in class cern.colt.matrix.DoubleMatrix2D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(double[][][]) - Method in class cern.colt.matrix.DoubleMatrix3D
Sets all cells to the state specified by values.
assign(double) - Method in class cern.colt.matrix.DoubleMatrix3D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix3D
Assigns the result of a function to each cell; x[slice,row,col] = function(x[slice,row,col]).
assign(DoubleMatrix3D) - Method in class cern.colt.matrix.DoubleMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix3D, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix3D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(double[]) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Sets all cells to the state specified by values.
assign(double) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(DoubleMatrix1D) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix1D, DoubleDoubleFunction) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(double[][]) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Sets all cells to the state specified by values.
assign(double) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(double[][][]) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
Sets all cells to the state specified by values.
assign(DoubleMatrix3D) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(Object[]) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(ObjectMatrix1D) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix1D, ObjectObjectFunction) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(Object[][]) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(ObjectMatrix2D) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix2D, ObjectObjectFunction) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(Object[][][]) - Method in class cern.colt.matrix.impl.DenseObjectMatrix3D
Sets all cells to the state specified by values.
assign(ObjectMatrix3D) - Method in class cern.colt.matrix.impl.DenseObjectMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(double) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
assign(double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Sets all cells to the state specified by value.
assign(double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
 
assign(double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Sets all cells to the state specified by value.
assign(DoubleMatrix2D, DoubleFunction) - Method in interface cern.colt.matrix.linalg.Blas
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(DoubleMatrix2D, DoubleMatrix2D, DoubleDoubleFunction) - Method in interface cern.colt.matrix.linalg.Blas
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(DoubleMatrix2D, DoubleFunction) - Method in class cern.colt.matrix.linalg.SeqBlas
 
assign(DoubleMatrix2D, DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.linalg.SeqBlas
 
assign(DoubleMatrix2D, DoubleFunction) - Method in class cern.colt.matrix.linalg.SmpBlas
 
assign(DoubleMatrix2D, DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.linalg.SmpBlas
 
assign(Object[]) - Method in class cern.colt.matrix.ObjectMatrix1D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(ObjectMatrix1D) - Method in class cern.colt.matrix.ObjectMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix1D, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(Object) - Method in class cern.colt.matrix.ObjectMatrix1D
Sets all cells to the state specified by value.
assign(Object[][]) - Method in class cern.colt.matrix.ObjectMatrix2D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix2D, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(Object) - Method in class cern.colt.matrix.ObjectMatrix2D
Sets all cells to the state specified by value.
assign(Object[][][]) - Method in class cern.colt.matrix.ObjectMatrix3D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix3D
Assigns the result of a function to each cell; x[slice,row,col] = function(x[slice,row,col]).
assign(ObjectMatrix3D) - Method in class cern.colt.matrix.ObjectMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix3D, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix3D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(Object) - Method in class cern.colt.matrix.ObjectMatrix3D
Sets all cells to the state specified by value.
ASSIGN - Static variable in class org.lsmp.djep.rpe.RpEval
 
Assign - Class in org.nfunk.jep.function
An assignment operator so we can do x=3+4.
Assign() - Constructor for class org.nfunk.jep.function.Assign
 
ASSIGN - Static variable in interface org.nfunk.jep.ParserConstants
 
AssignExpression() - Method in class org.nfunk.jep.Parser
 
AssignmentExample - Class in org.lsmp.djepExamples
Examples using assignment
AssignmentExample() - Constructor for class org.lsmp.djepExamples.AssignmentExample
 
assignToCluster(int) - Method in class jminhep.cluster.DataPoint
Assigns the data point to a cluster
ASSOCIATIVE - Static variable in class org.lsmp.djep.xjep.XOperator
Associative operators x*(y*z) == (x*y)*z .
asString() - Static method in class cern.colt.Version
Returns all version information as string.
Assume - Class in jhplot.math.pca
A set of convenience assert-like methods that throw an exception if given condition is not met.
Assume() - Constructor for class jhplot.math.pca.Assume
 
assume(boolean) - Static method in class jhplot.math.pca.Assume
 
assume(boolean, String) - Static method in class jhplot.math.pca.Assume
 
ASTConstant - Class in org.nfunk.jep
Constant Node
ASTConstant(int) - Constructor for class org.nfunk.jep.ASTConstant
 
ASTConstant(Parser, int) - Constructor for class org.nfunk.jep.ASTConstant
 
ASTFunNode - Class in org.nfunk.jep
Function Node
ASTFunNode(int) - Constructor for class org.nfunk.jep.ASTFunNode
Creates a new ASTFunNode
ASTFunNode(Parser, int) - Constructor for class org.nfunk.jep.ASTFunNode
Creates a new ASTFunNode
ASTMConstant - Class in org.lsmp.djep.matrixJep.nodeTypes
Holds a single constant number.
ASTMConstant(int) - Constructor for class org.lsmp.djep.matrixJep.nodeTypes.ASTMConstant
 
ASTMFunNode - Class in org.lsmp.djep.matrixJep.nodeTypes
 
ASTMFunNode(int) - Constructor for class org.lsmp.djep.matrixJep.nodeTypes.ASTMFunNode
 
ASTMVarNode - Class in org.lsmp.djep.matrixJep.nodeTypes
 
ASTMVarNode(int) - Constructor for class org.lsmp.djep.matrixJep.nodeTypes.ASTMVarNode
 
ASTStart - Class in org.nfunk.jep
Start Node
ASTStart(int) - Constructor for class org.nfunk.jep.ASTStart
 
ASTStart(Parser, int) - Constructor for class org.nfunk.jep.ASTStart
 
ASTVarNode - Class in org.nfunk.jep
Variable Node
ASTVarNode(int) - Constructor for class org.nfunk.jep.ASTVarNode
 
ASTVarNode(Parser, int) - Constructor for class org.nfunk.jep.ASTVarNode
 
atan - Static variable in class cern.jet.math.Functions
Function that returns Math.atan(a).
atan(ValueErr) - Method in class jhplot.math.ValueErr
inverse tangent of a value
atan(double) - Static method in class net.jafama.FastMath
 
atan(double) - Static method in class net.jafama.StrictFastMath
 
atan() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Arc tangent operation.
atan(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute arc tangent of a derivative structure.
atan() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Arc tangent operation.
Atan - Class in org.apache.commons.math3.analysis.function
Arc-tangent function.
Atan() - Constructor for class org.apache.commons.math3.analysis.function.Atan
 
atan() - Method in class org.apache.commons.math3.complex.Complex
Compute the inverse tangent of this complex number.
atan() - Method in class org.apache.commons.math3.dfp.Dfp
Arc tangent operation.
atan(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the arc tangent of the argument Uses the typical taylor series but may reduce arguments using the following identity tan(x+y) = (tan(x) + tan(y)) / (1 - tan(x)*tan(y)) since tan(PI/8) = sqrt(2)-1, atan(x) = atan( (x - sqrt(2) + 1) / (1+x*sqrt(2) - x) + PI/8.0
atan() - Method in interface org.apache.commons.math3.RealFieldElement
Arc tangent operation.
atan() - Method in class org.apache.commons.math3.util.Decimal64
Arc tangent operation.
atan(double) - Static method in class org.apache.commons.math3.util.FastMath
Arctangent function
atan(double) - Static method in class org.jlab.groot.math.FunctionFactory
 
atan(Object) - Method in class org.nfunk.jep.function.ArcTangent
 
atan() - Method in class org.nfunk.jep.type.Complex
 
atan2 - Static variable in class cern.jet.math.Functions
Function that returns Math.atan2(a,b).
atan2(ValueErr, ValueErr) - Method in class jhplot.math.ValueErr
Inverse tangent (atan2) of a value without correlations
atan2(ValueErr, ValueErr, double) - Method in class jhplot.math.ValueErr
Inverse tangent (atan2) of a value with a correlation
ATAN2 - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
atan2(double, double) - Static method in class net.jafama.FastMath
For special values for which multiple conventions could be adopted, behaves like Math.atan2(double,double).
atan2(double, double) - Static method in class net.jafama.StrictFastMath
For special values for which multiple conventions could be adopted, behaves like StrictMath.atan2(double,double).
atan2(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Two arguments arc tangent operation.
atan2(DerivativeStructure, DerivativeStructure) - Static method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Two arguments arc tangent operation.
atan2(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute two arguments arc tangent of a derivative structure.
atan2(SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Two arguments arc tangent operation.
atan2(SparseGradient, SparseGradient) - Static method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Two arguments arc tangent operation.
Atan2 - Class in org.apache.commons.math3.analysis.function
Arc-tangent function.
Atan2() - Constructor for class org.apache.commons.math3.analysis.function.Atan2
 
atan2(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Two arguments arc tangent operation.
atan2(T) - Method in interface org.apache.commons.math3.RealFieldElement
Two arguments arc tangent operation.
atan2(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Two arguments arc tangent operation.
atan2(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Two arguments arctangent function
atan2(double, double) - Static method in class org.jlab.groot.math.FunctionFactory
 
atanh(double) - Static method in class graph.SpecialFunction
 
atanh(double) - Static method in class jhplot.math.num.special.Trigonometric
atanh(double) - Static method in class net.jafama.FastMath
Some properties of atanh(x) = log((1+x)/(1-x))/2: 1) defined on ]-1,1[ 2) result in ]-Infinity,+Infinity[ 3) atanh(-1) = -Infinity (by continuity) 4) atanh(1) = +Infinity (by continuity) 5) atanh(epsilon) ~= epsilon 6) lim(atanh(x),x->1) = +Infinity
atanh(double) - Static method in class net.jafama.StrictFastMath
Some properties of atanh(x) = log((1+x)/(1-x))/2: 1) defined on ]-1,1[ 2) result in ]-Infinity,+Infinity[ 3) atanh(-1) = -Infinity (by continuity) 4) atanh(1) = +Infinity (by continuity) 5) atanh(epsilon) ~= epsilon 6) lim(atanh(x),x->1) = +Infinity
atanh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Inverse hyperbolic tangent operation.
atanh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute inverse hyperbolic tangent of a derivative structure.
atanh() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Inverse hyperbolic tangent operation.
Atanh - Class in org.apache.commons.math3.analysis.function
Hyperbolic arc-tangent function.
Atanh() - Constructor for class org.apache.commons.math3.analysis.function.Atanh
 
atanh() - Method in class org.apache.commons.math3.dfp.Dfp
Inverse hyperbolic tangent operation.
atanh() - Method in interface org.apache.commons.math3.RealFieldElement
Inverse hyperbolic tangent operation.
atanh() - Method in class org.apache.commons.math3.util.Decimal64
Inverse hyperbolic tangent operation.
atanh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the inverse hyperbolic tangent of a number.
atanh(Object) - Method in class org.nfunk.jep.function.ArcTanH
 
atanh() - Method in class org.nfunk.jep.type.Complex
 
AtCalorimeter - Static variable in interface hep.lcio.event.TrackState
 
AtFirstHit - Static variable in interface hep.lcio.event.TrackState
 
AtIP - Static variable in interface hep.lcio.event.TrackState
 
AtLastHit - Static variable in interface hep.lcio.event.TrackState
 
atLowerLimit() - Method in class org.freehep.math.minuit.MinosError
 
atLowerMaxFcn() - Method in class org.freehep.math.minuit.MinosError
 
atmosphere - Static variable in class cern.clhep.Units
 
atof(String) - Static method in class corejava.Format
Converts a string of digits to a double
atoi(String) - Static method in class corejava.Format
Converts a string of digits (decimal, octal or hex) to an integer
atol(String) - Static method in class corejava.Format
Converts a string of digits (decimal, octal or hex) to a long integer
AtOther - Static variable in interface hep.lcio.event.TrackState
 
attachAxis(Axis) - Method in class graph.G2Dint
Attach axis to be used for the drag scaling.
attachAxis(Axis) - Method in class graph.Graph2D
Attach a previously created Axis.
attachContours() - Method in class graph.Contour
Attach contours so that they will be plotted.
attachDataSet(DataSet) - Method in class graph.Axis
Attach a DataSet for the Axis to manage.
attachDataSet(DataSet) - Method in class graph.Graph2D
Attach a DataSet to the graph.
Attributes - Class in org.jlab.groot.base
 
Attributes() - Constructor for class org.jlab.groot.base.Attributes
 
AttributeType - Enum in org.jlab.groot.base
 
AttrStringUtils - Class in org.jfree.chart.util
Some AttributedString utilities.
atUpperLimit() - Method in class org.freehep.math.minuit.MinosError
 
atUpperMaxFcn() - Method in class org.freehep.math.minuit.MinosError
 
AtVertex - Static variable in interface hep.lcio.event.TrackState
 
AU - Static variable in class graph.SpecialFunction
Astronomical Unit (radius of the Earth's orbit).
au(Zmat, Z1, int, int, int, int, Z1) - Static method in class Jampack.House
Postmultiplies the Householder transformation contained in a Z1 into a Zmat A[r1:r2,c1:c2] and overwrites Zmat A[r1:r2,c1:c2] with the results.
au(Zmat, Z1, int, int, int, int) - Static method in class Jampack.House
Postmultiplies the Householder transformation contained in a Z1 into a Zmat A[r1:r2,c1:c2] and overwrites Zmat A[r1:r2,c1:c2] with the results.
AUTO_BOUNDS - Static variable in class jhplot.math.Slicing
 
AUTO_SCALE_Z_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
autoAdjustRange() - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Rescales the axis to ensure that all data are visible.
autoAdjustRange() - Method in class org.jfree.chart.axis.LogarithmicAxis
Rescales the axis to ensure that all data is visible.
AutoCloseInputStream - Class in org.apache.commons.io.input
Proxy stream that closes and discards the underlying stream as soon as the end of input has been reached or when the stream is explicitly closed.
AutoCloseInputStream(InputStream) - Constructor for class org.apache.commons.io.input.AutoCloseInputStream
Creates an automatically closing proxy for the given input stream.
autocorr(double[], int) - Static method in class jhplot.stat.StatUtils
Computes autocorrelation up to maxk for the time series data.
autoCorrelate(double[], int, int) - Static method in class jhplot.stat.StatUtils
This static class does the autocorrelation for the given float vector.
autoCorrelation(DoubleArrayList, int, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the auto-correlation of a data sequence.
autocov(double[], int) - Static method in class jhplot.stat.StatUtils
Computes autocovariance up to maxk for the time series data.
autoRange(int) - Method in class jplot.GraphSettings
Returns whether or not we should use automatic scaling.
autoScale() - Method in class jplot3d.SurfaceModelCanvas
 
available() - Method in class org.apache.commons.io.input.BoundedInputStream
available() - Method in class org.apache.commons.io.input.BrokenInputStream
Throws the configured exception.
available() - Method in class org.apache.commons.io.input.CharSequenceInputStream
Return an estimate of the number of bytes remaining in the byte stream.
available() - Method in class org.apache.commons.io.input.NullInputStream
Return the number of bytes that can be read.
available() - Method in class org.apache.commons.io.input.ProxyInputStream
Invokes the delegate's available() method.
available() - Method in class org.apache.commons.io.input.RandomAccessFileInputStream
Returns an estimate of the number of bytes that can be read (or skipped over) from this input stream.
available() - Method in class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
 
availableLong() - Method in class org.apache.commons.io.input.RandomAccessFileInputStream
Returns the number of bytes that can be read (or skipped over) from this input stream.
avg(double[]) - Static method in class jhplot.stat.StatUtils
Compute average of all values in vector v.
AVLTree<T extends Comparable<T>> - Class in org.apache.commons.math3.geometry.partitioning.utilities
Deprecated.
as of 3.4, this class is not used anymore and considered to be out of scope of Apache Commons Math
AVLTree() - Constructor for class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Deprecated.
Build an empty tree.
AVLTree.Node - Class in org.apache.commons.math3.geometry.partitioning.utilities
Deprecated.
This class implements AVL trees nodes.
Avogadro - Static variable in class cern.clhep.PhysicalConstants
 
AVOGADRO - Static variable in class graph.SpecialFunction
Avogadro Number.
axesDefinition - Variable in class jplot3dp.ModelView
 
AxesDefinition() - Constructor for class jplot3dp.ModelView.AxesDefinition
 
AxesOptions() - Constructor for class jplot.panels.PanelAxes.AxesOptions
Principal constructor.
Axis - Class in graph
This class controls the look and feel of axes.
Axis() - Constructor for class graph.Axis
Instantiate the class.
Axis(int) - Constructor for class graph.Axis
Instantiate the class.
Axis - Class in jplot
Includes a static function for selecting and labeling graph axis tic labels.
Axis() - Constructor for class jplot.Axis
 
Axis - Class in org.jfree.chart.axis
The base class for all axes in JFreeChart.
Axis - Class in org.jlab.groot.math
Defines the attributes for creating a basic axis template with a number of bins, a minimum value, and a maximum value
Axis() - Constructor for class org.jlab.groot.math.Axis
Creates a default axis with 1 bin, a minimum value of 0, and maximum value of 1.0.
Axis(double[]) - Constructor for class org.jlab.groot.math.Axis
Creates an axis using the desired limits for the bins
Axis(int, double, double) - Constructor for class org.jlab.groot.math.Axis
Creates an axis using the provided number of bins, minimum value, and maximum value
axis(String, int, double, double) - Method in class org.jlab.groot.matrix.SparseGridBuilder
 
axis(Axis) - Method in class org.jlab.groot.matrix.SparseGridBuilder
 
axis(String, double[]) - Method in class org.jlab.groot.matrix.SparseGridBuilder
 
AxisAttributes - Class in org.jlab.groot.base
 
AxisAttributes(int) - Constructor for class org.jlab.groot.base.AxisAttributes
 
AxisAttributes.AxisAttributesPane - Class in org.jlab.groot.base
 
AxisAttributesPane(AxisAttributes) - Constructor for class org.jlab.groot.base.AxisAttributes.AxisAttributesPane
 
axisChanged(AxisChangeEvent) - Method in interface org.jfree.chart.event.AxisChangeListener
Receives notification of an axis change event.
axisChanged(AxisChangeEvent) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Receives notification of a change to one of the plot's axes.
axisChanged(AxisChangeEvent) - Method in class org.jfree.chart.plot.Plot
Receives notification of a change to one of the plot's axes.
axisChanged(AxisChangeEvent) - Method in class org.jfree.chart.title.PaintScaleLegend
Receives notification of an axis change event and responds by firing a title change event.
AxisChangeEvent - Class in org.jfree.chart.event
A change event that encapsulates information about a change to an axis.
AxisChangeEvent(Axis) - Constructor for class org.jfree.chart.event.AxisChangeEvent
Creates a new AxisChangeEvent.
AxisChangeListener - Interface in org.jfree.chart.event
The interface that must be supported by classes that wish to receive notification of changes to an axis.
AxisCollection - Class in org.jfree.chart.axis
A collection of axes that have been assigned to the TOP, BOTTOM, LEFT or RIGHT of a chart.
AxisCollection() - Constructor for class org.jfree.chart.axis.AxisCollection
Creates a new empty collection.
axiscolor - Variable in class graph.Axis
Color of the Axis.
AxisEntity - Class in org.jfree.chart.entity
A class that captures information about an Axis belonging to a chart.
AxisEntity(Shape, Axis) - Constructor for class org.jfree.chart.entity.AxisEntity
Creates a new axis entity.
AxisEntity(Shape, Axis, String) - Constructor for class org.jfree.chart.entity.AxisEntity
Creates a new axis entity.
AxisEntity(Shape, Axis, String, String) - Constructor for class org.jfree.chart.entity.AxisEntity
Creates a new axis entity.
AxisLabelLocation - Class in org.jfree.chart.axis
Used to indicate the location of an axis label.
axisLengthX() - Method in class jhplot.HPlot
Length of X axis in pixels.
axisLengthY() - Method in class jhplot.HPlot
Length of Y axis in pixels.
AxisLocation - Class in org.jfree.chart.axis
Used to indicate the location of an axis on a 2D plot, prior to knowing the orientation of the plot.
axisMargins - Variable in class org.jlab.groot.math.Axis
 
AxisSpace - Class in org.jfree.chart.axis
A record that contains the space required at each edge of a plot.
AxisSpace() - Constructor for class org.jfree.chart.axis.AxisSpace
Creates a new axis space record.
AxisState - Class in org.jfree.chart.axis
Instances of this class are used to carry state information for an axis during the drawing process.
AxisState() - Constructor for class org.jfree.chart.axis.AxisState
Creates a new axis state.
AxisState(double) - Constructor for class org.jfree.chart.axis.AxisState
Creates a new axis state.
AXISTYPE_COLOR - Static variable in class org.jlab.groot.graphics.GraphicsAxis
 
AXISTYPE_HORIZONTAL - Static variable in class org.jlab.groot.graphics.GraphicsAxis
 
AXISTYPE_VERTICAL - Static variable in class org.jlab.groot.graphics.GraphicsAxis
 
axisVectors - Variable in class jplot3dp.ModelView.AxesDefinition
 
axisVectorsFrame - Variable in class jplot3dp.ModelView.AxesDefinition
 

B

backCulling - Variable in class jplot3dp.ModelView
 
backup(int) - Method in class jplot3dp.MathParser.SimpleCharStream
 
backup(int) - Method in class org.nfunk.jep.JavaCharStream
 
bahi(Zmat, Zltmat) - Static method in class Jampack.Solve
Solves XLH = B, where L is a Zltmat and B is a Zmat.
bahi(Zmat, Zutmat) - Static method in class Jampack.Solve
Solves XUH = B, where U is a Zutmat and B is a Zmat.
bahi(Zmat, Zmat) - Static method in class Jampack.Solve
Solve XA^H = B, where A is a Zmat and B is a Zmat.
bai(Zmat, Zltmat) - Static method in class Jampack.Solve
Solves XL = B, where L is a Zltmat and B is a Zmat.
bai(Zmat, Zutmat) - Static method in class Jampack.Solve
Solves XU = B, where U is a Zutmat and B is a Zmat.
bai(Zmat, Zmat) - Static method in class Jampack.Solve
Solve XA = B, where A is a Zmat and B is a Zmat.
bai(Zmat, Zpsdmat) - Static method in class Jampack.Solve
Solves XA = B, where A is a Zpsdmat and B is a Zmat.
ballOnSupport(List<P>) - Method in interface org.apache.commons.math3.geometry.enclosing.SupportBallGenerator
Create a ball whose boundary lies on prescribed support points.
ballOnSupport(List<Vector3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SphereGenerator
Create a ball whose boundary lies on prescribed support points.
ballOnSupport(List<Vector2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.DiskGenerator
Create a ball whose boundary lies on prescribed support points.
bar - Static variable in class cern.clhep.Units
 
BAR_OUTLINE_WIDTH_THRESHOLD - Static variable in class org.jfree.chart.renderer.category.BarRenderer
Constant that controls the minimum width before a bar has an outline drawn.
BarChartDemo1 - Class in org.jfree.chart.demo
A simple demonstration application showing how to create a bar chart.
BarChartDemo1(String) - Constructor for class org.jfree.chart.demo.BarChartDemo1
Creates a new demo instance.
BarChartFXDemo1 - Class in org.jfree.chart.fx.demo
A demo showing the display of JFreeChart within a JavaFX application.
BarChartFXDemo1() - Constructor for class org.jfree.chart.fx.demo.BarChartFXDemo1
 
BARCODE_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
BARCODE_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
BARCODE_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
barn - Static variable in class cern.clhep.Units
 
BarPainter - Interface in org.jfree.chart.renderer.category
The interface for plugin painter for the BarRenderer class.
BarRenderer - Class in org.jfree.chart.renderer.category
A CategoryItemRenderer that draws individual data items as bars.
BarRenderer() - Constructor for class org.jfree.chart.renderer.category.BarRenderer
Creates a new bar renderer with default settings.
BarRenderer3D - Class in org.jfree.chart.renderer.category
A renderer for bars with a 3D effect, for use with the CategoryPlot class.
BarRenderer3D() - Constructor for class org.jfree.chart.renderer.category.BarRenderer3D
Default constructor, creates a renderer with a default '3D effect'.
BarRenderer3D(double, double) - Constructor for class org.jfree.chart.renderer.category.BarRenderer3D
Constructs a new renderer with the specified '3D effect'.
BaseAbstractMultivariateOptimizer<FUNC extends MultivariateFunction> - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
BaseAbstractMultivariateSimpleBoundsOptimizer<FUNC extends MultivariateFunction> - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
BaseAbstractMultivariateVectorOptimizer<FUNC extends MultivariateVectorFunction> - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
BaseAbstractUnivariateIntegrator - Class in org.apache.commons.math3.analysis.integration
Provide a default implementation for several generic functions.
BaseAbstractUnivariateOptimizer - Class in org.apache.commons.math3.optimization.univariate
Deprecated.
As of 3.1 (to be removed in 4.0).
BaseAbstractUnivariateSolver<FUNC extends UnivariateFunction> - Class in org.apache.commons.math3.analysis.solvers
Provide a default implementation for several functions useful to generic solvers.
BaseEvent - Class in hep.physics.event
A simple implementation of HEPEvent
BaseEvent(int, int) - Constructor for class hep.physics.event.BaseEvent
 
BaseEvent(int, int, long) - Constructor for class hep.physics.event.BaseEvent
Create a new event with an explicit timestamp
BaseFormat - Class in org.lsmp.djep.xjep
A Number format object which prints results in a specified base.
BaseFormat(int) - Constructor for class org.lsmp.djep.xjep.BaseFormat
Create a new base format object
BaseFormat(int, String) - Constructor for class org.lsmp.djep.xjep.BaseFormat
Create a new base format object
BaseMultiStartMultivariateOptimizer<PAIR> - Class in org.apache.commons.math3.optim
Base class multi-start optimizer for a multivariate function.
BaseMultiStartMultivariateOptimizer(BaseMultivariateOptimizer<PAIR>, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optim.BaseMultiStartMultivariateOptimizer
Create a multi-start optimizer from a single-start optimizer.
BaseMultivariateMultiStartOptimizer<FUNC extends MultivariateFunction> - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
BaseMultivariateOptimizer<PAIR> - Class in org.apache.commons.math3.optim
Base class for implementing optimizers for multivariate functions.
BaseMultivariateOptimizer<FUNC extends MultivariateFunction> - Interface in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
BaseMultivariateSimpleBoundsOptimizer<FUNC extends MultivariateFunction> - Interface in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
BaseMultivariateVectorMultiStartOptimizer<FUNC extends MultivariateVectorFunction> - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
BaseMultivariateVectorOptimizer<FUNC extends MultivariateVectorFunction> - Interface in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
BaseOptimizer<PAIR> - Class in org.apache.commons.math3.optim
Base class for implementing optimizers.
BaseOptimizer<PAIR> - Interface in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
BaseRecordsFile - Class in jhplot.io.db
 
BaseRuleFactory<T extends Number> - Class in org.apache.commons.math3.analysis.integration.gauss
Base class for rules that determines the integration nodes and their weights.
BaseRuleFactory() - Constructor for class org.apache.commons.math3.analysis.integration.gauss.BaseRuleFactory
 
BaseSecantSolver - Class in org.apache.commons.math3.analysis.solvers
Base class for all bracketing Secant-based methods for root-finding (approximating a zero of a univariate real function).
BaseUnivariateOptimizer<FUNC extends UnivariateFunction> - Interface in org.apache.commons.math3.optimization.univariate
Deprecated.
As of 3.1 (to be removed in 4.0).
BaseUnivariateSolver<FUNC extends UnivariateFunction> - Interface in org.apache.commons.math3.analysis.solvers
Interface for (univariate real) rootfinding algorithms.
BasicDemo - Class in org.jlab.groot.demo
 
BasicDemo() - Constructor for class org.jlab.groot.demo.BasicDemo
 
BasicDemo2 - Class in org.jlab.groot.demo
 
BasicDemo2() - Constructor for class org.jlab.groot.demo.BasicDemo2
 
BasicDemo3 - Class in org.jlab.groot.demo
 
BasicDemo3() - Constructor for class org.jlab.groot.demo.BasicDemo3
 
BasicHep3Matrix - Class in hep.physics.vec
3x3 matrices for Hep3Vector operations.
BasicHep3Matrix() - Constructor for class hep.physics.vec.BasicHep3Matrix
 
BasicHep3Matrix(double, double, double, double, double, double, double, double, double) - Constructor for class hep.physics.vec.BasicHep3Matrix
 
BasicHep3Matrix(Matrix) - Constructor for class hep.physics.vec.BasicHep3Matrix
 
BasicHep3Vector - Class in hep.physics.vec
Basic implementation of a Hep3Vector
BasicHep3Vector() - Constructor for class hep.physics.vec.BasicHep3Vector
 
BasicHep3Vector(double, double, double) - Constructor for class hep.physics.vec.BasicHep3Vector
 
BasicHep3Vector(double[]) - Constructor for class hep.physics.vec.BasicHep3Vector
Create a BasicHep3Vector from a double array
BasicHep3Vector(float[]) - Constructor for class hep.physics.vec.BasicHep3Vector
 
BasicHepLorentzVector - Class in hep.physics.vec
BasicImplementation of a HepLorentzVector (4-vector)
BasicHepLorentzVector() - Constructor for class hep.physics.vec.BasicHepLorentzVector
 
BasicHepLorentzVector(double, double, double, double) - Constructor for class hep.physics.vec.BasicHepLorentzVector
 
BasicHepLorentzVector(double, double[]) - Constructor for class hep.physics.vec.BasicHepLorentzVector
 
BasicHepLorentzVector(double, float[]) - Constructor for class hep.physics.vec.BasicHepLorentzVector
 
BasicHepLorentzVector(double, Hep3Vector) - Constructor for class hep.physics.vec.BasicHepLorentzVector
 
BasicMatrix - Class in hep.physics.matrix
A very simple matrix implementation
BasicMatrix(int, int) - Constructor for class hep.physics.matrix.BasicMatrix
 
BasicMatrix(double[][]) - Constructor for class hep.physics.matrix.BasicMatrix
Creates a new instance of BasicMatrix
BasicMatrix(Matrix) - Constructor for class hep.physics.matrix.BasicMatrix
 
BasicMatrix - Class in hephysics.matrix
A very simple matrix implementation
BasicMatrix(int, int) - Constructor for class hephysics.matrix.BasicMatrix
 
BasicMatrix(double, double, double, double, double, double, double, double, double) - Constructor for class hephysics.matrix.BasicMatrix
 
BasicMatrix(double[][]) - Constructor for class hephysics.matrix.BasicMatrix
Creates a new instance of BasicMatrix
BasicMatrix(Matrix) - Constructor for class hephysics.matrix.BasicMatrix
 
BasicParticle - Class in hep.physics.particle
Default implementation of Particle.
BasicParticle(Hep3Vector, HepLorentzVector, ParticleType, int, double) - Constructor for class hep.physics.particle.BasicParticle
Create a new BasicParticle
becquerel - Static variable in class cern.clhep.Units
 
before(SegmentedTimeline.Segment) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns true if this segment is wholly before another segment.
beforeInsert(int, boolean) - Method in class cern.colt.list.AbstractBooleanList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, byte) - Method in class cern.colt.list.AbstractByteList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, char) - Method in class cern.colt.list.AbstractCharList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, double) - Method in class cern.colt.list.AbstractDoubleList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, float) - Method in class cern.colt.list.AbstractFloatList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, int) - Method in class cern.colt.list.AbstractIntList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, long) - Method in class cern.colt.list.AbstractLongList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, short) - Method in class cern.colt.list.AbstractShortList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, boolean) - Method in class cern.colt.list.BooleanArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, byte) - Method in class cern.colt.list.ByteArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, char) - Method in class cern.colt.list.CharArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, double) - Method in class cern.colt.list.DoubleArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, float) - Method in class cern.colt.list.FloatArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, int) - Method in class cern.colt.list.IntArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, long) - Method in class cern.colt.list.LongArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, Object) - Method in class cern.colt.list.ObjectArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, short) - Method in class cern.colt.list.ShortArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsertAllOf(int, Collection) - Method in class cern.colt.list.AbstractList
Inserts all elements of the specified collection before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractBooleanList, int, int) - Method in class cern.colt.list.AbstractBooleanList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractByteList, int, int) - Method in class cern.colt.list.AbstractByteList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractCharList, int, int) - Method in class cern.colt.list.AbstractCharList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractDoubleList, int, int) - Method in class cern.colt.list.AbstractDoubleList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractFloatList, int, int) - Method in class cern.colt.list.AbstractFloatList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractIntList, int, int) - Method in class cern.colt.list.AbstractIntList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractLongList, int, int) - Method in class cern.colt.list.AbstractLongList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractShortList, int, int) - Method in class cern.colt.list.AbstractShortList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, ObjectArrayList, int, int) - Method in class cern.colt.list.ObjectArrayList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beginColumn - Variable in class jplot3dp.MathParser.Token
beginLine and beginColumn describe the position of the first character of this token; endLine and endColumn describe the position of the last character of this token.
beginColumn - Variable in class org.nfunk.jep.Token
beginLine and beginColumn describe the position of the first character of this token; endLine and endColumn describe the position of the last character of this token.
beginLine - Variable in class jplot3dp.MathParser.Token
beginLine and beginColumn describe the position of the first character of this token; endLine and endColumn describe the position of the last character of this token.
beginLine - Variable in class org.nfunk.jep.Token
beginLine and beginColumn describe the position of the first character of this token; endLine and endColumn describe the position of the last character of this token.
BeginToken() - Method in class jplot3dp.MathParser.SimpleCharStream
 
BeginToken() - Method in class org.nfunk.jep.JavaCharStream
 
belongsToGeneratedSubspace(Matrix) - Method in class jhplot.math.pca.PCA
Check if given point lies in PCA-generated subspace.
belowWithin(Rectangle, Dimension) - Static method in class jhepsim.Util
 
belowWithin(Component, Component) - Static method in class jhepsim.Util
 
belowWithin(Rectangle, Dimension) - Static method in class jhplot.utils.Util
 
belowWithin(Component, Component) - Static method in class jhplot.utils.Util
 
belowWithin(Rectangle, Dimension) - Static method in class jminhep.utils.Util
 
belowWithin(Component, Component) - Static method in class jminhep.utils.Util
 
Benchmark - Class in cern.colt.map
Benchmarks the classes of this package.
benchmark(int, int, String) - Static method in class cern.colt.map.Benchmark
 
Benchmark - Class in cern.jet.random
Benchmarks random number generation from various distributions as well as PDF and CDF lookups.
Benchmark - Class in cern.jet.random.engine
Benchmarks the performance of the currently provided uniform pseudo-random number generation engines.
benchmark(int) - Static method in class cern.jet.random.engine.Benchmark
Benchmarks raw() for various uniform generation engines.
BenchmarkMatrix - Class in cern.colt.matrix.bench
Configurable matrix benchmark.
BernoulliRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Bernoulli distribution.
BernoulliRandomVariable() - Constructor for class jhplot.math.num.random.BernoulliRandomVariable
Default constructor.
BernoulliRandomVariable(double) - Constructor for class jhplot.math.num.random.BernoulliRandomVariable
Create a random variable with the given probability of success.
BernoulliRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.BernoulliRandomVariable
Create a random variable with the given probability of success and source generator.
Bessel - Class in cern.jet.math
Bessel and Airy functions.
BesselJ - Class in org.apache.commons.math3.special
This class provides computation methods related to Bessel functions of the first kind.
BesselJ(double) - Constructor for class org.apache.commons.math3.special.BesselJ
Create a new BesselJ with the given order.
BesselJ.BesselJResult - Class in org.apache.commons.math3.special
Encapsulates the results returned by BesselJ.rjBesl(double, double, int).
BesselJResult(double[], int) - Constructor for class org.apache.commons.math3.special.BesselJ.BesselJResult
Create a new BesselJResult with the given values and valid value count.
Beta - Class in cern.jet.random
Beta(double, double, RandomEngine) - Constructor for class cern.jet.random.Beta
Constructs a Beta distribution.
beta(double, double) - Static method in class cern.jet.stat.Gamma
Returns the beta function of the arguments.
beta(double, double, double) - Static method in class cern.jet.stat.Probability
Returns the area from zero to x under the beta density function.
Beta - Class in jhplot.math.num.pdf
The Beta distribution (1).
Beta() - Constructor for class jhplot.math.num.pdf.Beta
Default constructor.
Beta(double, double) - Constructor for class jhplot.math.num.pdf.Beta
Create a distribution with the given alpha and beta values.
Beta - Class in jhplot.math.num.special
Utility class that provides methods related to the beta family of functions.
beta(double, double) - Static method in class jhplot.math.Random
Generate a random number from a beta random variable.
Beta - Class in org.apache.commons.math3.special
This is a utility class that provides computation methods related to the Beta family of functions.
betaComplemented(double, double, double) - Static method in class cern.jet.stat.Probability
Returns the area under the right hand tail (from x to infinity) of the beta density function.
BetaDistribution - Class in org.apache.commons.math3.distribution
Implements the Beta distribution.
BetaDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.BetaDistribution
Build a new instance.
BetaDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.BetaDistribution
Build a new instance.
BetaDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.BetaDistribution
Creates a β distribution.
BetaDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.BetaDistribution
Creates a β distribution.
BetaRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Beta distribution.
BetaRandomVariable() - Constructor for class jhplot.math.num.random.BetaRandomVariable
Default constructor.
BetaRandomVariable(double, double) - Constructor for class jhplot.math.num.random.BetaRandomVariable
Create a random variable with the given alpha and beta values.
BetaRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.BetaRandomVariable
Create a random variable with the given parameters.
between(double, double) - Static method in class cern.jet.math.Functions
Constructs a function that returns (from<=a && a<=to) ? 1 : 0.
between(int, int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns (from<=a && a<=to) ? 1 : 0.
BFunc - Class in fitter
Class representing a single function with tooltip
BFunc(String, String, String, String, int) - Constructor for class fitter.BFunc
 
BFunc(String, String) - Constructor for class fitter.BFunc
Assume no definition
bgColor - Variable in class jplot3dp.ModelView
 
BicubicInterpolatingFunction - Class in org.apache.commons.math3.analysis.interpolation
Function that implements the bicubic spline interpolation.
BicubicInterpolatingFunction(double[], double[], double[][], double[][], double[][], double[][]) - Constructor for class org.apache.commons.math3.analysis.interpolation.BicubicInterpolatingFunction
 
BicubicInterpolator - Class in org.apache.commons.math3.analysis.interpolation
BicubicInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.BicubicInterpolator
 
BicubicSplineInterpolatingFunction - Class in org.apache.commons.math3.analysis.interpolation
Deprecated.
BicubicSplineInterpolatingFunction(double[], double[], double[][], double[][], double[][], double[][]) - Constructor for class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
Deprecated.
 
BicubicSplineInterpolatingFunction(double[], double[], double[][], double[][], double[][], double[][], boolean) - Constructor for class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
Deprecated.
 
BicubicSplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Deprecated.
BicubicSplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolator
Deprecated.
Default constructor.
BicubicSplineInterpolator(boolean) - Constructor for class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolator
Deprecated.
Creates an interpolator.
BIG_ENDIAN - Static variable in class jhplot.math.io.BinaryFile
 
BIG_ENDIAN - Static variable in class jhplot.math.io.BinaryInputStream
 
BIG_ENDIAN - Static variable in class jhplot.math.io.BinaryOutputStream
 
bigDecimalValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a BigDecimal.
bigDecimalValue(int) - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a BigDecimal following the passed rounding mode.
bigDecimalValue(int, int) - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a BigDecimal following the passed scale and rounding mode.
bigDecimalValue() - Method in class org.apache.commons.math3.util.BigReal
Get the BigDecimal value corresponding to the instance.
BigFraction - Class in org.apache.commons.math3.fraction
Representation of a rational number without any overflow.
BigFraction(BigInteger) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction equivalent to the passed BigInteger, ie "num / 1".
BigFraction(BigInteger, BigInteger) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction given the numerator and denominator as BigInteger.
BigFraction(double) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a fraction given the double value.
BigFraction(double, double, int) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a fraction given the double value and maximum error allowed.
BigFraction(double, int) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a fraction given the double value and maximum denominator.
BigFraction(int) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction equivalent to the passed int, ie "num / 1".
BigFraction(int, int) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction given the numerator and denominator as simple int.
BigFraction(long) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction equivalent to the passed long, ie "num / 1".
BigFraction(long, long) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction given the numerator and denominator as simple long.
BigFractionField - Class in org.apache.commons.math3.fraction
Representation of the fractional numbers without any overflow field.
BigFractionFormat - Class in org.apache.commons.math3.fraction
Formats a BigFraction number in proper format or improper format.
BigFractionFormat() - Constructor for class org.apache.commons.math3.fraction.BigFractionFormat
Create an improper formatting instance with the default number format for the numerator and denominator.
BigFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.BigFractionFormat
Create an improper formatting instance with a custom number format for both the numerator and denominator.
BigFractionFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.BigFractionFormat
Create an improper formatting instance with a custom number format for the numerator and a custom number format for the denominator.
bigFractionMatrixToRealMatrix(FieldMatrix<BigFraction>) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Convert a FieldMatrix/BigFraction matrix to a RealMatrix.
bigIntegerCounter() - Static method in class org.apache.commons.io.file.Counters
Returns a new BigInteger Counter.
bigIntegerPathCounters() - Static method in class org.apache.commons.io.file.Counters
Returns a new BigInteger PathCounters.
BigReal - Class in org.apache.commons.math3.util
Arbitrary precision decimal number.
BigReal(BigDecimal) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a BigDecimal.
BigReal(BigInteger) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a BigInteger.
BigReal(BigInteger, int) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from an unscaled BigInteger.
BigReal(BigInteger, int, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from an unscaled BigInteger.
BigReal(BigInteger, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a BigInteger.
BigReal(char[]) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a characters representation.
BigReal(char[], int, int) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a characters representation.
BigReal(char[], int, int, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a characters representation.
BigReal(char[], MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a characters representation.
BigReal(double) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a double.
BigReal(double, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a double.
BigReal(int) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from an int.
BigReal(int, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from an int.
BigReal(long) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a long.
BigReal(long, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a long.
BigReal(String) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a String representation.
BigReal(String, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a String representation.
BigRealField - Class in org.apache.commons.math3.util
Representation of real numbers with arbitrary precision field.
BigReals - Class in org.lsmp.djep.groupJep.groups
The field of Reals represented by BigDecimals.
BigReals(int, int) - Constructor for class org.lsmp.djep.groupJep.groups.BigReals
Create a field of BigIntegers.
BigReals(int) - Constructor for class org.lsmp.djep.groupJep.groups.BigReals
Create a BigReals group with round mode set to BigDecimal.ROUND_HALF_DOWN.
bin(DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Fills all cell values of the given vector into a bin from which statistics measures can be retrieved efficiently.
BINARY - Static variable in class org.lsmp.djep.xjep.XOperator
Binary operators, such as x+y, x>y
BinaryChromosome - Class in org.apache.commons.math3.genetics
Chromosome represented by a vector of 0s and 1s.
BinaryChromosome(List<Integer>) - Constructor for class org.apache.commons.math3.genetics.BinaryChromosome
Constructor.
BinaryChromosome(Integer[]) - Constructor for class org.apache.commons.math3.genetics.BinaryChromosome
Constructor.
BinaryFile - Class in jhplot.math.io
BSD License
BinaryFile(File, String) - Constructor for class jhplot.math.io.BinaryFile
 
BinaryInputStream - Class in jhplot.math.io
BSD License
BinaryInputStream(InputStream, String) - Constructor for class jhplot.math.io.BinaryInputStream
 
BinaryInputStream(InputStream, boolean) - Constructor for class jhplot.math.io.BinaryInputStream
 
BinaryMutation - Class in org.apache.commons.math3.genetics
Mutation for BinaryChromosomes.
BinaryMutation() - Constructor for class org.apache.commons.math3.genetics.BinaryMutation
 
BinaryOperatorI - Interface in org.lsmp.djep.vectorJep.function
A matrix enabled binary operator.
BinaryOutputStream - Class in jhplot.math.io
BSD License
BinaryOutputStream(OutputStream, String) - Constructor for class jhplot.math.io.BinaryOutputStream
 
BinaryOutputStream(OutputStream, boolean) - Constructor for class jhplot.math.io.BinaryOutputStream
 
binarySearch(boolean) - Method in class cern.colt.list.AbstractBooleanList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(byte) - Method in class cern.colt.list.AbstractByteList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(char) - Method in class cern.colt.list.AbstractCharList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(double) - Method in class cern.colt.list.AbstractDoubleList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(float) - Method in class cern.colt.list.AbstractFloatList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(int) - Method in class cern.colt.list.AbstractIntList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(long) - Method in class cern.colt.list.AbstractLongList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(short) - Method in class cern.colt.list.AbstractShortList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(Object) - Method in class cern.colt.list.ObjectArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(boolean, int, int) - Method in class cern.colt.list.AbstractBooleanList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(byte, int, int) - Method in class cern.colt.list.AbstractByteList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(char, int, int) - Method in class cern.colt.list.AbstractCharList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(double, int, int) - Method in class cern.colt.list.AbstractDoubleList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(float, int, int) - Method in class cern.colt.list.AbstractFloatList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(int, int, int) - Method in class cern.colt.list.AbstractIntList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(long, int, int) - Method in class cern.colt.list.AbstractLongList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(short, int, int) - Method in class cern.colt.list.AbstractShortList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(byte, int, int) - Method in class cern.colt.list.ByteArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(char, int, int) - Method in class cern.colt.list.CharArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(double, int, int) - Method in class cern.colt.list.DoubleArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(float, int, int) - Method in class cern.colt.list.FloatArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(int, int, int) - Method in class cern.colt.list.IntArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(long, int, int) - Method in class cern.colt.list.LongArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(Object, int, int) - Method in class cern.colt.list.ObjectArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(Object, int, int, Comparator) - Method in class cern.colt.list.ObjectArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(short, int, int) - Method in class cern.colt.list.ShortArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(byte[], byte, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(char[], char, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(double[], double, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(float[], float, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(int[], int, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(long[], long, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(Object[], Object, int, int, Comparator) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(short[], short, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(int, int, IntComparator) - Static method in class cern.colt.Sorting
Generically searches the list for the specified value using the binary search algorithm.
BinBinFunction1D - Interface in cern.hep.aida.bin
Interface that represents a function object: a function that takes two bins as arguments and returns a single value.
binCenter(int) - Method in class jhplot.H1D
Get bin centres.
binCenter(int) - Method in class jhplot.HProf1D
Get bin centres.
binCenters() - Method in class jhplot.H1D
Get all bin centers in form of array
binCenters() - Method in class jhplot.HProf1D
Get all bin centers in form of array
binCentre(int) - Method in class cern.hep.aida.ref.FixedAxis
 
binCentre(int) - Method in class cern.hep.aida.ref.VariableAxis
 
binCentre(int) - Method in interface colt.hep.aida.IAxis
Centre of the bin specified.
bindArg1(DoubleDoubleFunction, double) - Static method in class cern.jet.math.Functions
Constructs a unary function from a binary function with the first operand (argument) fixed to the given constant c.
bindArg1(IntIntFunction, int) - Static method in class cern.jet.math.IntFunctions
Constructs a unary function from a binary function with the first operand (argument) fixed to the given constant c.
bindArg2(DoubleDoubleFunction, double) - Static method in class cern.jet.math.Functions
Constructs a unary function from a binary function with the second operand (argument) fixed to the given constant c.
bindArg2(IntIntFunction, int) - Static method in class cern.jet.math.IntFunctions
Constructs a unary function from a binary function with the second operand (argument) fixed to the given constant c.
bindStream(InputStream) - Method in class org.apache.commons.io.input.DemuxInputStream
Binds the specified stream to the current thread.
bindStream(OutputStream) - Method in class org.apache.commons.io.output.DemuxOutputStream
Binds the specified stream to the current thread.
binEntries(int) - Method in class cern.hep.aida.ref.Histogram1D
 
binEntries(int, int) - Method in class cern.hep.aida.ref.Histogram2D
 
binEntries(int, int, int) - Method in class cern.hep.aida.ref.Histogram3D
 
binEntries(int) - Method in interface colt.hep.aida.IHistogram1D
Number of entries in the corresponding bin (ie the number of times fill was called for this bin).
binEntries(int, int) - Method in interface colt.hep.aida.IHistogram2D
The number of entries (ie the number of times fill was called for this bin).
binEntries(int, int, int) - Method in interface colt.hep.aida.IHistogram3D
The number of entries (ie the number of times fill was called for this bin).
binEntries(int) - Method in class jhplot.H1D
Number of entries in a bin with index i
binEntries() - Method in class jhplot.H1D
Get all entries of the histogram as an array
binEntries(int, int) - Method in class jhplot.H2D
Number of entries in the corresponding bin (i.e.
binEntries(int) - Method in class jhplot.HProf1D
Number of entries in a bin with index i
binEntries() - Method in class jhplot.HProf1D
Get all entries of the histogram as an array
binEntries(int, int) - Method in class jhplot.HProf2D
Number of entries in the corresponding bin (i.e.
binEntriesX(int) - Method in interface colt.hep.aida.IHistogram2D
Equivalent to projectionX().binEntries(indexX).
binEntriesY(int) - Method in interface colt.hep.aida.IHistogram2D
Equivalent to projectionY().binEntries(indexY).
binError(int) - Method in class cern.hep.aida.ref.Histogram1D
 
binError(int, int) - Method in class cern.hep.aida.ref.Histogram2D
 
binError(int, int, int) - Method in class cern.hep.aida.ref.Histogram3D
 
binError(int) - Method in interface colt.hep.aida.IHistogram1D
The error on this bin.
binError(int, int) - Method in interface colt.hep.aida.IHistogram2D
The error on this bin.
binError(int, int, int) - Method in interface colt.hep.aida.IHistogram3D
The error on this bin.
binError(int) - Method in class jhplot.H1D
Error on the bin with index i
binError(int, int) - Method in class jhplot.H2D
Error of the corresponding bin.
binError(int) - Method in class jhplot.HProf1D
Error on the bin with index i
binError(int, int) - Method in class jhplot.HProf2D
Error of the corresponding bin.
binErrors() - Method in class jhplot.H1D
Get all bin errors of the histogram as an array
binErrors() - Method in class jhplot.H2D
Get errors on heights as 2D array.
binErrors() - Method in class jhplot.HProf1D
Get all bin errors of the histogram as an array
BinFunction1D - Interface in cern.hep.aida.bin
Interface that represents a function object: a function that takes two bins as arguments and returns a single value.
BinFunctions1D - Class in cern.hep.aida.bin
Function objects computing dynamic bin aggregations; to be passed to generic methods.
binHeight(int) - Method in class cern.hep.aida.ref.Histogram1D
 
binHeight(int, int) - Method in class cern.hep.aida.ref.Histogram2D
 
binHeight(int, int, int) - Method in class cern.hep.aida.ref.Histogram3D
 
binHeight(int) - Method in interface colt.hep.aida.IHistogram1D
Total height of the corresponding bin (ie the sum of the weights in this bin).
binHeight(int, int) - Method in interface colt.hep.aida.IHistogram2D
Total height of the corresponding bin (ie the sum of the weights in this bin).
binHeight(int, int, int) - Method in interface colt.hep.aida.IHistogram3D
Total height of the corresponding bin (ie the sum of the weights in this bin).
binHeight(int) - Method in class jhplot.H1D
Height of the corresponding bin
binHeight(int, int) - Method in class jhplot.H2D
Total height of the corresponding bin.
binHeight(int) - Method in class jhplot.HProf1D
Height of the corresponding bin
binHeight(int, int) - Method in class jhplot.HProf2D
Total height of the corresponding bin.
binHeights() - Method in class jhplot.H1D
Get all heights of the histogram as an array
binHeights() - Method in class jhplot.H2D
Get bin heights as 2D array.
binHeights() - Method in class jhplot.HProf1D
Get all heights of the histogram as an array
binHeightX(int) - Method in interface colt.hep.aida.IHistogram2D
Equivalent to projectionX().binHeight(indexX).
binHeightY(int) - Method in interface colt.hep.aida.IHistogram2D
Equivalent to projectionY().binHeight(indexY).
binLowerEdge(int) - Method in class cern.hep.aida.ref.FixedAxis
 
binLowerEdge(int) - Method in class cern.hep.aida.ref.VariableAxis
 
binLowerEdge(int) - Method in interface colt.hep.aida.IAxis
Lower edge of the specified bin.
binLowerEdge(int) - Method in class jhplot.H1D
Get bin lower edge.
binLowerEdge(int) - Method in class jhplot.HProf1D
Get bin lower edge.
binLowerEdges() - Method in class jhplot.H1D
Get all lower edges in form of array
binLowerEdges() - Method in class jhplot.HProf1D
Get all lower edges in form of array
binMean(int) - Method in class jhplot.H1D
Mean in a single bin with index
binMean(int) - Method in class jhplot.HProf1D
Mean in a single bin with index
binMeans(int, int) - Method in class jhplot.H2D
Get bin mean position at the location (i,i)
binMeansX() - Method in class jhplot.H2D
Get mean position for X axis as 2D array.
binMeansY() - Method in class jhplot.H2D
Get mean position for Y axis as 2D array.
binOfElement(float) - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns the bin index of the given element.
binom(int, int) - Static method in class org.nfunk.jep.function.Binomial
Returns the binomial coefficients.
binomial(double, long) - Static method in class cern.jet.math.Arithmetic
Efficiently returns the binomial coefficient, often also referred to as "n over k" or "n choose k".
binomial(long, long) - Static method in class cern.jet.math.Arithmetic
Efficiently returns the binomial coefficient, often also referred to as "n over k" or "n choose k".
Binomial - Class in cern.jet.random
Binomial distribution; See the math definition and animated definition.
Binomial(int, double, RandomEngine) - Constructor for class cern.jet.random.Binomial
Constructs a binomial distribution.
binomial(int, int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the terms 0 through k of the Binomial probability density.
Binomial - Class in jhplot.math.num.pdf
The Binomial distribution.
Binomial() - Constructor for class jhplot.math.num.pdf.Binomial
Default constructor.
Binomial(int, double) - Constructor for class jhplot.math.num.pdf.Binomial
Create a distribution with the given number of trials and probability of success.
binomial(long, long) - Static method in class org.lsmp.djep.xjep.XMath
 
binomial(XMath.LongPair) - Static method in class org.lsmp.djep.xjep.XMath
 
Binomial - Class in org.nfunk.jep.function
Binomial coeficients: binom(n,i).
Binomial() - Constructor for class org.nfunk.jep.function.Binomial
 
binomialCoefficient(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
binomialCoefficient(int, int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Returns an exact representation of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialCoefficientDouble(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
binomialCoefficientDouble(int, int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Returns a double representation of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialCoefficientLog(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
binomialCoefficientLog(int, int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Returns the natural log of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialComplemented(int, int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the terms k+1 through n of the Binomial probability density.
BinomialConfidenceInterval - Interface in org.apache.commons.math3.stat.interval
Interface to generate confidence intervals for a binomial proportion.
BinomialDistribution - Class in org.apache.commons.math3.distribution
Implementation of the binomial distribution.
BinomialDistribution(int, double) - Constructor for class org.apache.commons.math3.distribution.BinomialDistribution
Create a binomial distribution with the given number of trials and probability of success.
BinomialDistribution(RandomGenerator, int, double) - Constructor for class org.apache.commons.math3.distribution.BinomialDistribution
Creates a binomial distribution.
BinomialRandomVariable - Class in jhplot.math.num.random
 
BinomialRandomVariable() - Constructor for class jhplot.math.num.random.BinomialRandomVariable
Default constructor.
BinomialRandomVariable(int, double) - Constructor for class jhplot.math.num.random.BinomialRandomVariable
Create a random variable with the given number of trials and probability of success.
BinomialRandomVariable(int, double, RNG) - Constructor for class jhplot.math.num.random.BinomialRandomVariable
Create a random variable with the given parameters.
BinomialTest - Class in org.apache.commons.math3.stat.inference
Implements binomial test statistics.
BinomialTest() - Constructor for class org.apache.commons.math3.stat.inference.BinomialTest
 
binomialTest(int, int, double, AlternativeHypothesis, double) - Method in class org.apache.commons.math3.stat.inference.BinomialTest
Returns whether the null hypothesis can be rejected with the given confidence level.
binomialTest(int, int, double, AlternativeHypothesis) - Method in class org.apache.commons.math3.stat.inference.BinomialTest
Returns the observed significance level, or p-value, associated with a Binomial test.
binRms(int) - Method in class jhplot.H1D
RMS of a single bin with index
binRms(int) - Method in class jhplot.HProf1D
RMS of a single bin with index
bins() - Method in class cern.hep.aida.ref.FixedAxis
 
bins() - Method in class cern.hep.aida.ref.VariableAxis
 
bins() - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns the number of bins.
bins() - Method in interface colt.hep.aida.IAxis
The number of bins (excluding underflow and overflow) on the axis.
BINS_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
binUpperEdge(int) - Method in class cern.hep.aida.ref.FixedAxis
 
binUpperEdge(int) - Method in class cern.hep.aida.ref.VariableAxis
 
binUpperEdge(int) - Method in interface colt.hep.aida.IAxis
Upper edge of the specified bin.
binUpperEdge(int) - Method in class jhplot.H1D
Get bin upper edge.
binUpperEdge(int) - Method in class jhplot.HProf1D
Get bin upper edge.
binUpperEdges() - Method in class jhplot.H1D
Get all upper edges in form of array
binUpperEdges() - Method in class jhplot.HProf1D
Get all upper edges in form of array
binWidth(int) - Method in class cern.hep.aida.ref.FixedAxis
 
binWidth(int) - Method in class cern.hep.aida.ref.VariableAxis
 
binWidth(int) - Method in interface colt.hep.aida.IAxis
Width of the bin specified.
BisectionRootFinder - Class in jhplot.math.num.root
The bisection method (1) for finding roots of functions.
BisectionRootFinder(Function) - Constructor for class jhplot.math.num.root.BisectionRootFinder
Create a root finder for the given function.
BisectionRootFinder(Function, int, double) - Constructor for class jhplot.math.num.root.BisectionRootFinder
Create a root finder for the given function.
BisectionSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the bisection algorithm for finding zeros of univariate real functions.
BisectionSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.BisectionSolver
Construct a solver with default accuracy (1e-6).
BisectionSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.BisectionSolver
Construct a solver.
BisectionSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.BisectionSolver
Construct a solver.
BITBackscatter - Static variable in interface hep.lcio.event.MCParticle
 
BITCreatedInSimulation - Static variable in interface hep.lcio.event.MCParticle
 
BITDecayedInCalorimeter - Static variable in interface hep.lcio.event.MCParticle
 
BITDecayedInTracker - Static variable in interface hep.lcio.event.MCParticle
 
BITDefault - Static variable in interface hep.lcio.event.LCCollection
 
BITEndpoint - Static variable in interface hep.lcio.event.MCParticle
 
BITLeftDetector - Static variable in interface hep.lcio.event.MCParticle
 
bitMaskWithBitsSetFromTo(int, int) - Static method in class cern.colt.bitvector.QuickBitVector
Returns a bit mask with bits in the specified range set to 1, all the rest set to 0.
BitMatrix - Class in cern.colt.bitvector
Fixed sized (non resizable) n*m bit matrix.
BitMatrix(int, int) - Constructor for class cern.colt.bitvector.BitMatrix
Constructs a bit matrix with a given number of columns and rows.
BITOverlay - Static variable in interface hep.lcio.event.MCParticle
 
BITOverlay - Static variable in interface hep.lcio.event.SimTrackerHit
 
BITProducedBySecondary - Static variable in interface hep.lcio.event.SimTrackerHit
 
bitSet(int) - Method in interface hep.lcio.event.LCFlag
Returns true if bit at given index is set.
bitSizeForSignedValue(int) - Static method in class net.jafama.NumbersUtils
 
bitSizeForSignedValue(long) - Static method in class net.jafama.NumbersUtils
 
bitSizeForUnsignedValue(int) - Static method in class net.jafama.NumbersUtils
 
bitSizeForUnsignedValue(long) - Static method in class net.jafama.NumbersUtils
 
bitsPerElement() - Method in class cern.colt.list.MinMaxNumberList
Returns the number of bits necessary to store a single element.
bitsPerElement(long, long) - Static method in class cern.colt.list.MinMaxNumberList
Returns the number of bits necessary to store values in the range [minimum,maximum].
BitsStreamGenerator - Class in org.apache.commons.math3.random
Base class for random number generators that generates bits streams.
BitsStreamGenerator() - Constructor for class org.apache.commons.math3.random.BitsStreamGenerator
Creates a new random number generator.
BITStopped - Static variable in interface hep.lcio.event.MCParticle
 
BITSubset - Static variable in interface hep.lcio.event.LCCollection
 
BITTransient - Static variable in interface hep.lcio.event.LCCollection
Transient bit in flag word.
BitVector - Class in cern.colt.bitvector
Fixed sized (non resizable) bitvector.
BitVector(long[], int) - Constructor for class cern.colt.bitvector.BitVector
You normally need not use this method.
BitVector(int) - Constructor for class cern.colt.bitvector.BitVector
Constructs a bit vector that holds size bits.
BITVertexIsNotEndpointOfParent - Static variable in interface hep.lcio.event.MCParticle
 
BivariateFunction - Interface in org.apache.commons.math3.analysis
An interface representing a bivariate real function.
BivariateGridInterpolator - Interface in org.apache.commons.math3.analysis.interpolation
Interface representing a bivariate real interpolating function where the sample points must be specified on a regular grid.
BJETS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent
 
Blas - Interface in cern.colt.matrix.linalg
Subset of the BLAS (Basic Linear Algebra System); High quality "building block" routines for performing basic vector and matrix operations.
blendColors(Color, Color, double) - Static method in class jplot3d.Utils
 
Block - Class in Jampack
Block contains a static method for partitioning a matrix.
Block() - Constructor for class Jampack.Block
 
Block - Interface in org.jfree.chart.block
A block is an arbitrary item that can be drawn (in Java2D space) within a rectangular area, has a preferred size, and can be arranged by an Arrangement manager.
BLOCK_SIZE - Static variable in class org.apache.commons.math3.linear.BlockFieldMatrix
Block size.
BLOCK_SIZE - Static variable in class org.apache.commons.math3.linear.BlockRealMatrix
Block size.
BlockBorder - Class in org.jfree.chart.block
A border for a block.
BlockBorder() - Constructor for class org.jfree.chart.block.BlockBorder
Creates a default border.
BlockBorder(Paint) - Constructor for class org.jfree.chart.block.BlockBorder
Creates a new border with the specified color.
BlockBorder(double, double, double, double) - Constructor for class org.jfree.chart.block.BlockBorder
Creates a new border with the specified line widths (in black).
BlockBorder(double, double, double, double, Paint) - Constructor for class org.jfree.chart.block.BlockBorder
Creates a new border with the specified line widths (in black).
BlockBorder(RectangleInsets, Paint) - Constructor for class org.jfree.chart.block.BlockBorder
Creates a new border.
BlockContainer - Class in org.jfree.chart.block
A container for a collection of Block objects.
BlockContainer() - Constructor for class org.jfree.chart.block.BlockContainer
Creates a new instance with default settings.
BlockContainer(Arrangement) - Constructor for class org.jfree.chart.block.BlockContainer
Creates a new instance with the specified arrangement.
BlockFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Cache-friendly implementation of FieldMatrix using a flat arrays to store square blocks of the matrix.
BlockFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.BlockFieldMatrix
Create a new matrix with the supplied row and column dimensions.
BlockFieldMatrix(T[][]) - Constructor for class org.apache.commons.math3.linear.BlockFieldMatrix
Create a new dense matrix copying entries from raw layout data.
BlockFieldMatrix(int, int, T[][], boolean) - Constructor for class org.apache.commons.math3.linear.BlockFieldMatrix
Create a new dense matrix copying entries from block layout data.
BlockFrame - Interface in org.jfree.chart.block
A block frame is a type of border that can be drawn around the outside of any AbstractBlock.
blockInverse(RealMatrix, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Computes the inverse of the given matrix by splitting it into 4 sub-matrices.
BlockParams - Class in org.jfree.chart.block
A standard parameter object that can be passed to the draw() method defined by the Block class.
BlockParams() - Constructor for class org.jfree.chart.block.BlockParams
Creates a new instance.
BlockRealMatrix - Class in org.apache.commons.math3.linear
Cache-friendly implementation of RealMatrix using a flat arrays to store square blocks of the matrix.
BlockRealMatrix(int, int) - Constructor for class org.apache.commons.math3.linear.BlockRealMatrix
Create a new matrix with the supplied row and column dimensions.
BlockRealMatrix(double[][]) - Constructor for class org.apache.commons.math3.linear.BlockRealMatrix
Create a new dense matrix copying entries from raw layout data.
BlockRealMatrix(int, int, double[][], boolean) - Constructor for class org.apache.commons.math3.linear.BlockRealMatrix
Create a new dense matrix copying entries from block layout data.
BlockResult - Class in org.jfree.chart.block
Used to return results from the draw() method in the Block class.
BlockResult() - Constructor for class org.jfree.chart.block.BlockResult
Creates a new result instance.
BlockStatments - Class in org.lsmp.djepExamples
Example code illustrating how block control structures could be implemented.
BlockStatments() - Constructor for class org.lsmp.djepExamples.BlockStatments
 
blue3D - Static variable in class org.jlab.groot.base.ColorPalette
 
BOBYQAOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
Powell's BOBYQA algorithm.
BOBYQAOptimizer(int) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
 
BOBYQAOptimizer(int, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
 
BOBYQAOptimizer - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
BOBYQAOptimizer(int) - Constructor for class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
Deprecated.
 
BOBYQAOptimizer(int, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
Deprecated.
 
Bohr_radius - Static variable in class cern.clhep.PhysicalConstants
 
BOLTZMAN - Static variable in class graph.SpecialFunction
Boltzman Constant.
BOMInputStream - Class in org.apache.commons.io.input
This class is used to wrap a stream that includes an encoded ByteOrderMark as its first bytes.
BOMInputStream(InputStream) - Constructor for class org.apache.commons.io.input.BOMInputStream
Constructs a new BOM InputStream that excludes a ByteOrderMark.UTF_8 BOM.
BOMInputStream(InputStream, boolean) - Constructor for class org.apache.commons.io.input.BOMInputStream
Constructs a new BOM InputStream that detects a a ByteOrderMark.UTF_8 and optionally includes it.
BOMInputStream(InputStream, ByteOrderMark...) - Constructor for class org.apache.commons.io.input.BOMInputStream
Constructs a new BOM InputStream that excludes the specified BOMs.
BOMInputStream(InputStream, boolean, ByteOrderMark...) - Constructor for class org.apache.commons.io.input.BOMInputStream
Constructs a new BOM InputStream that detects the specified BOMs and optionally includes them.
BooleanArrayList - Class in cern.colt.list
Resizable list holding boolean elements; implemented with arrays.
BooleanArrayList() - Constructor for class cern.colt.list.BooleanArrayList
Constructs an empty list.
BooleanArrayList(boolean[]) - Constructor for class cern.colt.list.BooleanArrayList
Constructs a list containing the specified elements.
BooleanArrayList(int) - Constructor for class cern.colt.list.BooleanArrayList
Constructs an empty list with the specified initial capacity.
BooleanProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
boost(HepLorentzVector, Hep3Vector) - Static method in class hep.physics.vec.VecOp
Boost fourVector with boostVector.
boost(HepLorentzVector, HepLorentzVector) - Static method in class hep.physics.vec.VecOp
Boost fourVector into system of refFourVector.
boost(HEParticle) - Method in class hephysics.particle.HEParticle
Lorentz Boost
boost(LParticle) - Method in class hephysics.particle.LParticle
Lorentz Boost
boost(HepLorentzVector, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Boost fourVector with boostVector.
boost(HepLorentzVector, HepLorentzVector) - Method in class hephysics.vec.Hep3Vector
Boost fourVector into system of refFourVector.
boost(double, double, double) - Method in class hephysics.vec.HepLorentzVector
Lorentz Boost using 3-vector
boost(HepLorentzVector, Hep3Vector) - Method in class hephysics.vec.HepLorentzVector
Boost fourVector with boostVector.
boost(HepLorentzVector, HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Boost fourVector into system of refFourVector.
boost(HepLorentzVector, Hep3Vector) - Static method in class hephysics.vec.VecOp
Boost fourVector with boostVector.
boost(HepLorentzVector, HepLorentzVector) - Static method in class hephysics.vec.VecOp
Boost fourVector into system of refFourVector.
boost(double, double, double) - Method in class j4np.physics.LorentzVector
 
boost(Vector3) - Method in class j4np.physics.LorentzVector
 
boostVector() - Method in class j4np.physics.LorentzVector
 
bootstrap(double[], double[], int, boolean) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Estimates the p-value of a two-sample Kolmogorov-Smirnov test evaluating the null hypothesis that x and y are samples drawn from the same probability distribution.
bootstrap(double[], double[], int) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Computes bootstrap(x, y, iterations, true).
BorderArrangement - Class in org.jfree.chart.block
An arrangement manager that lays out blocks in a similar way to Swing's BorderLayout class.
BorderArrangement() - Constructor for class org.jfree.chart.block.BorderArrangement
Creates a new instance.
borderBottom - Variable in class graph.Graph2D
The width of the border at the bottom of the canvas.
borderLeft - Variable in class graph.Graph2D
The width of the border at the left of the canvas.
borderRight - Variable in class graph.Graph2D
The width of the border at the right of the canvas.
borderTop - Variable in class graph.Graph2D
The width of the border at the top of the canvas.
BOTTOM - Static variable in class graph.Axis
Constant flagging Axis position on the graph.
BOTTOM_OR_LEFT - Static variable in class org.jfree.chart.axis.AxisLocation
Axis at the bottom or left.
BOTTOM_OR_RIGHT - Static variable in class org.jfree.chart.axis.AxisLocation
Axis at the bottom or right.
BoundaryAttribute<S extends Space> - Class in org.apache.commons.math3.geometry.partitioning
Class holding boundary attributes.
BoundaryAttribute(SubHyperplane<S>, SubHyperplane<S>) - Constructor for class org.apache.commons.math3.geometry.partitioning.BoundaryAttribute
Deprecated.
as of 3.4, the constructor has been replaced by a new one which is not public anymore, as it is intended to be used only by BoundaryBuilder
BoundaryProjection<S extends Space> - Class in org.apache.commons.math3.geometry.partitioning
Class holding the result of point projection on region boundary.
BoundaryProjection(Point<S>, Point<S>, double) - Constructor for class org.apache.commons.math3.geometry.partitioning.BoundaryProjection
Constructor from raw elements.
BoundedInputStream - Class in org.apache.commons.io.input
This is a stream that will only supply bytes up to a certain length - if its position goes above that, it will stop.
BoundedInputStream(InputStream, long) - Constructor for class org.apache.commons.io.input.BoundedInputStream
Creates a new BoundedInputStream that wraps the given input stream and limits it to a certain size.
BoundedInputStream(InputStream) - Constructor for class org.apache.commons.io.input.BoundedInputStream
Creates a new BoundedInputStream that wraps the given input stream and is unlimited.
BoundedReader - Class in org.apache.commons.io.input
A reader that imposes a limit to the number of characters that can be read from an underlying reader, returning EOF when this limit is reached, regardless of state of underlying reader.
BoundedReader(Reader, int) - Constructor for class org.apache.commons.io.input.BoundedReader
Constructs a bounded reader
boundedToUnbounded(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
Maps an array from bounded to unbounded.
boundedToUnbounded(double[]) - Method in class org.apache.commons.math3.optimization.direct.MultivariateFunctionMappingAdapter
Deprecated.
Map an array from bounded to unbounded.
BoxAndWhiskerCalculator - Class in org.jfree.data.statistics
A utility class that calculates the mean, median, quartiles Q1 and Q3, plus a list of outlier values...all from an arbitrary list of Number objects.
BoxAndWhiskerCalculator() - Constructor for class org.jfree.data.statistics.BoxAndWhiskerCalculator
 
BoxAndWhiskerCategoryDataset - Interface in org.jfree.data.statistics
A category dataset that defines various medians, outliers and an average value for each item.
BoxAndWhiskerItem - Class in org.jfree.data.statistics
Represents one data item within a box-and-whisker dataset.
BoxAndWhiskerItem(Number, Number, Number, Number, Number, Number, Number, Number, List) - Constructor for class org.jfree.data.statistics.BoxAndWhiskerItem
Creates a new box-and-whisker item.
BoxAndWhiskerItem(double, double, double, double, double, double, double, double, List) - Constructor for class org.jfree.data.statistics.BoxAndWhiskerItem
Creates a new box-and-whisker item.
BoxAndWhiskerRenderer - Class in org.jfree.chart.renderer.category
A box-and-whisker renderer.
BoxAndWhiskerRenderer() - Constructor for class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Default constructor.
BoxAndWhiskerToolTipGenerator - Class in org.jfree.chart.labels
An item label generator for plots that use data from a BoxAndWhiskerCategoryDataset.
BoxAndWhiskerToolTipGenerator() - Constructor for class org.jfree.chart.labels.BoxAndWhiskerToolTipGenerator
Creates a default tool tip generator.
BoxAndWhiskerToolTipGenerator(String, NumberFormat) - Constructor for class org.jfree.chart.labels.BoxAndWhiskerToolTipGenerator
Creates a tool tip formatter.
BoxAndWhiskerXYDataset - Interface in org.jfree.data.statistics
An interface that defines data in the form of (x, max, min, average, median) tuples.
BoxAndWhiskerXYToolTipGenerator - Class in org.jfree.chart.labels
An item label generator for plots that use data from a BoxAndWhiskerXYDataset.
BoxAndWhiskerXYToolTipGenerator() - Constructor for class org.jfree.chart.labels.BoxAndWhiskerXYToolTipGenerator
Creates a default item label generator.
BoxAndWhiskerXYToolTipGenerator(String, DateFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.BoxAndWhiskerXYToolTipGenerator
Creates a new item label generator.
BOXED_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
BoxOptions() - Constructor for class jplot.panels.PanelAxes.BoxOptions
Principal constructor.
bq(Zmat) - Method in class Jampack.Zhqrd
Computes the product BQ.
bqh(Zmat, Zmat) - Method in class Jampack.Zhqrd
Computes the product BQH.
BRACE_CLOSE - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
BRACE_OPEN - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
Bracket - Class in jhplot.math.num.root
Simple root bracketing routine.
Bracket(Function) - Constructor for class jhplot.math.num.root.Bracket
Create a root bracketer for the given function.
Bracket(Function, int) - Constructor for class jhplot.math.num.root.Bracket
Create a root bracketer for the given function.
bracket(UnivariateFunction, double, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
This method simply calls bracket(function, initial, lowerBound, upperBound, q, r, maximumIterations) with q and r set to 1.0 and maximumIterations set to Integer.MAX_VALUE.
bracket(UnivariateFunction, double, double, double, int) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
This method simply calls bracket(function, initial, lowerBound, upperBound, q, r, maximumIterations) with q and r set to 1.0.
bracket(UnivariateFunction, double, double, double, double, double, int) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
This method attempts to find two values a and b satisfying lowerBound <= a < initial < b <= upperBound f(a) * f(b) <= 0 If f is continuous on [a,b], this means that a and b bracket a root of f.
BracketedRealFieldUnivariateSolver<T extends RealFieldElement<T>> - Interface in org.apache.commons.math3.analysis.solvers
Interface for (univariate real) root-finding algorithms that maintain a bracketed solution.
BracketedUnivariateSolver<FUNC extends UnivariateFunction> - Interface in org.apache.commons.math3.analysis.solvers
Interface for (univariate real) root-finding algorithms that maintain a bracketed solution.
BracketFinder - Class in org.apache.commons.math3.optim.univariate
Provide an interval that brackets a local optimum of a function.
BracketFinder() - Constructor for class org.apache.commons.math3.optim.univariate.BracketFinder
Constructor with default values 100, 500 (see the other constructor).
BracketFinder(double, int) - Constructor for class org.apache.commons.math3.optim.univariate.BracketFinder
Create a bracketing interval finder.
BracketFinder - Class in org.apache.commons.math3.optimization.univariate
Deprecated.
As of 3.1 (to be removed in 4.0).
BracketFinder() - Constructor for class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.
Constructor with default values 100, 50 (see the other constructor).
BracketFinder(double, int) - Constructor for class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.
Create a bracketing interval finder.
BracketingNthOrderBrentSolver - Class in org.apache.commons.math3.analysis.solvers
This class implements a modification of the Brent algorithm.
BracketingNthOrderBrentSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Construct a solver with default accuracy and maximal order (1e-6 and 5 respectively)
BracketingNthOrderBrentSolver(double, int) - Constructor for class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Construct a solver.
BracketingNthOrderBrentSolver(double, double, int) - Constructor for class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Construct a solver.
BracketingNthOrderBrentSolver(double, double, double, int) - Constructor for class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Construct a solver.
BracketingNthOrderBrentSolverDFP - Class in org.apache.commons.math3.dfp
Deprecated.
as of 3.6 replaced with FieldBracketingNthOrderBrentSolver
BracketingNthOrderBrentSolverDFP(Dfp, Dfp, Dfp, int) - Constructor for class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Deprecated.
Construct a solver.
BracketingStep(double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.BracketingStep
Deprecated.
 
bracketOut(double, double, double) - Method in class jhplot.math.num.root.Bracket
Bracket a root for the target function by creating and continuously expanding an interval around the initial point until the interval is known to contain at least one root.
Branch - Class in org.jlab.groot.tree
 
Branch(String, String, String) - Constructor for class org.jlab.groot.tree.Branch
 
Branch(String) - Constructor for class org.jlab.groot.tree.Branch
 
BRAY_CURTIS - Static variable in class cern.colt.matrix.doublealgo.Statistic
Bray-Curtis distance function; Sum( abs(x[i]-y[i]) ) / Sum( x[i]+y[i] ).
BreitWigner - Class in cern.jet.random
BreitWigner (aka Lorentz) distribution; See the math definition.
BreitWigner(double, double, double, RandomEngine) - Constructor for class cern.jet.random.BreitWigner
Constructs a BreitWigner distribution.
BreitWigner - Class in jhplot.fit
Build a Breit-Wigner distribution.
BreitWigner() - Constructor for class jhplot.fit.BreitWigner
 
BreitWigner(String) - Constructor for class jhplot.fit.BreitWigner
 
BreitWigner(String[], String[]) - Constructor for class jhplot.fit.BreitWigner
 
BreitWignerMeanSquare - Class in cern.jet.random
Mean-square BreitWigner distribution; See the math definition.
BreitWignerMeanSquare(double, double, double, RandomEngine) - Constructor for class cern.jet.random.BreitWignerMeanSquare
Constructs a mean-squared BreitWigner distribution.
BrentOptimizer - Class in org.apache.commons.math3.optim.univariate
For a function defined on some interval (lo, hi), this class finds an approximation x to the point at which the function attains its minimum.
BrentOptimizer(double, double, ConvergenceChecker<UnivariatePointValuePair>) - Constructor for class org.apache.commons.math3.optim.univariate.BrentOptimizer
The arguments are used implement the original stopping criterion of Brent's algorithm.
BrentOptimizer(double, double) - Constructor for class org.apache.commons.math3.optim.univariate.BrentOptimizer
The arguments are used for implementing the original stopping criterion of Brent's algorithm.
BrentOptimizer - Class in org.apache.commons.math3.optimization.univariate
Deprecated.
As of 3.1 (to be removed in 4.0).
BrentOptimizer(double, double, ConvergenceChecker<UnivariatePointValuePair>) - Constructor for class org.apache.commons.math3.optimization.univariate.BrentOptimizer
Deprecated.
The arguments are used implement the original stopping criterion of Brent's algorithm.
BrentOptimizer(double, double) - Constructor for class org.apache.commons.math3.optimization.univariate.BrentOptimizer
Deprecated.
The arguments are used for implementing the original stopping criterion of Brent's algorithm.
BrentRootFinder - Class in jhplot.math.num.root
Brent's method (1) for finding roots of functions.
BrentRootFinder(Function) - Constructor for class jhplot.math.num.root.BrentRootFinder
Create a root finder for the given function.
BrentRootFinder(Function, int, double) - Constructor for class jhplot.math.num.root.BrentRootFinder
Create a root finder for the given function.
BrentSolver - Class in org.apache.commons.math3.analysis.solvers
This class implements the Brent algorithm for finding zeros of real univariate functions.
BrentSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.BrentSolver
Construct a solver with default absolute accuracy (1e-6).
BrentSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.BrentSolver
Construct a solver.
BrentSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.BrentSolver
Construct a solver.
BrentSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.BrentSolver
Construct a solver.
BrokenInputStream - Class in org.apache.commons.io.input
Broken input stream.
BrokenInputStream(IOException) - Constructor for class org.apache.commons.io.input.BrokenInputStream
Creates a new stream that always throws the given exception.
BrokenInputStream() - Constructor for class org.apache.commons.io.input.BrokenInputStream
Creates a new stream that always throws an IOException
BrokenOutputStream - Class in org.apache.commons.io.output
Broken output stream.
BrokenOutputStream(IOException) - Constructor for class org.apache.commons.io.output.BrokenOutputStream
Creates a new stream that always throws the given exception.
BrokenOutputStream() - Constructor for class org.apache.commons.io.output.BrokenOutputStream
Creates a new stream that always throws an IOException
BrokenReader - Class in org.apache.commons.io.input
Broken reader.
BrokenReader(IOException) - Constructor for class org.apache.commons.io.input.BrokenReader
Creates a new reader that always throws the given exception.
BrokenReader() - Constructor for class org.apache.commons.io.input.BrokenReader
Creates a new reader that always throws an IOException
BrokenWriter - Class in org.apache.commons.io.output
Broken writer.
BrokenWriter(IOException) - Constructor for class org.apache.commons.io.output.BrokenWriter
Creates a new writer that always throws the given exception.
BrokenWriter() - Constructor for class org.apache.commons.io.output.BrokenWriter
Creates a new writer that always throws an IOException
BrowserHTML - Class in jhplot.utils
Simple Web browser" using Swing.
BrowserHTML(URL) - Constructor for class jhplot.utils.BrowserHTML
 
BrushStroke - Class in org.jlab.groot.base
 
BrushStroke(double) - Constructor for class org.jlab.groot.base.BrushStroke
 
bShowAxes - Variable in class jplot3dp.ModelView
 
BSPTree<S extends Space> - Class in org.apache.commons.math3.geometry.partitioning
This class represent a Binary Space Partition tree.
BSPTree() - Constructor for class org.apache.commons.math3.geometry.partitioning.BSPTree
Build a tree having only one root cell representing the whole space.
BSPTree(Object) - Constructor for class org.apache.commons.math3.geometry.partitioning.BSPTree
Build a tree having only one root cell representing the whole space.
BSPTree(SubHyperplane<S>, BSPTree<S>, BSPTree<S>, Object) - Constructor for class org.apache.commons.math3.geometry.partitioning.BSPTree
Build a BSPTree from its underlying elements.
BSPTree.LeafMerger<S extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface gather the merging operations between a BSP tree leaf and another BSP tree.
BSPTree.VanishingCutHandler<S extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface handles the corner cases when an internal node cut sub-hyperplane vanishes.
BSPTreeVisitor<S extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface is used to visit BSP tree nodes.
BSPTreeVisitor.Order - Enum in org.apache.commons.math3.geometry.partitioning
Enumerate for visit order with respect to plus sub-tree, minus sub-tree and cut sub-hyperplane.
BTAG_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.BLJets
 
BTAG_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.GenJets
 
BTAG_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Jets
 
BubbleXYItemLabelGenerator - Class in org.jfree.chart.labels
An item label generator defined for use with the XYBubbleRenderer class, or any other class that uses an XYZDataset.
BubbleXYItemLabelGenerator() - Constructor for class org.jfree.chart.labels.BubbleXYItemLabelGenerator
Creates a new tool tip generator using default number formatters for the x, y and z-values.
BubbleXYItemLabelGenerator(String, NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.BubbleXYItemLabelGenerator
Constructs a new tool tip generator using the specified number formatters.
BubbleXYItemLabelGenerator(String, DateFormat, DateFormat, DateFormat) - Constructor for class org.jfree.chart.labels.BubbleXYItemLabelGenerator
Constructs a new item label generator using the specified date formatters.
buffer(InputStream) - Static method in class org.apache.commons.io.IOUtils
Returns the given InputStream if it is already a BufferedInputStream, otherwise creates a BufferedInputStream from the given InputStream.
buffer(InputStream, int) - Static method in class org.apache.commons.io.IOUtils
Returns the given InputStream if it is already a BufferedInputStream, otherwise creates a BufferedInputStream from the given InputStream.
buffer(OutputStream) - Static method in class org.apache.commons.io.IOUtils
Returns the given OutputStream if it is already a BufferedOutputStream, otherwise creates a BufferedOutputStream from the given OutputStream.
buffer(OutputStream, int) - Static method in class org.apache.commons.io.IOUtils
Returns the given OutputStream if it is already a BufferedOutputStream, otherwise creates a BufferedOutputStream from the given OutputStream.
buffer(Reader) - Static method in class org.apache.commons.io.IOUtils
Returns the given reader if it is already a BufferedReader, otherwise creates a BufferedReader from the given reader.
buffer(Reader, int) - Static method in class org.apache.commons.io.IOUtils
Returns the given reader if it is already a BufferedReader, otherwise creates a BufferedReader from the given reader.
buffer(Writer) - Static method in class org.apache.commons.io.IOUtils
Returns the given Writer if it is already a BufferedWriter, otherwise creates a BufferedWriter from the given Writer.
buffer(Writer, int) - Static method in class org.apache.commons.io.IOUtils
Returns the given Writer if it is already a BufferedWriter, otherwise creates a BufferedWriter from the given Writer.
buffered(int) - Method in class cern.hep.aida.bin.AbstractBin1D
Constructs and returns a streaming buffer connected to the receiver.
bufpos - Variable in class jplot3dp.MathParser.SimpleCharStream
 
bufpos - Variable in class org.nfunk.jep.JavaCharStream
 
BugsTest - Class in org.nfunk.jeptesting
This class is intended to contain all tests related to reported bugs.
BugsTest(String) - Constructor for class org.nfunk.jeptesting.BugsTest
Creates a new BugsTest instance
build() - Method in class jhplot.math.exp4j.ExpressionBuilder
Build the Expression instance using the custom operators and functions set.
build() - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Construct a LeastSquaresProblem from the data in this builder.
build(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Build an initial simplex.
build(double[]) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated.
Build an initial simplex.
build() - Method in class org.jlab.groot.matrix.SparseGridBuilder
 
build() - Method in class proeic.io.ProMC.ProMCEvent.Builder
 
build() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
 
build() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
 
build() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
 
build() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
 
build() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
build() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
build() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
build() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
 
build() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
 
build() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
 
build() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
build() - Method in class promc.io.PBufFile.Record.Builder
 
build() - Method in class promc.io.PBufFile.Record.F1D.Builder
 
build() - Method in class promc.io.PBufFile.Record.F2D.Builder
 
build() - Method in class promc.io.PBufFile.Record.FND.Builder
 
build() - Method in class promc.io.PBufFile.Record.FPR.Builder
 
build() - Method in class promc.io.PBufFile.Record.H1D.Builder
 
build() - Method in class promc.io.PBufFile.Record.H2D.Builder
 
build() - Method in class promc.io.PBufFile.Record.P0D.Builder
 
build() - Method in class promc.io.PBufFile.Record.P0I.Builder
 
build() - Method in class promc.io.PBufFile.Record.P1D.Builder
 
build() - Method in class promc.io.PBufFile.Record.PND.Builder
 
build() - Method in class promc.io.PBufFile.Record.PNI.Builder
 
build() - Method in class promc.io.PBufFile.Record.PXY.Builder
 
build() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
 
build() - Method in class promc.io.PEventFile.HEvent.Builder
 
build() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
 
build() - Method in class promc.io.PEventFile.HEvent.Group.Builder
 
build() - Method in class promc.io.ProMC.ProMCEvent.Builder
 
build() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
 
build() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
 
build() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
 
build() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
 
build() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
build() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
build() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
build() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
 
build() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
build() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
 
build() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
 
build() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
 
build() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
 
build() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
 
build() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
build() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
build() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
build() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
 
build() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
build() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
 
build() - Method in class proreco.io.ProMC.ProMCEvent.Builder
 
build() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
 
build() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
 
build() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
 
build() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
 
build() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
 
build() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
 
build() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
 
build() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
 
build() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
 
build() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
 
build() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
 
build() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
build() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
build() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
build() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
 
build() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
buildArray(Field<T>, int) - Static method in class org.apache.commons.math3.util.MathArrays
Build an array of elements.
buildArray(Field<T>, int, int) - Static method in class org.apache.commons.math3.util.MathArrays
Build a double dimension array of elements.
buildConstantNode(Object) - Method in class org.lsmp.djep.matrixJep.MatrixNodeFactory
Creates an ASTConstant node with specified value.
buildConstantNode(Object) - Method in class org.lsmp.djep.xjep.NodeFactory
Creates an ASTConstant node with specified value.
buildConstantNode(ASTConstant) - Method in class org.lsmp.djep.xjep.NodeFactory
Create an ASTConstant with same value as argument.
buildConstantNode(PostfixMathCommandI, Node[]) - Method in class org.lsmp.djep.xjep.NodeFactory
Creates a ASTConstant whose value of applying the operator to its arguments.
buildConstantNode(Operator, Node[]) - Method in class org.lsmp.djep.xjep.NodeFactory
Creates a ASTConstant whose value of applying the operator to its arguments.
buildConstantNode(Operator, Node, Node) - Method in class org.lsmp.djep.xjep.NodeFactory
Creates a ASTConstant whose value of applying binary operator to its arguments.
buildConstantNode(Operator, Node) - Method in class org.lsmp.djep.xjep.NodeFactory
Creates a ASTConstant whose value of applying a unary operator to its arguments.
buildConvex(Hyperplane<S>...) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Build a convex region from a collection of bounding hyperplanes.
buildFunctionNode(String, PostfixMathCommandI, Node[]) - Method in class org.lsmp.djep.matrixJep.MatrixNodeFactory
Builds a function with n arguments
buildFunctionNode(ASTFunNode, Node[]) - Method in class org.lsmp.djep.matrixJep.MatrixNodeFactory
Builds a function with n arguments
buildFunctionNode(ASTFunNode, Node[], Dimensions) - Method in class org.lsmp.djep.matrixJep.MatrixNodeFactory
create a function node with a known dimension
buildFunctionNode(String, PostfixMathCommandI, Node[]) - Method in class org.lsmp.djep.xjep.NodeFactory
Builds a function with n arguments This method should be sub-classed
buildFunctionNode(ASTFunNode, Node[]) - Method in class org.lsmp.djep.xjep.NodeFactory
Builds a function with n arguments and same fun as specified in arguments.
BuildGraph - Class in graph
This class will parse a description file and build a plot based on the instructions in the file.
BuildGraph(InputStream, Applet) - Constructor for class graph.BuildGraph
Instantiate the class
buildJets(List<ParticleD>) - Method in class hephysics.jet.JetN2
Run the jet algorithm using the list of particles.
buildJets(ArrayList<ParticleF>) - Method in class hephysics.jet.KTjet
Run the jet algorithm using the list of particles
buildJets(List<ParticleD>) - Method in class hephysics.jet.SCJet
Run the jet algorithm using the list of particles.
buildNew(BSPTree<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build a region using the instance as a prototype.
buildNew(BSPTree<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Build a region using the instance as a prototype.
buildNew(BSPTree<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a region using the instance as a prototype.
buildNew(BSPTree<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Build a region using the instance as a prototype.
buildNew(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Build a region using the instance as a prototype.
buildNew(BSPTree<Sphere1D>) - Method in class org.apache.commons.math3.geometry.spherical.oned.ArcsSet
Build a region using the instance as a prototype.
buildNew(BSPTree<Sphere2D>) - Method in class org.apache.commons.math3.geometry.spherical.twod.SphericalPolygonsSet
Build a region using the instance as a prototype.
buildOperatorNode(Operator, Node[]) - Method in class org.lsmp.djep.matrixJep.MatrixNodeFactory
Builds a operator node with n arguments
buildOperatorNode(Operator, Node[], Dimensions) - Method in class org.lsmp.djep.matrixJep.MatrixNodeFactory
create a function node with a known dimension
buildOperatorNode(Operator, Node[]) - Method in class org.lsmp.djep.xjep.NodeFactory
Builds a operator node with n arguments This method should be sub-classed
buildOperatorNode(Operator, Node) - Method in class org.lsmp.djep.xjep.NodeFactory
creates a unary function.
buildOperatorNode(Operator, Node, Node) - Method in class org.lsmp.djep.xjep.NodeFactory
creates a binary function.
buildPartial() - Method in class proeic.io.ProMC.ProMCEvent.Builder
 
buildPartial() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
 
buildPartial() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
 
buildPartial() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
 
buildPartial() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
 
buildPartial() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
buildPartial() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
buildPartial() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
buildPartial() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
 
buildPartial() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
 
buildPartial() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
 
buildPartial() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.F1D.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.F2D.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.FND.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.FPR.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.H1D.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.H2D.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.P0D.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.P0I.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.P1D.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.PND.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.PNI.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.PXY.Builder
 
buildPartial() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
 
buildPartial() - Method in class promc.io.PEventFile.HEvent.Builder
 
buildPartial() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
 
buildPartial() - Method in class promc.io.PEventFile.HEvent.Group.Builder
 
buildPartial() - Method in class promc.io.ProMC.ProMCEvent.Builder
 
buildPartial() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
 
buildPartial() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
 
buildPartial() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
 
buildPartial() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
 
buildPartial() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
buildPartial() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
buildPartial() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
buildPartial() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
 
buildPartial() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
buildPartial() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
 
buildPartial() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
 
buildPartial() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
 
buildPartial() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
 
buildPartial() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
 
buildPartial() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
buildPartial() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
buildPartial() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
buildPartial() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
 
buildPartial() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
buildPartial() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
 
buildPartial() - Method in class proreco.io.ProMC.ProMCEvent.Builder
 
buildPartial() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
 
buildPartial() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
 
buildPartial() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
 
buildPartial() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
 
buildPartial() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
 
buildPartial() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
 
buildPartial() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
 
buildPartial() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
 
buildPartial() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
 
buildPartial() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
 
buildPartial() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
 
buildPartial() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
buildPartial() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
buildPartial() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
buildPartial() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
 
buildPartial() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
buildUnfinishedOperatorNode(Operator) - Method in class org.lsmp.djep.matrixJep.MatrixNodeFactory
Creates an operator node, but don't fill in the children or calculate its dimension.
buildUnfinishedOperatorNode(Operator) - Method in class org.lsmp.djep.xjep.NodeFactory
An unfinished node.
buildVariableNode(Variable) - Method in class org.lsmp.djep.matrixJep.MatrixNodeFactory
Creates a ASTVariable node with specified value.
buildVariableNode(ASTVarNode) - Method in class org.lsmp.djep.xjep.NodeFactory
creates a new ASTVarNode with the same name as argument.
buildVariableNode(Variable) - Method in class org.lsmp.djep.xjep.NodeFactory
creates a new ASTVarNode with a given variable.
buildVariableNode(String, Object) - Method in class org.lsmp.djep.xjep.NodeFactory
 
buildXY(double, double, double[]) - Static method in class jhplot.math.DoubleArray
Generate a two column matrix.
buildXY(double[], double[]) - Static method in class jhplot.math.DoubleArray
Join two arrays into a matrix.
BULB - Static variable in class org.jfree.chart.plot.ThermometerPlot
A constant for the value label position (in the thermometer bulb).
bummer(Frame, String) - Static method in class jplot.Utils
Bummer message.
BunchingParameters - Class in jhplot.stat
Calculations of bunching parameters.
BunchingParameters(int, int, int, double, double) - Constructor for class jhplot.stat.BunchingParameters
Initialize Bunching parameter.
buttonDefault - Variable in class org.jlab.groot.base.DatasetAttributes.DatasetAttributesPane
 
ButtonEditor(JCheckBox) - Constructor for class jplot.panels.PanelPlot.ButtonEditor
 
buttonRemove - Variable in class org.jlab.groot.base.DatasetAttributes.DatasetAttributesPane
 
buttonSetDefault - Variable in class org.jlab.groot.base.DatasetAttributes.DatasetAttributesPane
 
bx - Variable in class Jampack.Zdiagmat
The base index (public)
bx - Variable in class Jampack.Zmat
The base index
BY_KEY - Static variable in class org.jfree.data.KeyedValueComparatorType
An object representing 'by key' sorting.
BY_VALUE - Static variable in class org.jfree.data.KeyedValueComparatorType
An object representing 'by value' sorting.
BYTE - Static variable in class org.jfree.chart.util.HexNumberFormat
Number of hexadecimal digits for a byte.
ByteArrayList - Class in cern.colt.list
Resizable list holding byte elements; implemented with arrays.
ByteArrayList() - Constructor for class cern.colt.list.ByteArrayList
Constructs an empty list.
ByteArrayList(byte[]) - Constructor for class cern.colt.list.ByteArrayList
Constructs a list containing the specified elements.
ByteArrayList(int) - Constructor for class cern.colt.list.ByteArrayList
Constructs an empty list with the specified initial capacity.
ByteArrayOutputStream - Class in org.apache.commons.io.output
Implements a ThreadSafe version of AbstractByteArrayOutputStream using instance synchronization.
ByteArrayOutputStream() - Constructor for class org.apache.commons.io.output.ByteArrayOutputStream
Creates a new byte array output stream.
ByteArrayOutputStream(int) - Constructor for class org.apache.commons.io.output.ByteArrayOutputStream
Creates a new byte array output stream, with a buffer capacity of the specified size, in bytes.
byteAsUnsigned(byte) - Static method in class net.jafama.NumbersUtils
 
ByteComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
byteCountToDisplaySize(BigInteger) - Static method in class org.apache.commons.io.FileUtils
Returns a human-readable version of the file size, where the input represents a specific number of bytes.
byteCountToDisplaySize(long) - Static method in class org.apache.commons.io.FileUtils
Returns a human-readable version of the file size, where the input represents a specific number of bytes.
ByteOrderMark - Class in org.apache.commons.io
Byte Order Mark (BOM) representation - see BOMInputStream.
ByteOrderMark(String, int...) - Constructor for class org.apache.commons.io.ByteOrderMark
Construct a new BOM.
ByteOrderParser - Class in org.apache.commons.io
Converts Strings to ByteOrder instances.
ByteProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
byteValue() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation performs casting to a byte.

C

c_light - Static variable in class cern.clhep.PhysicalConstants
 
c_squared - Static variable in class cern.clhep.PhysicalConstants
 
cachePhiRapidity() - Method in class hephysics.jet.ParticleD
The method precomputers Phi, Rapidity and Pt2 and store them.
calc_divisions - Variable in class jplot3d.JSurface
 
CALC_DIVISIONS_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
calcAlignedStringBounds(String, Graphics2D, float, float, TextAnchor) - Static method in class org.jfree.chart.util.TextUtils
Returns the bounds of an aligned string.
calcCoords(int, int, int, double, double) - Method in class jplot.GraphGeneral
 
calcDim(Dimensions) - Method in class org.lsmp.djep.jama.Inverse
 
calcDim(Dimensions) - Method in class org.lsmp.djep.jama.Rank
 
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.jama.Solve
 
calcDim(Dimensions[]) - Method in class org.lsmp.djep.matrixJep.function.MIf
Find the dimension of this node.
calcDim(Dimensions[]) - Method in class org.lsmp.djep.matrixJep.function.MSum
 
calcDim(String, PostfixMathCommandI, Node[]) - Method in class org.lsmp.djep.matrixJep.MatrixNodeFactory
Calculates the dimension of node using the dimensions of the children.
calcDim(Operator, Node[]) - Method in class org.lsmp.djep.matrixJep.MatrixNodeFactory
Calculates the dimension of node using the dimensions of the children.
calcDim(Dimensions, Dimensions) - Method in interface org.lsmp.djep.vectorJep.function.BinaryOperatorI
Find the dimensions of this operator when applied to arguments with given dimensions.
calcDim(Dimensions) - Method in class org.lsmp.djep.vectorJep.function.Determinant
 
calcDim(Dimensions) - Method in class org.lsmp.djep.vectorJep.function.Diagonal
 
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.vectorJep.function.Ele
 
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.vectorJep.function.ElementComparative
 
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.vectorJep.function.ElementDivide
 
calcDim(Dimensions[]) - Method in class org.lsmp.djep.vectorJep.function.ElementMultiply
 
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.vectorJep.function.ExteriorProduct
 
calcDim(Dimensions) - Method in class org.lsmp.djep.vectorJep.function.GetDiagonal
 
calcDim(Dimensions) - Method in class org.lsmp.djep.vectorJep.function.Length
 
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.vectorJep.function.MAdd
 
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.vectorJep.function.MDivide
 
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.vectorJep.function.MDot
 
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.vectorJep.function.MMultiply
 
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.vectorJep.function.MSubtract
 
calcDim(Dimensions) - Method in class org.lsmp.djep.vectorJep.function.MUMinus
 
calcDim(Dimensions[]) - Method in interface org.lsmp.djep.vectorJep.function.NaryOperatorI
Find the dimensions of this operator when applied to arguments with given dimensions.
calcDim(Dimensions) - Method in class org.lsmp.djep.vectorJep.function.Size
 
calcDim(Dimensions) - Method in class org.lsmp.djep.vectorJep.function.Trace
 
calcDim(Dimensions) - Method in class org.lsmp.djep.vectorJep.function.Transpose
 
calcDim(Dimensions) - Method in interface org.lsmp.djep.vectorJep.function.UnaryOperatorI
Find the dimensions of this operator when applied to arguments with given dimensions.
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.vectorJep.function.VEle
 
calcDim(Dimensions[]) - Method in class org.lsmp.djep.vectorJep.function.VList
Calculates the dimension of this node with given dimensions of children.
calcDim(Dimensions[]) - Method in class org.lsmp.djep.vectorJep.function.VMap
 
calcDim(Dimensions, Dimensions) - Method in class org.lsmp.djep.vectorJep.function.VPower
 
calcDim(Dimensions[]) - Method in class org.lsmp.djep.vectorJep.function.VRange
Calculates the dimension of this node with given dimensions of children.
calcDim(Dimensions) - Method in class org.lsmp.djep.vectorJep.function.VSum
 
calcDissim(int, int, double[], double[][]) - Static method in class jminhep.algorithms.HierarchicalAlg
Method Dissim, calculates dissimilarity n x n array
calcDistance(double[], double[]) - Static method in class jminhep.cluster.Get
This method calculates the Euclidean distance between two N-ncolsional vectors.
calClustMat(int, int[][], int, int, int) - Static method in class jminhep.algorithms.HierarchicalAlg
Method ClustMat, updates cluster structure matrix following an agglomeration
calcMass() - Method in class hephysics.particle.LParticle
Get calculated mass as sqrt(e*e-px**2-py**2-pz**2)
calcMJ() - Method in class org.lsmp.djepExamples.MRpSurfExample
 
calcMRPE() - Method in class org.lsmp.djepExamples.MRpDiffExample
 
calcMRPE() - Method in class org.lsmp.djepExamples.MRpSurfExample
 
calcPolynomial(Node, FreeGroup) - Method in class org.lsmp.djep.groupJep.PolynomialVisitor
calculates a polynomial representing the node.
calcSquaredDistance(double[], double[]) - Static method in class jminhep.cluster.Get
This method calculates the squared distance between two N-dimesional vectors.
calculate(FCNBase, double[], double[]) - Method in class org.freehep.math.minuit.MnHesse
 
calculate(FCNBase, double[], double[], int) - Method in class org.freehep.math.minuit.MnHesse
FCN + parameters + errors
calculate(FCNBase, double[], MnUserCovariance) - Method in class org.freehep.math.minuit.MnHesse
 
calculate(FCNBase, double[], MnUserCovariance, int) - Method in class org.freehep.math.minuit.MnHesse
FCN + parameters + MnUserCovariance
calculate(FCNBase, MnUserParameters) - Method in class org.freehep.math.minuit.MnHesse
 
calculate(FCNBase, MnUserParameters, int) - Method in class org.freehep.math.minuit.MnHesse
FCN + MnUserParameters
calculate(FCNBase, MnUserParameters, MnUserCovariance) - Method in class org.freehep.math.minuit.MnHesse
 
calculate(FCNBase, MnUserParameters, MnUserCovariance, int) - Method in class org.freehep.math.minuit.MnHesse
FCN + MnUserParameters + MnUserCovariance
calculate(FCNBase, MnUserParameterState, int) - Method in class org.freehep.math.minuit.MnHesse
FCN + MnUserParameterState
calculateAdjustedRSquared() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Returns the adjusted R-squared statistic, defined by the formula
calculateBoxAndWhiskerStatistics(List) - Static method in class org.jfree.data.statistics.BoxAndWhiskerCalculator
Calculates the statistics required for a BoxAndWhiskerItem from a list of Number objects.
calculateBoxAndWhiskerStatistics(List, boolean) - Static method in class org.jfree.data.statistics.BoxAndWhiskerCalculator
Calculates the statistics required for a BoxAndWhiskerItem from a list of Number objects.
calculateColors() - Method in class jplot.Contour
Compute color levels
calculateColumnTotal(Values2D, int) - Static method in class org.jfree.data.DataUtilities
Returns the total of the values in one column of the supplied data table.
calculateColumnTotal(Values2D, int, int[]) - Static method in class org.jfree.data.DataUtilities
Returns the total of the values in one column of the supplied data table by taking only the row numbers in the array into account.
calculateComplexValue(Complex) - Method in class org.lsmp.djep.groupJep.values.Polynomial
returns the complex value of this polynomial.
calculateConditionalEntropy(double[], double[]) - Static method in class jhplot.stat.Entropy
Calculates the conditional entropy H(X|Y) from two vectors.
calculateConditionalMutualInformation(double[], double[], double[]) - Static method in class jhplot.stat.MutualInformation
Calculates the conditional Mutual Information I(X;Y|Z) between two random variables, conditioned on a third.
calculateConstrainedSize(Size2D) - Method in class org.jfree.chart.block.RectangleConstraint
Returns the new size that reflects the constraints defined by this instance.
calculateCovarianceMatrix(Matrix) - Static method in class jhplot.math.pca.PCA
Function for JUnit testing purposes only
calculateCovarianceMatrixOfCenteredData(Matrix) - Static method in class jhplot.math.pca.covmatrixevd.EVDBased
Calculate covariance matrix with an assumption that data matrix is centered i.e.
calculateEntropy(double[]) - Static method in class jhplot.stat.Entropy
Calculates the univariate entropy H(X) from a vector.
calculateHat() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Compute the "hat" matrix.
calculateHighestVisibleTickValue(DateTickUnit) - Method in class org.jfree.chart.axis.DateAxis
Calculates the value of the highest visible tick on the axis.
calculateJointEntropy(double[], double[]) - Static method in class jhplot.stat.Entropy
Calculates the joint entropy H(X,Y) from two vectors.
calculateLog(double) - Method in class org.jfree.chart.axis.LogAxis
Calculates the log of the given value, using the current base.
calculateLowestVisibleTickValue(DateTickUnit) - Method in class org.jfree.chart.axis.DateAxis
Calculates the value of the lowest visible tick on the axis.
calculateMean(Number[]) - Static method in class org.jfree.data.statistics.Statistics
Returns the mean of an array of numbers.
calculateMean(Number[], boolean) - Static method in class org.jfree.data.statistics.Statistics
Returns the mean of an array of numbers.
calculateMean(Collection) - Static method in class org.jfree.data.statistics.Statistics
Returns the mean of a collection of Number objects.
calculateMean(Collection, boolean) - Static method in class org.jfree.data.statistics.Statistics
Returns the mean of a collection of Number objects.
calculateMedian(List) - Static method in class org.jfree.data.statistics.Statistics
Calculates the median for a list of values (Number objects).
calculateMedian(List, boolean) - Static method in class org.jfree.data.statistics.Statistics
Calculates the median for a list of values (Number objects).
calculateMedian(List, int, int) - Static method in class org.jfree.data.statistics.Statistics
Calculates the median for a sublist within a list of values (Number objects).
calculateMedian(List, int, int, boolean) - Static method in class org.jfree.data.statistics.Statistics
Calculates the median for a sublist within a list of values (Number objects).
calculateMutualInformation(double[], double[]) - Static method in class jhplot.stat.MutualInformation
Calculates the Mutual Information I(X;Y) between two random variables.
calculateOffsetX() - Method in class org.jfree.chart.util.DefaultShadowGenerator
Calculates the x-offset for drawing the shadow image relative to the source.
calculateOffsetX() - Method in interface org.jfree.chart.util.ShadowGenerator
Calculates the x-offset for drawing the shadow image relative to the source.
calculateOffsetY() - Method in class org.jfree.chart.util.DefaultShadowGenerator
Calculates the y-offset for drawing the shadow image relative to the source.
calculateOffsetY() - Method in interface org.jfree.chart.util.ShadowGenerator
Calculates the y-offset for drawing the shadow image relative to the source.
calculatePieDatasetTotal(PieDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Calculates the total of all the values in a PieDataset.
calculateQ1(List) - Static method in class org.jfree.data.statistics.BoxAndWhiskerCalculator
Calculates the first quartile for a list of numbers in ascending order.
calculateQ3(List) - Static method in class org.jfree.data.statistics.BoxAndWhiskerCalculator
Calculates the third quartile for a list of numbers in ascending order.
calculateResidualSumOfSquares() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Returns the sum of squared residuals.
calculateRowTotal(Values2D, int) - Static method in class org.jfree.data.DataUtilities
Returns the total of the values in one row of the supplied data table.
calculateRowTotal(Values2D, int, int[]) - Static method in class org.jfree.data.DataUtilities
Returns the total of the values in one row of the supplied data table by taking only the column numbers in the array into account.
calculateRSquared() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Returns the R-Squared statistic, defined by the formula
calculateSegmentNumber(long) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Calculates the segment number for a given millisecond.
calculateStackTotal(TableXYDataset, int) - Static method in class org.jfree.data.general.DatasetUtilities
Calculates the total for the y-values in all series for a given item index.
calculateTicNumber(double, double, double, boolean) - Static method in class jplot.Axis
Precompute number of ticks
calculateTicSep(double, double, int) - Static method in class jplot.Axis
Calculation of the separation length between tics.
calculateTotalSumOfSquares() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Returns the sum of squared deviations of Y from its mean.
calculateValue(double) - Method in class org.jfree.chart.axis.LogAxis
Calculates the value from a given log.
calculateValue(Number) - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
calcValue(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.jama.Inverse
 
calcValue(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.jama.Rank
 
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.jama.Solve
 
calcValue(MatrixValueI, MatrixValueI[]) - Method in class org.lsmp.djep.matrixJep.function.MIf
This method should not be called.
calcValue(MatrixValueI, MatrixValueI[]) - Method in class org.lsmp.djep.matrixJep.function.MList
 
calcValue(MatrixValueI, MatrixValueI[]) - Method in class org.lsmp.djep.matrixJep.function.MSum
 
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in interface org.lsmp.djep.vectorJep.function.BinaryOperatorI
Calculates the value of this operator for given input with results stored in res.
calcValue(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.Determinant
 
calcValue(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.Diagonal
 
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.Ele
 
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.ElementComparative
Multiply the inputs element by element putting the results in res.
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.ElementDivide
Multiply the inputs element by element putting the results in res.
calcValue(MatrixValueI, MatrixValueI[]) - Method in class org.lsmp.djep.vectorJep.function.ElementMultiply
Multiply the inputs element by element putting the results in res.
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.ExteriorProduct
 
calcValue(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.GetDiagonal
 
calcValue(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.Length
 
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.MAdd
calculates the value.
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.MDivide
 
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.MDot
calculates the value.
calcValue(Scaler, MVector, MVector) - Method in class org.lsmp.djep.vectorJep.function.MDot
 
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.MMultiply
 
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.MSubtract
calculates the value.
calcValue(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.MUMinus
calculates the value.
calcValue(MatrixValueI, MatrixValueI[]) - Method in interface org.lsmp.djep.vectorJep.function.NaryOperatorI
Calculates the value of this operator for given input with results stored in res.
calcValue(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.Size
 
calcValue(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.Trace
 
calcValue(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.Transpose
 
calcValue(MatrixValueI, MatrixValueI) - Method in interface org.lsmp.djep.vectorJep.function.UnaryOperatorI
Calculates the value of this operator for given input with results stored in res.
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.VEle
 
calcValue(MatrixValueI, MatrixValueI[]) - Method in class org.lsmp.djep.vectorJep.function.VList
Calculates the value of this node.
calcValue(MatrixValueI, MatrixValueI[]) - Method in class org.lsmp.djep.vectorJep.function.VMap
 
calcValue(MatrixValueI, MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.VPower
 
calcValue(MatrixValueI, MatrixValueI[]) - Method in class org.lsmp.djep.vectorJep.function.VRange
Calculates the value of this node.
calcValue(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.VSum
 
calcValue(XJep) - Method in class org.lsmp.djep.xjep.XVariable
Calculates the value for the variables equation and returns that value.
calcValue(String) - Method in class org.lsmp.djepJUnit.JepTest
Parse and evaluate an expression.
calcValue(Node) - Method in class org.lsmp.djepJUnit.JepTest
 
calcValue(Node) - Method in class org.lsmp.djepJUnit.MatrixJepTest
 
calcValue(String) - Method in class org.lsmp.djepJUnit.MRpTest
 
calcValue(String) - Method in class org.lsmp.djepJUnit.RpTest
 
calcValue(String) - Method in class org.lsmp.djepJUnit.SJepTest
 
calcValues(int, int, int, int) - Method in class jplot.GraphGeneral
 
calcValuesQuad(int, int, int, int) - Method in class jplot.GraphGeneral
 
calcVarValue(String) - Method in class org.lsmp.djep.xjep.XJep
Calculates the value for the variables equation and returns that value.
calcVJ() - Method in class org.lsmp.djepExamples.MRpSurfExample
 
CalibrationConstant - Class in hep.lcio.example
Example for a user class based on LCGenericObject.
Note: Once we switch to Java 1.5 we can provide a templated class for fixed size LCGenericObjects that makes it easier for the users to implement their classes.
CalibrationConstant(int, float, float) - Constructor for class hep.lcio.example.CalibrationConstant
Convenience c'tor
CalibrationConstant(LCObject) - Constructor for class hep.lcio.example.CalibrationConstant
Convenience wrapper for LCGenericObjects read from file
CallbackEvaluationI - Interface in org.nfunk.jep.function
Functions which require greater control over their evaluation should implement this interface.
CalorimeterHit - Interface in hep.lcio.event
The generic calorimeter hit - created from SimCalorimeterHit or RawCalorimeterHit.
CALORIMETERHIT - Static variable in interface hep.lcio.event.LCIO
 
cameraForward(double) - Method in class jplot3dp.ModelView
 
CAN_EXECUTE - Static variable in class org.apache.commons.io.filefilter.CanExecuteFileFilter
Singleton instance of executable filter
CAN_READ - Static variable in class org.apache.commons.io.filefilter.CanReadFileFilter
Singleton instance of readable filter
CAN_WRITE - Static variable in class org.apache.commons.io.filefilter.CanWriteFileFilter
Singleton instance of writable filter
CANBERRA - Static variable in class cern.colt.matrix.doublealgo.Statistic
Canberra distance function; Sum( abs(x[i]-y[i]) / abs(x[i]+y[i]) ).
CanberraDistance - Class in org.apache.commons.math3.ml.distance
Calculates the Canberra distance between two points.
CanberraDistance() - Constructor for class org.apache.commons.math3.ml.distance.CanberraDistance
 
CancelException(File, int) - Constructor for exception org.apache.commons.io.DirectoryWalker.CancelException
Constructs a CancelException with the file and depth when cancellation occurred.
CancelException(String, File, int) - Constructor for exception org.apache.commons.io.DirectoryWalker.CancelException
Constructs a CancelException with an appropriate message and the file and depth when cancellation occurred.
cancelled - Variable in class jplot3d.ColorDialog
 
candela - Static variable in class cern.clhep.Units
 
CandlestickRenderer - Class in org.jfree.chart.renderer.xy
A renderer that draws candlesticks on an XYPlot (requires a OHLCDataset).
CandlestickRenderer() - Constructor for class org.jfree.chart.renderer.xy.CandlestickRenderer
Creates a new renderer for candlestick charts.
CandlestickRenderer(double) - Constructor for class org.jfree.chart.renderer.xy.CandlestickRenderer
Creates a new renderer for candlestick charts.
CandlestickRenderer(double, boolean, XYToolTipGenerator) - Constructor for class org.jfree.chart.renderer.xy.CandlestickRenderer
Creates a new renderer for candlestick charts.
CanExecuteFileFilter - Class in org.apache.commons.io.filefilter
This filter accepts Files that can be executed.
canIncrement() - Method in class org.apache.commons.math3.util.Incrementor
Deprecated.
Checks whether a single increment is allowed.
canIncrement() - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Checks whether incrementing the counter nTimes is allowed.
canIncrement(int) - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Checks whether incrementing the counter several times is allowed.
CANNOT_EXECUTE - Static variable in class org.apache.commons.io.filefilter.CanExecuteFileFilter
Singleton instance of not executable filter
CANNOT_READ - Static variable in class org.apache.commons.io.filefilter.CanReadFileFilter
Singleton instance of not readable filter
CANNOT_WRITE - Static variable in class org.apache.commons.io.filefilter.CanWriteFileFilter
Singleton instance of not writable filter
CanReadFileFilter - Class in org.apache.commons.io.filefilter
This filter accepts Files that can be read.
CanWriteFileFilter - Class in org.apache.commons.io.filefilter
This filter accepts Files that can be written to.
CardanEulerSingularityException - Exception in org.apache.commons.math3.geometry.euclidean.threed
This class represents exceptions thrown while extractiong Cardan or Euler angles from a rotation.
CardanEulerSingularityException(boolean) - Constructor for exception org.apache.commons.math3.geometry.euclidean.threed.CardanEulerSingularityException
Simple constructor.
cardinality() - Method in class cern.colt.bitvector.BitMatrix
Returns the number of bits currently in the true state.
cardinality() - Method in class cern.colt.bitvector.BitVector
Returns the number of bits currently in the true state.
cardinality() - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.DoubleMatrix2D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.DoubleMatrix3D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.ObjectMatrix1D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.ObjectMatrix2D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.ObjectMatrix3D
Returns the number of cells having non-zero values; ignores tolerance.
CATEGORY - Static variable in class org.jfree.chart.axis.CategoryLabelWidthType
Percentage of category.
CategoryAnchor - Class in org.jfree.chart.axis
Used to indicate one of three positions within a category: START, MIDDLE and END.
CategoryAnnotation - Interface in org.jfree.chart.annotations
The interface that must be supported by annotations that are to be added to a CategoryPlot.
CategoryAxis - Class in org.jfree.chart.axis
An axis that displays categories.
CategoryAxis() - Constructor for class org.jfree.chart.axis.CategoryAxis
Creates a new category axis with no label.
CategoryAxis(String) - Constructor for class org.jfree.chart.axis.CategoryAxis
Constructs a category axis, using default values where necessary.
CategoryAxis3D - Class in org.jfree.chart.axis
An axis that displays categories and has a 3D effect.
CategoryAxis3D() - Constructor for class org.jfree.chart.axis.CategoryAxis3D
Creates a new axis.
CategoryAxis3D(String) - Constructor for class org.jfree.chart.axis.CategoryAxis3D
Creates a new axis using default attribute values.
CategoryCrosshairState - Class in org.jfree.chart.plot
Represents state information for the crosshairs in a CategoryPlot.
CategoryCrosshairState() - Constructor for class org.jfree.chart.plot.CategoryCrosshairState
Creates a new instance.
CategoryDataset - Interface in org.jfree.data.category
The interface for a dataset with one or more series, and values associated with categories.
CATEGORYDATASET_TAG - Static variable in interface org.jfree.data.xml.DatasetTags
The 'CategoryDataset' element name.
CategoryDatasetHandler - Class in org.jfree.data.xml
A SAX handler for reading a CategoryDataset from an XML file.
CategoryDatasetHandler() - Constructor for class org.jfree.data.xml.CategoryDatasetHandler
Creates a new handler.
CategoryItemEntity - Class in org.jfree.chart.entity
A chart entity that represents one item within a category plot.
CategoryItemEntity(Shape, String, String, CategoryDataset, int, Object, int) - Constructor for class org.jfree.chart.entity.CategoryItemEntity
CategoryItemEntity(Shape, String, String, CategoryDataset, Comparable, Comparable) - Constructor for class org.jfree.chart.entity.CategoryItemEntity
Creates a new entity instance for an item in the specified dataset.
CategoryItemLabelGenerator - Interface in org.jfree.chart.labels
A category item label generator is an object that can be assigned to a CategoryItemRenderer and that assumes responsibility for creating text items to be used as labels for the items in a CategoryPlot.
CategoryItemRenderer - Interface in org.jfree.chart.renderer.category
A plug-in object that is used by the CategoryPlot class to display individual data items from a CategoryDataset.
CategoryItemRendererState - Class in org.jfree.chart.renderer.category
An object that retains temporary state information for a CategoryItemRenderer.
CategoryItemRendererState(PlotRenderingInfo) - Constructor for class org.jfree.chart.renderer.category.CategoryItemRendererState
Creates a new object for recording temporary state information for a renderer.
CategoryLabelEntity - Class in org.jfree.chart.entity
An entity to represent the labels on a CategoryAxis.
CategoryLabelEntity(Comparable, Shape, String, String) - Constructor for class org.jfree.chart.entity.CategoryLabelEntity
Creates a new entity.
CategoryLabelPosition - Class in org.jfree.chart.axis
The attributes that control the position of the labels for the categories on a CategoryAxis.
CategoryLabelPosition() - Constructor for class org.jfree.chart.axis.CategoryLabelPosition
Creates a new position record with default settings.
CategoryLabelPosition(RectangleAnchor, TextBlockAnchor) - Constructor for class org.jfree.chart.axis.CategoryLabelPosition
Creates a new category label position record.
CategoryLabelPosition(RectangleAnchor, TextBlockAnchor, CategoryLabelWidthType, float) - Constructor for class org.jfree.chart.axis.CategoryLabelPosition
Creates a new category label position record.
CategoryLabelPosition(RectangleAnchor, TextBlockAnchor, TextAnchor, double, CategoryLabelWidthType, float) - Constructor for class org.jfree.chart.axis.CategoryLabelPosition
Creates a new position record.
CategoryLabelPositions - Class in org.jfree.chart.axis
Records the label positions for a category axis.
CategoryLabelPositions() - Constructor for class org.jfree.chart.axis.CategoryLabelPositions
Default constructor.
CategoryLabelPositions(CategoryLabelPosition, CategoryLabelPosition, CategoryLabelPosition, CategoryLabelPosition) - Constructor for class org.jfree.chart.axis.CategoryLabelPositions
Creates a new position specification.
CategoryLabelWidthType - Class in org.jfree.chart.axis
Represents the width types for a category label.
CategoryLineAnnotation - Class in org.jfree.chart.annotations
A line annotation that can be placed on a CategoryPlot.
CategoryLineAnnotation(Comparable, double, Comparable, double, Paint, Stroke) - Constructor for class org.jfree.chart.annotations.CategoryLineAnnotation
Creates a new annotation that draws a line between (category1, value1) and (category2, value2).
CategoryMarker - Class in org.jfree.chart.plot
A marker for a category.
CategoryMarker(Comparable) - Constructor for class org.jfree.chart.plot.CategoryMarker
Creates a new category marker for the specified category.
CategoryMarker(Comparable, Paint, Stroke) - Constructor for class org.jfree.chart.plot.CategoryMarker
Creates a new category marker.
CategoryMarker(Comparable, Paint, Stroke, Paint, Stroke, float) - Constructor for class org.jfree.chart.plot.CategoryMarker
Creates a new category marker.
CategoryPlot - Class in org.jfree.chart.plot
A general plotting class that uses data from a CategoryDataset and renders each data item using a CategoryItemRenderer.
CategoryPlot() - Constructor for class org.jfree.chart.plot.CategoryPlot
Default constructor.
CategoryPlot(CategoryDataset, CategoryAxis, ValueAxis, CategoryItemRenderer) - Constructor for class org.jfree.chart.plot.CategoryPlot
Creates a new plot.
CategoryPointerAnnotation - Class in org.jfree.chart.annotations
An arrow and label that can be placed on a CategoryPlot.
CategoryPointerAnnotation(String, Comparable, double, double) - Constructor for class org.jfree.chart.annotations.CategoryPointerAnnotation
Creates a new label and arrow annotation.
CategoryRangeInfo - Interface in org.jfree.data.category
An interface that can (optionally) be implemented by a dataset to assist in determining the minimum and maximum y-values.
CategorySeriesHandler - Class in org.jfree.data.xml
A handler for reading a series for a category dataset.
CategorySeriesHandler(RootHandler) - Constructor for class org.jfree.data.xml.CategorySeriesHandler
Creates a new item handler.
CategorySeriesLabelGenerator - Interface in org.jfree.chart.labels
A generator that creates labels for the series in a CategoryDataset.
CategoryStepRenderer - Class in org.jfree.chart.renderer.category
A "step" renderer similar to XYStepRenderer but that can be used with the CategoryPlot class.
CategoryStepRenderer() - Constructor for class org.jfree.chart.renderer.category.CategoryStepRenderer
Creates a new renderer (stagger defaults to false).
CategoryStepRenderer(boolean) - Constructor for class org.jfree.chart.renderer.category.CategoryStepRenderer
Creates a new renderer.
CategoryTableXYDataset - Class in org.jfree.data.xy
An implementation variant of the TableXYDataset where every series shares the same x-values (required for generating stacked area charts).
CategoryTableXYDataset() - Constructor for class org.jfree.data.xy.CategoryTableXYDataset
Creates a new empty CategoryTableXYDataset.
CategoryTextAnnotation - Class in org.jfree.chart.annotations
A text annotation that can be placed on a CategoryPlot.
CategoryTextAnnotation(String, Comparable, double) - Constructor for class org.jfree.chart.annotations.CategoryTextAnnotation
Creates a new annotation to be displayed at the given location.
CategoryTick - Class in org.jfree.chart.axis
A tick for a CategoryAxis.
CategoryTick(Comparable, TextBlock, TextBlockAnchor, TextAnchor, double) - Constructor for class org.jfree.chart.axis.CategoryTick
Creates a new tick.
CategoryToolTipGenerator - Interface in org.jfree.chart.labels
A category tool tip generator is an object that can be assigned to a CategoryItemRenderer and that assumes responsibility for creating text items to be used as tooltips for the items in a CategoryPlot.
CategoryToPieDataset - Class in org.jfree.data.category
A PieDataset implementation that obtains its data from one row or column of a CategoryDataset.
CategoryToPieDataset(CategoryDataset, TableOrder, int) - Constructor for class org.jfree.data.category.CategoryToPieDataset
An adaptor class that converts any CategoryDataset into a PieDataset, by taking the values from a single row or column.
CategoryURLGenerator - Interface in org.jfree.chart.urls
A URL generator for items in a CategoryDataset.
Cauchy - Class in jhplot.math.num.pdf
The Cauchy distribution (1).
Cauchy() - Constructor for class jhplot.math.num.pdf.Cauchy
Default constructor.
Cauchy(double, double) - Constructor for class jhplot.math.num.pdf.Cauchy
Create a distribution with the given location and scale parameters.
cauchy(double, double) - Static method in class jhplot.math.Random
Generate a random number from a Cauchy random variable (Mean = Inf, and Variance = Inf).
CauchyDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Cauchy distribution.
CauchyDistribution() - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
Creates a Cauchy distribution with the median equal to zero and scale equal to one.
CauchyDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
Creates a Cauchy distribution using the given median and scale.
CauchyDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
Creates a Cauchy distribution using the given median and scale.
CauchyDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
Creates a Cauchy distribution.
CauchyDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
Creates a Cauchy distribution.
CauchyRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Cauchy distribution.
CauchyRandomVariable() - Constructor for class jhplot.math.num.random.CauchyRandomVariable
Default constructor.
CauchyRandomVariable(double, double) - Constructor for class jhplot.math.num.random.CauchyRandomVariable
Create a random variable with the given location and scale parameters.
CauchyRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.CauchyRandomVariable
Create a random variable with the given parameters.
cbrt(double) - Static method in class net.jafama.FastMath
 
cbrt(double) - Static method in class net.jafama.StrictFastMath
 
cbrt() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Cubic root.
cbrt() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Cubic root.
Cbrt - Class in org.apache.commons.math3.analysis.function
Cube root function.
Cbrt() - Constructor for class org.apache.commons.math3.analysis.function.Cbrt
 
cbrt() - Method in class org.apache.commons.math3.dfp.Dfp
Cubic root.
cbrt() - Method in interface org.apache.commons.math3.RealFieldElement
Cubic root.
cbrt() - Method in class org.apache.commons.math3.util.Decimal64
Cubic root.
cbrt(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the cubic root of a number.
CC - Static variable in class jminhep.clcontrol.Global
 
cd(int, int) - Method in class jhplot.gui.GHFrame
Navigate to a selected plot.
cd(String) - Method in class jhplot.io.FileAida
Navigate to a directory inside the file
cd(String) - Method in class jhplot.io.FileRoot
Navigate to a directory inside the ROOT file.
cd() - Method in class org.jlab.groot.data.Directory
sets current directory to ROOT.
cd(String) - Method in class org.jlab.groot.data.Directory
Changes current working directory to given directory
cd(int) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
changes current active drawing pad to index=pad
cd(int) - Method in class org.jlab.groot.ui.TCanvas
 
cdf(double) - Method in class cern.jet.random.Beta
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.Binomial
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.ChiSquare
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.Empirical
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.EmpiricalWalker
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.Exponential
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.Gamma
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.NegativeBinomial
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.Normal
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.Poisson
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.StudentT
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.Uniform
Returns the cumulative distribution function (assuming a continous uniform distribution).
cdf(int, double) - Static method in class jhplot.math.KolmogorovSmirnovDist
Computes the cumulative probability P[D_n <= x] of the Kolmogorov-Smirnov distribution with sample size n at x.
cdf(double) - Method in class org.apache.commons.math3.distribution.KolmogorovSmirnovDistribution
Deprecated.
Calculates P(D_n < d) using method described in [1] with quick decisions for extreme values given in [2] (see above).
cdf(double, boolean) - Method in class org.apache.commons.math3.distribution.KolmogorovSmirnovDistribution
Deprecated.
Calculates P(D_n < d) using method described in [1] with quick decisions for extreme values given in [2] (see above).
cdf(double, int) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Calculates \(P(D_n < d)\) using the method described in [1] with quick decisions for extreme values given in [2] (see above).
cdf(double, int, boolean) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Calculates P(D_n < d) using method described in [1] with quick decisions for extreme values given in [2] (see above).
cdfExact(double) - Method in class org.apache.commons.math3.distribution.KolmogorovSmirnovDistribution
Deprecated.
Calculates P(D_n < d) using method described in [1] with quick decisions for extreme values given in [2] (see above).
cdfExact(double, int) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Calculates P(D_n < d).
ceil(double) - Static method in class cern.jet.math.Arithmetic
Returns the smallest long >= value.
ceil - Static variable in class cern.jet.math.Functions
Function that returns Math.ceil(a).
ceil(double, int) - Method in class jplot3d.SurfaceModelCanvas
 
CEIL - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ceil(float) - Static method in class net.jafama.FastMath
 
ceil(double) - Static method in class net.jafama.FastMath
 
ceil(float) - Static method in class net.jafama.StrictFastMath
 
ceil(double) - Static method in class net.jafama.StrictFastMath
 
ceil() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the smallest whole number larger than instance.
ceil() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Get the smallest whole number larger than instance.
Ceil - Class in org.apache.commons.math3.analysis.function
ceil function.
Ceil() - Constructor for class org.apache.commons.math3.analysis.function.Ceil
 
ceil() - Method in class org.apache.commons.math3.dfp.Dfp
Round to an integer using the round ceil mode.
ceil() - Method in interface org.apache.commons.math3.RealFieldElement
Get the smallest whole number larger than instance.
ceil() - Method in class org.apache.commons.math3.util.Decimal64
Get the smallest whole number larger than instance.
ceil(double) - Static method in class org.apache.commons.math3.util.FastMath
Get the smallest whole number larger than x.
Ceil - Class in org.nfunk.jep.function
A PostfixMathCommandI which find the smallest integer above the number ceil(pi) give 4 ceil(-i) give -3
Ceil() - Constructor for class org.nfunk.jep.function.Ceil
 
ceil(Object) - Method in class org.nfunk.jep.function.Ceil
 
ceilingPowerOfTwo(int) - Static method in class net.jafama.NumbersUtils
 
ceilingPowerOfTwo(long) - Static method in class net.jafama.NumbersUtils
 
CellIDEncoding - Static variable in interface hep.lcio.event.LCIO
 
CENTER - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The alignment string aligning the cells of a column to its center.
center() - Method in class cern.hep.aida.bin.AbstractBin
Returns center(0).
center(int) - Method in class cern.hep.aida.bin.AbstractBin
Returns a custom definable "center" measure; override this method if necessary.
CENTER - Static variable in class graph.TextLine
Center the Text over the point
CENTER - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
CENTER.
center_reduce(double[][]) - Method in class jhplot.stat.PCA
 
CenterArrangement - Class in org.jfree.chart.block
Arranges a block in the center of its container.
CenterArrangement() - Constructor for class org.jfree.chart.block.CenterArrangement
Creates a new instance.
centerOfMass(List) - Static method in class hep.physics.vec.VecOp
 
centerOfMass(List<Hep3Vector>) - Method in class hephysics.vec.Hep3Vector
Return a center of mass of a list of vectors
centerOfMass(List<HepLorentzVector>) - Method in class hephysics.vec.HepLorentzVector
Return a center mass vector
centerRange(double) - Method in class org.jfree.chart.axis.CyclicNumberAxis
Centers the range about the given value.
centerRange(double) - Method in class org.jfree.chart.axis.ValueAxis
Centers the axis range about the specified value and sends an AxisChangeEvent to all registered listeners.
Centers() - Static method in class jminhep.clcontrol.Display
Show cluster centers
CenterTextMode - Enum in org.jfree.chart.plot
The mode for the center text on a RingPlot.
centimeter - Static variable in class cern.clhep.Units
 
centimeter2 - Static variable in class cern.clhep.Units
 
centimeter3 - Static variable in class cern.clhep.Units
 
CentralPivotingStrategy - Class in org.apache.commons.math3.util
A mid point strategy based on the average of begin and end indices.
CentralPivotingStrategy() - Constructor for class org.apache.commons.math3.util.CentralPivotingStrategy
 
centreWithin(Rectangle, Dimension) - Static method in class jhepsim.Util
Calculates the X and Y coordinates that a child component should have to be centered within its parent.
centreWithin(Component, Component) - Static method in class jhepsim.Util
Centres the child component within its parent.
centreWithin(Rectangle, Dimension) - Static method in class jhplot.utils.Util
Calculates the X and Y coordinates that a child component should have to be centered within its parent.
centreWithin(Component, Component) - Static method in class jhplot.utils.Util
Centres the child component within its parent.
centreWithin(Rectangle, Dimension) - Static method in class jminhep.utils.Util
Calculates the X and Y coordinates that a child component should have to be centered within its parent.
centreWithin(Component, Component) - Static method in class jminhep.utils.Util
Centres the child component within its parent.
CentroidCluster<T extends Clusterable> - Class in org.apache.commons.math3.ml.clustering
A Cluster used by centroid-based clustering algorithms.
CentroidCluster(Clusterable) - Constructor for class org.apache.commons.math3.ml.clustering.CentroidCluster
Build a cluster centered at a specified point.
centroidOf(Collection<T>) - Method in interface org.apache.commons.math3.stat.clustering.Clusterable
Deprecated.
Returns the centroid of the given Collection of points.
centroidOf(Collection<EuclideanDoublePoint>) - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
Deprecated.
Returns the centroid of the given Collection of points.
centroidOf(Collection<EuclideanIntegerPoint>) - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
Deprecated.
Returns the centroid of the given Collection of points.
cern.clhep - package cern.clhep
A Java port of CLHEP 1.4.0 (C++) - A Class Library for High Energy Physics; still quite incomplete - should probably find a way to take cern.clhep out of this distribution and merge cern.clhep with hep.lcd (SLAC).
cern.colt - package cern.colt
Core base classes; Operations on primitive arrays such as sorting, partitioning and permuting.
cern.colt.bitvector - package cern.colt.bitvector
Bit vectors and bit matrices.
cern.colt.buffer - package cern.colt.buffer
Fixed sized (non resizable) streaming buffers connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.function - package cern.colt.function
Core interfaces for functions, comparisons and procedures on objects and primitive data types.
cern.colt.list - package cern.colt.list
Resizable lists holding objects or primitive data types such as int, double, etc.
cern.colt.list.adapter - package cern.colt.list.adapter
List adapters that make Colt lists compatible with the JDK 1.2 Collections Framework.
cern.colt.map - package cern.colt.map
Automatically growing and shrinking maps holding objects or primitive data types such as int, double, etc.
cern.colt.matrix - package cern.colt.matrix
Matrix interfaces and factories; efficient and flexible dense and sparse 1, 2, 3 and d-dimensional matrices holding objects or primitive data types such as int, double, etc; Templated, fixed sized (not dynamically resizable); Also known as multi-dimensional arrays or Data Cubes.
cern.colt.matrix.bench - package cern.colt.matrix.bench
Matrix benchmarks.
cern.colt.matrix.doublealgo - package cern.colt.matrix.doublealgo
Double matrix algorithms such as print formatting, sorting, partitioning and statistics.
cern.colt.matrix.impl - package cern.colt.matrix.impl
Matrix implementations; You normally need not look at this package, because all concrete classes implement the abstract interfaces of cern.colt.matrix, without subsetting or supersetting.
cern.colt.matrix.linalg - package cern.colt.matrix.linalg
Linear Algebraic matrix computations operating on DoubleMatrix2D and DoubleMatrix1D.
cern.colt.matrix.objectalgo - package cern.colt.matrix.objectalgo
Object matrix algorithms such as print formatting, sorting, partitioning and statistics.
cern.hep.aida.bin - package cern.hep.aida.bin
Multisets (bags) with efficient statistics operations defined upon; This package requires the Colt distribution.
cern.hep.aida.ref - package cern.hep.aida.ref
Reference implementation of the AIDA histogram interfaces.
cern.jet.math - package cern.jet.math
Tools for basic and advanced mathematics: Arithmetics and Algebra, Polynomials and Chebyshev series, Bessel and Airy functions, Function Objects for generic function evaluation, etc.
cern.jet.random - package cern.jet.random
Large variety of probability distributions featuring high performance generation of random numbers, CDF's and PDF's.
cern.jet.random.engine - package cern.jet.random.engine
Engines generating strong uniformly distributed pseudo-random numbers; Needed by all JET probability distributions since they rely on uniform random numbers to generate random numbers from their own distribution.
cern.jet.random.sampling - package cern.jet.random.sampling
Samples (picks) random subsets of data sequences.
cern.jet.stat - package cern.jet.stat
Tools for basic and advanced statistics: Estimators, Gamma functions, Beta functions, Probabilities, Special integrals, etc.
cern.jet.stat.quantile - package cern.jet.stat.quantile
Scalable algorithms and data structures to compute approximate quantiles over very large data sequences.
CFBook - Class in jhplot.io
This class is used to book histograms for writing and reading.
CFBook(String) - Constructor for class jhplot.io.CFBook
Initialize CFBook.
CFBook() - Constructor for class jhplot.io.CFBook
Initialize CFBook class.
chain(DoubleDoubleFunction, DoubleFunction, DoubleFunction) - Static method in class cern.jet.math.Functions
Constructs the function f( g(a), h(b) ).
chain(DoubleFunction, DoubleDoubleFunction) - Static method in class cern.jet.math.Functions
Constructs the function g( h(a,b) ).
chain(DoubleFunction, DoubleFunction) - Static method in class cern.jet.math.Functions
Constructs the function g( h(a) ).
chain(IntFunction, IntFunction) - Static method in class cern.jet.math.IntFunctions
Constructs the function g( h(a) ).
chain(IntFunction, IntIntFunction) - Static method in class cern.jet.math.IntFunctions
Constructs the function g( h(a,b) ).
chain(IntIntFunction, IntFunction, IntFunction) - Static method in class cern.jet.math.IntFunctions
Constructs the function f( g(a), h(b) ).
ChainRuleDiffRules - Class in org.lsmp.djep.djep.diffRules
Common methods used when the rules are specified by node trees or strings.
ChainRuleDiffRules() - Constructor for class org.lsmp.djep.djep.diffRules.ChainRuleDiffRules
Cannot construct outside the context of a differentation visitor.
changeAlpha(Color, int) - Static method in class jplot3d.Utils
 
changeTickFontSize(int) - Method in class org.jfree.chart.plot.JThermometer
Increases or decreases the tick font size.
CharacterFilterReader - Class in org.apache.commons.io.input
A filter reader that filters out a given character represented as an int code point, handy to remove known junk characters from CSV files for example.
CharacterFilterReader(Reader, int) - Constructor for class org.apache.commons.io.input.CharacterFilterReader
Constructs a new reader.
characters(char[], int, int) - Method in class org.jfree.data.xml.KeyHandler
Receives some (or all) of the text in the current element.
characters(char[], int, int) - Method in class org.jfree.data.xml.RootHandler
Receives some (or all) of the text in the current element.
characters(char[], int, int) - Method in class org.jfree.data.xml.ValueHandler
Receives some (or all) of the text in the current element.
CharacterSetFilterReader - Class in org.apache.commons.io.input
A filter reader that removes a given set of characters represented as int code points, handy to remove known junk characters from CSV files for example.
CharacterSetFilterReader(Reader, Set<Integer>) - Constructor for class org.apache.commons.io.input.CharacterSetFilterReader
Constructs a new reader.
CharArrayList - Class in cern.colt.list
Resizable list holding char elements; implemented with arrays.
CharArrayList() - Constructor for class cern.colt.list.CharArrayList
Constructs an empty list.
CharArrayList(char[]) - Constructor for class cern.colt.list.CharArrayList
Constructs a list containing the specified elements.
CharArrayList(int) - Constructor for class cern.colt.list.CharArrayList
Constructs an empty list with the specified initial capacity.
CharComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
charge() - Method in class j4np.physics.PDGParticle
 
CHARGE_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
CHARGE_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
CHARGE_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
CHARGE_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
CHARGE_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
CHARGE_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.BLJets
 
CHARGE_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Electrons
 
CHARGE_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.GenJets
 
CHARGE_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Jets
 
CHARGE_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Muons
 
CHARGE_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
CHARGE_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
CHARGE_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
CharProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
CharSequenceInputStream - Class in org.apache.commons.io.input
InputStream implementation that can read from String, StringBuffer, StringBuilder or CharBuffer.
CharSequenceInputStream(CharSequence, Charset, int) - Constructor for class org.apache.commons.io.input.CharSequenceInputStream
Constructor.
CharSequenceInputStream(CharSequence, String, int) - Constructor for class org.apache.commons.io.input.CharSequenceInputStream
CharSequenceInputStream(CharSequence, Charset) - Constructor for class org.apache.commons.io.input.CharSequenceInputStream
CharSequenceInputStream(CharSequence, String) - Constructor for class org.apache.commons.io.input.CharSequenceInputStream
CharSequenceReader - Class in org.apache.commons.io.input
Reader implementation that can read from String, StringBuffer, StringBuilder or CharBuffer.
CharSequenceReader(CharSequence) - Constructor for class org.apache.commons.io.input.CharSequenceReader
Constructs a new instance with the specified character sequence.
CharSequenceReader(CharSequence, int) - Constructor for class org.apache.commons.io.input.CharSequenceReader
Constructs a new instance with a portion of the specified character sequence.
CharSequenceReader(CharSequence, int, int) - Constructor for class org.apache.commons.io.input.CharSequenceReader
Constructs a new instance with a portion of the specified character sequence.
Charsets - Class in org.apache.commons.io
Charsets required of every implementation of the Java platform.
Charsets() - Constructor for class org.apache.commons.io.Charsets
 
ChartCanvas - Class in org.jfree.chart.fx
A canvas for displaying a JFreeChart in JavaFX.
ChartCanvas(JFreeChart) - Constructor for class org.jfree.chart.fx.ChartCanvas
Creates a new canvas to display the supplied chart in JavaFX.
chartChanged(ChartChangeEvent) - Method in class org.jfree.chart.ChartPanel
Receives notification of changes to the chart, and redraws the chart.
chartChanged(ChartChangeEvent) - Method in interface org.jfree.chart.event.ChartChangeListener
Receives notification of a chart change event.
chartChanged(ChartChangeEvent) - Method in class org.jfree.chart.fx.ChartCanvas
Receives a notification from the chart that it has been changed and responds by redrawing the chart entirely.
ChartChangeEvent - Class in org.jfree.chart.event
A change event that encapsulates information about a change to a chart.
ChartChangeEvent(Object) - Constructor for class org.jfree.chart.event.ChartChangeEvent
Creates a new chart change event.
ChartChangeEvent(Object, JFreeChart) - Constructor for class org.jfree.chart.event.ChartChangeEvent
Creates a new chart change event.
ChartChangeEvent(Object, JFreeChart, ChartChangeEventType) - Constructor for class org.jfree.chart.event.ChartChangeEvent
Creates a new chart change event.
ChartChangeEventType - Class in org.jfree.chart.event
Defines tokens used to indicate an event type.
ChartChangeListener - Interface in org.jfree.chart.event
The interface that must be supported by classes that wish to receive notification of chart events.
ChartColor - Class in org.jfree.chart
Class to extend the number of Colors available to the charts.
ChartColor(int, int, int) - Constructor for class org.jfree.chart.ChartColor
Creates a Color with an opaque sRGB with red, green and blue values in range 0-255.
ChartDeleter - Class in org.jfree.chart.servlet
Used for deleting charts from the temporary directory when the users session expires.
ChartDeleter() - Constructor for class org.jfree.chart.servlet.ChartDeleter
Blank constructor.
ChartEditor - Interface in org.jfree.chart.editor
A chart editor is typically a JComponent containing a user interface for modifying the properties of a chart.
ChartEditorFactory - Interface in org.jfree.chart.editor
A factory for creating new ChartEditor instances.
ChartEditorManager - Class in org.jfree.chart.editor
The central point for obtaining ChartEditor instances for editing charts.
ChartEntity - Class in org.jfree.chart.entity
A class that captures information about some component of a chart (a bar, line etc).
ChartEntity(Shape) - Constructor for class org.jfree.chart.entity.ChartEntity
Creates a new chart entity.
ChartEntity(Shape, String) - Constructor for class org.jfree.chart.entity.ChartEntity
Creates a new chart entity.
ChartEntity(Shape, String, String) - Constructor for class org.jfree.chart.entity.ChartEntity
Creates a new entity.
ChartFactory - Class in org.jfree.chart
A collection of utility methods for creating some standard charts with JFreeChart.
ChartFactory() - Constructor for class org.jfree.chart.ChartFactory
 
ChartFrame - Class in org.jfree.chart
A frame for displaying a chart.
ChartFrame(String, JFreeChart) - Constructor for class org.jfree.chart.ChartFrame
Constructs a frame for a chart.
ChartFrame(String, JFreeChart, boolean) - Constructor for class org.jfree.chart.ChartFrame
Constructs a frame for a chart.
ChartHints - Class in org.jfree.chart
Special rendering hints that can be used internally by JFreeChart or by specialised implementations of the Graphics2D API.
ChartHints.Key - Class in org.jfree.chart
A key for rendering hints that can be used with JFreeChart (in addition to the regular Java2D rendering hints).
chartMouseClicked(ChartMouseEvent) - Method in interface org.jfree.chart.ChartMouseListener
Callback method for receiving notification of a mouse click on a chart.
chartMouseClicked(ChartMouseEventFX) - Method in class org.jfree.chart.fx.ChartViewer
 
chartMouseClicked(ChartMouseEventFX) - Method in class org.jfree.chart.fx.demo.BarChartFXDemo1
Write the event to the console, just to illustrate.
chartMouseClicked(ChartMouseEventFX) - Method in interface org.jfree.chart.fx.interaction.ChartMouseListenerFX
Receives notification of a mouse click on a chart.
ChartMouseEvent - Class in org.jfree.chart
A mouse event for a chart that is displayed in a ChartPanel.
ChartMouseEvent(JFreeChart, MouseEvent, ChartEntity) - Constructor for class org.jfree.chart.ChartMouseEvent
Constructs a new event.
ChartMouseEventFX - Class in org.jfree.chart.fx.interaction
A mouse event for a chart that is displayed in a (JavaFX) ChartViewer.
ChartMouseEventFX(JFreeChart, MouseEvent, ChartEntity) - Constructor for class org.jfree.chart.fx.interaction.ChartMouseEventFX
Constructs a new event.
ChartMouseListener - Interface in org.jfree.chart
The interface that must be implemented by classes that wish to receive ChartMouseEvent notifications from a ChartPanel.
ChartMouseListenerFX - Interface in org.jfree.chart.fx.interaction
A mouse listener that can receive event notifications from a (JavaFX) ChartViewer instance.
chartMouseMoved(ChartMouseEvent) - Method in interface org.jfree.chart.ChartMouseListener
Callback method for receiving notification of a mouse movement on a chart.
chartMouseMoved(ChartMouseEventFX) - Method in class org.jfree.chart.fx.ChartViewer
 
chartMouseMoved(ChartMouseEventFX) - Method in class org.jfree.chart.fx.demo.BarChartFXDemo1
Write the event to the console, just to illustrate.
chartMouseMoved(ChartMouseEventFX) - Method in interface org.jfree.chart.fx.interaction.ChartMouseListenerFX
Receives notification of a mouse move event on a chart.
ChartPanel - Class in org.jfree.chart
A Swing GUI component for displaying a JFreeChart object.
ChartPanel(JFreeChart) - Constructor for class org.jfree.chart.ChartPanel
Constructs a panel that displays the specified chart.
ChartPanel(JFreeChart, boolean) - Constructor for class org.jfree.chart.ChartPanel
Constructs a panel containing a chart.
ChartPanel(JFreeChart, boolean, boolean, boolean, boolean, boolean) - Constructor for class org.jfree.chart.ChartPanel
Constructs a JFreeChart panel.
ChartPanel(JFreeChart, int, int, int, int, int, int, boolean, boolean, boolean, boolean, boolean, boolean) - Constructor for class org.jfree.chart.ChartPanel
Constructs a JFreeChart panel.
ChartPanel(JFreeChart, int, int, int, int, int, int, boolean, boolean, boolean, boolean, boolean, boolean, boolean) - Constructor for class org.jfree.chart.ChartPanel
Constructs a JFreeChart panel.
chartProgress(ChartProgressEvent) - Method in class org.jfree.chart.ChartPanel
Receives notification of a chart progress event.
chartProgress(ChartProgressEvent) - Method in interface org.jfree.chart.event.ChartProgressListener
Receives notification of a chart progress event.
ChartProgressEvent - Class in org.jfree.chart.event
An event that contains information about the drawing progress of a chart.
ChartProgressEvent(Object, JFreeChart, int, int) - Constructor for class org.jfree.chart.event.ChartProgressEvent
Creates a new chart change event.
ChartProgressListener - Interface in org.jfree.chart.event
The interface that must be supported by classes that wish to receive notification of chart progress events.
ChartRenderingInfo - Class in org.jfree.chart
A structure for storing rendering information from one call to the JFreeChart.draw() method.
ChartRenderingInfo() - Constructor for class org.jfree.chart.ChartRenderingInfo
Constructs a new ChartRenderingInfo structure that can be used to collect information about the dimensions of a rendered chart.
ChartRenderingInfo(EntityCollection) - Constructor for class org.jfree.chart.ChartRenderingInfo
Constructs a new instance.
ChartTheme - Interface in org.jfree.chart
A ChartTheme a class that can apply a style or 'theme' to a chart.
ChartTransferable - Class in org.jfree.chart
A class used to represent a chart on the clipboard.
ChartTransferable(JFreeChart, int, int) - Constructor for class org.jfree.chart.ChartTransferable
Creates a new chart selection.
ChartTransferable(JFreeChart, int, int, boolean) - Constructor for class org.jfree.chart.ChartTransferable
Creates a new chart selection.
ChartTransferable(JFreeChart, int, int, int, int, int, int, boolean) - Constructor for class org.jfree.chart.ChartTransferable
Creates a new chart selection.
ChartUtilities - Class in org.jfree.chart
A collection of utility methods for JFreeChart.
ChartUtilities() - Constructor for class org.jfree.chart.ChartUtilities
 
ChartViewer - Class in org.jfree.chart.fx
A control for displaying a JFreeChart in JavaFX (embeds a ChartCanvas, adds drag zooming and provides a popup menu for export to PNG/JPG/SVG and PDF formats).
ChartViewer(JFreeChart) - Constructor for class org.jfree.chart.fx.ChartViewer
Creates a new viewer to display the supplied chart in JavaFX.
ChartViewer(JFreeChart, boolean) - Constructor for class org.jfree.chart.fx.ChartViewer
Creates a new viewer instance.
ChartViewerSkin - Class in org.jfree.chart.fx
A default skin for the ChartViewer control.
ChartViewerSkin(ChartViewer) - Constructor for class org.jfree.chart.fx.ChartViewerSkin
Creates a new instance.
charWidth(Graphics, char) - Method in class graph.TextLine
 
chbevl(double, double[], int) - Static method in class cern.jet.math.Arithmetic
Evaluates the series of Chebyshev polynomials Ti at argument x/2.
CHBIT_BARREL - Static variable in interface hep.lcio.event.LCIO
 
CHBIT_ID1 - Static variable in interface hep.lcio.event.LCIO
 
CHBIT_LONG - Static variable in interface hep.lcio.event.LCIO
 
CHBIT_PDG - Static variable in interface hep.lcio.event.LCIO
 
CHBIT_STEP - Static variable in interface hep.lcio.event.LCIO
 
ChebyshevDistance - Class in org.apache.commons.math3.ml.distance
Calculates the L (max of abs) distance between two points.
ChebyshevDistance() - Constructor for class org.apache.commons.math3.ml.distance.ChebyshevDistance
 
CHECK - Static variable in class jplot.GraphLabel
 
checkAdditionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if matrices are addition compatible.
checkAnalyticalDerivatives() - Method in class org.freehep.math.minuit.MnApplication
 
checkAndNotify() - Method in class org.apache.commons.io.monitor.FileAlterationObserver
Checks whether the file and its children have been created, modified or deleted.
checkBinomial(int, int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Check binomial preconditions.
checkBitPositionsByte(int, int) - Static method in class net.jafama.NumbersUtils
 
checkBitPositionsInt(int, int) - Static method in class net.jafama.NumbersUtils
 
checkBitPositionsLong(int, int) - Static method in class net.jafama.NumbersUtils
 
checkBitPositionsShort(int, int) - Static method in class net.jafama.NumbersUtils
 
checkBitSizeForSignedInt(int) - Static method in class net.jafama.NumbersUtils
 
checkBitSizeForSignedLong(int) - Static method in class net.jafama.NumbersUtils
 
checkBitSizeForUnsignedInt(int) - Static method in class net.jafama.NumbersUtils
 
checkBitSizeForUnsignedLong(int) - Static method in class net.jafama.NumbersUtils
 
checkbox - Variable in class jplot.Utils.LabeledTextField
 
checkColumnDimension(double[][], int) - Static method in class jhplot.math.DoubleArray
Checks to make sure each row of a matrix is of a specified dimension.
checkColumnIndex(AnyMatrix, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if a column index is valid.
checkCompareTo(String, String) - Method in enum org.apache.commons.io.IOCase
Compares two strings using the case-sensitivity rule.
checkCompatibility(DSCompiler) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Check rules set compatibility.
checkEndsWith(String, String) - Method in enum org.apache.commons.io.IOCase
Checks if one string ends with another using the case-sensitivity rule.
checkEqualLength(double[], double[], boolean) - Static method in class org.apache.commons.math3.util.MathArrays
Check that both arrays have the same length.
checkEqualLength(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Check that both arrays have the same length.
checkEqualLength(int[], int[], boolean) - Static method in class org.apache.commons.math3.util.MathArrays
Check that both arrays have the same length.
checkEqualLength(int[], int[]) - Static method in class org.apache.commons.math3.util.MathArrays
Check that both arrays have the same length.
checkEquals(String, String) - Method in enum org.apache.commons.io.IOCase
Compares two strings using the case-sensitivity rule.
checker(ConvergenceChecker<LeastSquaresProblem.Evaluation>) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the convergence checker.
checkerPair(ConvergenceChecker<PointVectorValuePair>) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the convergence checker.
checkFinite(double) - Static method in class org.apache.commons.math3.util.MathUtils
Check that the argument is a real number.
checkFinite(double[]) - Static method in class org.apache.commons.math3.util.MathUtils
Check that all the elements are real numbers.
checkIndexOf(String, int, String) - Method in enum org.apache.commons.io.IOCase
Checks if one string contains another starting at a specific index using the case-sensitivity rule.
checkIsInRange(int, int, int) - Static method in class net.jafama.NumbersUtils
 
checkIsInRange(long, long, long) - Static method in class net.jafama.NumbersUtils
 
checkIsInRange(float, float, float) - Static method in class net.jafama.NumbersUtils
 
checkIsInRange(double, double, double) - Static method in class net.jafama.NumbersUtils
 
checkIsInRangeSigned(int, int) - Static method in class net.jafama.NumbersUtils
 
checkIsInRangeSigned(long, int) - Static method in class net.jafama.NumbersUtils
 
checkIsInRangeUnsigned(int, int) - Static method in class net.jafama.NumbersUtils
 
checkIsInRangeUnsigned(long, int) - Static method in class net.jafama.NumbersUtils
 
checkLength(double[], int) - Static method in class jhplot.math.DoubleArray
Checks to make sure an array is of a specified length.
checkMatrixIndex(AnyMatrix, int, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if matrix indices are valid.
checkMultiplicationCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if matrices are multiplication compatible
checkNonNegative(long[]) - Static method in class org.apache.commons.math3.util.MathArrays
Check that all entries of the input array are >= 0.
checkNonNegative(long[][]) - Static method in class org.apache.commons.math3.util.MathArrays
Check all entries of the input array are >= 0.
checkNotNaN(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Check that no entry of the input array is NaN.
checkNotNull(Object, Localizable, Object...) - Static method in class org.apache.commons.math3.util.MathUtils
Checks that an object is not null.
checkNotNull(Object) - Static method in class org.apache.commons.math3.util.MathUtils
Checks that an object is not null.
checkNumberOfParameters(int) - Method in class org.lsmp.djep.matrixJep.function.MIf
 
checkNumberOfParameters(int) - Method in class org.lsmp.djep.vectorJep.function.GenMat
 
checkNumberOfParameters(int) - Method in class org.lsmp.djep.vectorJep.function.VMap
 
checkNumberOfParameters(int) - Method in class org.lsmp.djep.xjep.function.SumType
 
checkNumberOfParameters(int) - Method in class org.lsmp.djep.xjep.function.ToBase
 
checkNumberOfParameters(int) - Method in class org.nfunk.jep.function.If
Checks the number of parameters of the call.
checkNumberOfParameters(int) - Method in class org.nfunk.jep.function.PostfixMathCommand
Checks the number of parameters of the function.
checkNumberOfParameters(int) - Method in interface org.nfunk.jep.function.PostfixMathCommandI
Checks the number of parameters of the function.
checkOption() - Static method in class jhepsim.Options
 
checkOrder(double[], MathArrays.OrderDirection, boolean, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
Check that the given array is sorted.
checkOrder(double[], MathArrays.OrderDirection, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
Check that the given array is sorted.
checkOrder(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Check that the given array is sorted in strictly increasing order.
checkPoint(double, double) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Check a point with respect to the interval.
checkPoint(Vector<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check a point with respect to the region.
checkPoint(Point<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check a point with respect to the region.
checkPoint(Point<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Check a point with respect to the region.
checkPoint(double) - Method in class org.apache.commons.math3.geometry.spherical.oned.Arc
Check a point with respect to the arc.
checkPositive(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Check that all entries of the input array are strictly positive.
checkRadix(int) - Static method in class net.jafama.NumbersUtils
 
checkRectangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Checks whether the given matrix A is rectangular.
checkRectangular(long[][]) - Static method in class org.apache.commons.math3.util.MathArrays
Throws DimensionMismatchException if the input array is not rectangular.
checkRegionMatches(String, int, String) - Method in enum org.apache.commons.io.IOCase
Checks if one string contains another at a specific index using the case-sensitivity rule.
checkRowDimension(double[][], int) - Static method in class jhplot.math.DoubleArray
Checks to make sure each column of a matrix is of a specified dimension.
checkRowIndex(AnyMatrix, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if a row index is valid.
checkShape(AbstractMatrix2D) - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Sanity check for operations requiring two matrices with the same number of columns and rows.
checkShape(AbstractMatrix2D, AbstractMatrix2D) - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Sanity check for operations requiring matrices with the same number of columns and rows.
checkShape(AbstractMatrix3D) - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Sanity check for operations requiring two matrices with the same number of slices, rows and columns.
checkShape(AbstractMatrix3D, AbstractMatrix3D) - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Sanity check for operations requiring matrices with the same number of slices, rows and columns.
checkSize(AbstractMatrix1D) - Method in class cern.colt.matrix.impl.AbstractMatrix1D
Sanity check for operations requiring two matrices with the same size.
checkSquare(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Checks whether the given matrix A is square.
checkStartsWith(String, String) - Method in enum org.apache.commons.io.IOCase
Checks if one string starts with another using the case-sensitivity rule.
checkSubMatrixIndex(AnyMatrix, int, int, int, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if submatrix ranges indices are valid.
checkSubMatrixIndex(AnyMatrix, int[], int[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if submatrix ranges indices are valid.
checkSubtractionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if matrices are subtraction compatible
checksum(File, Checksum) - Static method in class org.apache.commons.io.FileUtils
Computes the checksum of a file using the specified checksum object.
checksumCRC32(File) - Static method in class org.apache.commons.io.FileUtils
Computes the checksum of a file using the CRC32 checksum routine.
checkSymmetric(RealMatrix, double) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Checks whether a matrix is symmetric.
chi2(int) - Static method in class jhplot.math.Random
Generate a random number from a Chi-2 random variable.
childrenAccept(ParserVisitor, Object) - Method in class org.nfunk.jep.SimpleNode
Accept the visitor.
chisq(double, double) - Static method in class graph.SpecialFunction
Returns the area under the left hand tail (from 0 to x) of the Chi square probability density function with v degrees of freedom.
chisqc(double, double) - Static method in class graph.SpecialFunction
Returns the area under the right hand tail (from x to infinity) of the Chi square probability density function with v degrees of freedom:
ChiSquare - Class in cern.jet.random
ChiSquare distribution; See the math definition and animated definition.
ChiSquare(double, RandomEngine) - Constructor for class cern.jet.random.ChiSquare
Constructs a ChiSquare distribution.
chiSquare(double, double) - Static method in class cern.jet.stat.Probability
Returns the area under the left hand tail (from 0 to x) of the Chi square probability density function with v degrees of freedom.
chiSquare(double[], long[]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Computes the Chi-Square statistic comparing observed and expected frequency counts.
chiSquare(long[][]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Computes the Chi-Square statistic associated with a chi-square test of independence based on the input counts array, viewed as a two-way table.
chiSquare(double[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquare(long[][]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareComplemented(double, double) - Static method in class cern.jet.stat.Probability
Returns the area under the right hand tail (from x to infinity) of the Chi square probability density function with v degrees of freedom.
ChiSquared - Class in jhplot.math.num.pdf
The Chi-Squared distribution (1).
ChiSquared() - Constructor for class jhplot.math.num.pdf.ChiSquared
Default constructor.
ChiSquared(double) - Constructor for class jhplot.math.num.pdf.ChiSquared
Create a distribution with the given degrees of freedom.
chiSquareDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Computes a Chi-Square two sample test statistic comparing bin frequency counts in observed1 and observed2.
chiSquareDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
ChiSquaredDistribution - Class in org.apache.commons.math3.distribution
Implementation of the chi-squared distribution.
ChiSquaredDistribution(double) - Constructor for class org.apache.commons.math3.distribution.ChiSquaredDistribution
Create a Chi-Squared distribution with the given degrees of freedom.
ChiSquaredDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.ChiSquaredDistribution
Create a Chi-Squared distribution with the given degrees of freedom and inverse cumulative probability accuracy.
ChiSquaredDistribution(RandomGenerator, double) - Constructor for class org.apache.commons.math3.distribution.ChiSquaredDistribution
Create a Chi-Squared distribution with the given degrees of freedom.
ChiSquaredDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.ChiSquaredDistribution
Create a Chi-Squared distribution with the given degrees of freedom and inverse cumulative probability accuracy.
ChiSquaredRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Chi-Squared distribution.
ChiSquaredRandomVariable() - Constructor for class jhplot.math.num.random.ChiSquaredRandomVariable
Default constructor.
ChiSquaredRandomVariable(double) - Constructor for class jhplot.math.num.random.ChiSquaredRandomVariable
Create a random variable with the given degrees of freedom.
ChiSquaredRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.ChiSquaredRandomVariable
Create a random variable with the given parameters.
ChiSquareTest - Class in org.apache.commons.math3.stat.inference
Implements Chi-Square test statistics.
ChiSquareTest() - Constructor for class org.apache.commons.math3.stat.inference.ChiSquareTest
Construct a ChiSquareTest
chiSquareTest(double[], long[]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Returns the observed significance level, or p-value, associated with a Chi-square goodness of fit test comparing the observed frequency counts to those in the expected array.
chiSquareTest(double[], long[], double) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Performs a Chi-square goodness of fit test evaluating the null hypothesis that the observed counts conform to the frequency distribution described by the expected counts, with significance level alpha.
chiSquareTest(long[][]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Returns the observed significance level, or p-value, associated with a chi-square test of independence based on the input counts array, viewed as a two-way table.
chiSquareTest(long[][], double) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Performs a chi-square test of independence evaluating the null hypothesis that the classifications represented by the counts in the columns of the input 2-way table are independent of the rows, with significance level alpha.
chiSquareTest(double[], long[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareTest(double[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareTest(long[][], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareTest(long[][]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareTestDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Returns the observed significance level, or p-value, associated with a Chi-Square two sample test comparing bin frequency counts in observed1 and observed2.
chiSquareTestDataSetsComparison(long[], long[], double) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Performs a Chi-Square two sample test comparing two binned data sets.
chiSquareTestDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareTestDataSetsComparison(long[], long[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chol() - Method in class Jama.Matrix
Cholesky Decomposition
cholesky(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
CholeskyDecomposition - Class in cern.colt.matrix.linalg
For a symmetric, positive definite matrix A, the Cholesky decomposition is a lower triangular matrix L so that A = L*L'; If the matrix is not symmetric or positive definite, the constructor returns a partial decomposition and sets an internal flag that may be queried by the isSymmetricPositiveDefinite() method.
CholeskyDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.linalg.CholeskyDecomposition
Constructs and returns a new Cholesky decomposition object for a symmetric and positive definite matrix; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
CholeskyDecomposition - Class in Jama
Cholesky Decomposition.
CholeskyDecomposition(Matrix) - Constructor for class Jama.CholeskyDecomposition
Cholesky algorithm for symmetric and positive definite matrix.
CholeskyDecomposition - Class in jhplot.math
Cholesky Decomposition.
CholeskyDecomposition(double[][]) - Constructor for class jhplot.math.CholeskyDecomposition
Cholesky algorithm for symmetric and positive definite matrix.
CholeskyDecomposition - Class in org.apache.commons.math3.linear
Calculates the Cholesky decomposition of a matrix.
CholeskyDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.CholeskyDecomposition
Calculates the Cholesky decomposition of the given matrix.
CholeskyDecomposition(RealMatrix, double, double) - Constructor for class org.apache.commons.math3.linear.CholeskyDecomposition
Calculates the Cholesky decomposition of the given matrix.
chooseByString(JComboBox, String) - Static method in class org.jlab.groot.base.Attributes
 
chooseFile(String, boolean) - Method in class org.jlab.groot.studio.StudioUI
 
CHORD - Static variable in class org.jfree.chart.plot.DialShape
Chord.
Chromosome - Class in org.apache.commons.math3.genetics
Individual in a population.
Chromosome() - Constructor for class org.apache.commons.math3.genetics.Chromosome
 
ChromosomePair - Class in org.apache.commons.math3.genetics
A pair of Chromosome objects.
ChromosomePair(Chromosome, Chromosome) - Constructor for class org.apache.commons.math3.genetics.ChromosomePair
Create a chromosome pair.
chs() - Method in class jhplot.math.Complex
Negative of this complex number (chs stands for change sign).
ChunkedOutputStream - Class in org.apache.commons.io.output
OutputStream which breaks larger output blocks into chunks.
ChunkedOutputStream(OutputStream, int) - Constructor for class org.apache.commons.io.output.ChunkedOutputStream
Creates a new stream that uses the specified chunk size.
ChunkedOutputStream(OutputStream) - Constructor for class org.apache.commons.io.output.ChunkedOutputStream
Creates a new stream that uses a chunk size of ChunkedOutputStream.DEFAULT_CHUNK_SIZE.
ChunkedWriter - Class in org.apache.commons.io.output
Writer which breaks larger output blocks into chunks.
ChunkedWriter(Writer, int) - Constructor for class org.apache.commons.io.output.ChunkedWriter
Creates a new writer that uses the specified chunk size.
ChunkedWriter(Writer) - Constructor for class org.apache.commons.io.output.ChunkedWriter
Creates a new writer that uses a chunk size of ChunkedWriter.DEFAULT_CHUNK_SIZE
Circle - Class in jhplot.shapes
Build a Circle using the USER coordinate system
Circle(double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.Circle
Build a circle
Circle(double, double, double) - Constructor for class jhplot.shapes.Circle
Build a circle using the default stroke and color
CIRCLE - Static variable in class jhplot.shapes.HShape
 
Circle - Class in org.apache.commons.math3.geometry.spherical.twod
This class represents an oriented great circle on the 2-sphere.
Circle(Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.Circle
Build a great circle from its pole.
Circle(S2Point, S2Point, double) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.Circle
Build a great circle from two non-aligned points.
Circle(Circle) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.Circle
Copy constructor.
CIRCLE - Static variable in class org.jfree.chart.plot.DialShape
Circle.
CircularBufferInputStream - Class in org.apache.commons.io.input.buffer
Implementation of a buffered input stream, which is internally based on the CircularByteBuffer.
CircularBufferInputStream(InputStream, int) - Constructor for class org.apache.commons.io.input.buffer.CircularBufferInputStream
Creates a new instance, which filters the given input stream, and uses the given buffer size.
CircularBufferInputStream(InputStream) - Constructor for class org.apache.commons.io.input.buffer.CircularBufferInputStream
Creates a new instance, which filters the given input stream, and uses a reasonable default buffer size (IOUtils.DEFAULT_BUFFER_SIZE).
CircularByteBuffer - Class in org.apache.commons.io.input.buffer
A buffer, which doesn't need reallocation of byte arrays, because it reuses a single byte array.
CircularByteBuffer(int) - Constructor for class org.apache.commons.io.input.buffer.CircularByteBuffer
Creates a new instance with the given buffer size.
CircularByteBuffer() - Constructor for class org.apache.commons.io.input.buffer.CircularByteBuffer
Creates a new instance with a reasonable default buffer size (IOUtils.DEFAULT_BUFFER_SIZE).
CircularInputStream - Class in org.apache.commons.io.input
An InputStream that repeats provided bytes for given target byte count.
CircularInputStream(byte[], long) - Constructor for class org.apache.commons.io.input.CircularInputStream
Creates an instance from the specified array of bytes.
classes() - Method in class org.apache.commons.math3.util.TransformerMap
Returns the Set of Classes used as keys in the map.
classic_electr_radius - Static variable in class cern.clhep.PhysicalConstants
 
ClassicalRungeKuttaFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements the classical fourth order Runge-Kutta integrator for Ordinary Differential Equations (it is the most often used Runge-Kutta method).
ClassicalRungeKuttaFieldIntegrator(Field<T>, T) - Constructor for class org.apache.commons.math3.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
Simple constructor.
ClassicalRungeKuttaIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the classical fourth order Runge-Kutta integrator for Ordinary Differential Equations (it is the most often used Runge-Kutta method).
ClassicalRungeKuttaIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.ClassicalRungeKuttaIntegrator
Simple constructor.
classify() - Method in class org.apache.commons.math3.dfp.Dfp
Returns the type - one of FINITE, INFINITE, SNAN, QNAN.
ClassLoaderObjectInputStream - Class in org.apache.commons.io.input
A special ObjectInputStream that loads a class based on a specified ClassLoader rather than the system default.
ClassLoaderObjectInputStream(ClassLoader, InputStream) - Constructor for class org.apache.commons.io.input.ClassLoaderObjectInputStream
Constructs a new ClassLoaderObjectInputStream.
ClassNameMatcher - Interface in org.apache.commons.io.serialization
An object that matches a Class name to a condition.
CLBIT_HITS - Static variable in interface hep.lcio.event.LCIO
 
ClControl - Class in jminhep.clcontrol
 
ClControl() - Constructor for class jminhep.clcontrol.ClControl
Control panel for clustering
cleanDirectory(Path) - Static method in class org.apache.commons.io.file.PathUtils
Cleans a directory including sub-directories without deleting directories.
cleanDirectory(Path, DeleteOption...) - Static method in class org.apache.commons.io.file.PathUtils
Cleans a directory including sub-directories without deleting directories.
cleanDirectory(File) - Static method in class org.apache.commons.io.FileUtils
Cleans a directory without deleting it.
CleaningPathVisitor - Class in org.apache.commons.io.file
Deletes files but not directories as a visit proceeds.
CleaningPathVisitor(Counters.PathCounters, DeleteOption[], String...) - Constructor for class org.apache.commons.io.file.CleaningPathVisitor
Constructs a new visitor that deletes files except for the files and directories explicitly given.
CleaningPathVisitor(Counters.PathCounters, String...) - Constructor for class org.apache.commons.io.file.CleaningPathVisitor
Constructs a new visitor that deletes files except for the files and directories explicitly given.
cleanUp() - Method in class org.lsmp.djep.mrpe.MRpEval
Removes observers and other cleanup needed when evaluator no longer used.
cleanUp() - Method in class org.lsmp.djep.rpe.RpEval
Removes observers and other cleanup needed when evaluator no longer used.
clear() - Method in class cern.colt.bitvector.BitMatrix
Clears all bits of the receiver.
clear() - Method in class cern.colt.bitvector.BitVector
Clears all bits of the receiver.
clear(int) - Method in class cern.colt.bitvector.BitVector
Changes the bit with index bitIndex to the "clear" (false) state.
clear(long[], int) - Static method in class cern.colt.bitvector.QuickBitVector
Changes the bit with index bitIndex in the bitvector bits to the "clear" (false) state.
clear() - Method in class cern.colt.buffer.DoubleBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.DoubleBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.DoubleBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.IntBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.IntBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.IntBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.ObjectBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.list.AbstractCollection
Removes all elements from the receiver.
clear() - Method in class cern.colt.list.AbstractList
Removes all elements from the receiver.
clear() - Method in class cern.colt.map.AbstractMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.OpenDoubleIntHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.OpenIntDoubleHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.OpenIntIntHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.OpenIntObjectHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.OpenLongObjectHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.hep.aida.bin.AbstractBin
Removes all elements from the receiver.
clear() - Method in class cern.hep.aida.bin.DynamicBin1D
Removes all elements from the receiver.
clear() - Method in class cern.hep.aida.bin.QuantileBin1D
Removes all elements from the receiver.
clear() - Method in class cern.hep.aida.bin.StaticBin1D
Removes all elements from the receiver.
clear() - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Removes all elements from the receiver.
clear() - Method in class jhplot.H1D
Make a copy of the data holder
clear() - Method in class jhplot.H2D
 
clear() - Method in class jhplot.HChart
Clear the current graph including graph settings.
clear(int, int) - Method in class jhplot.HChart
Clear the chart characterized by an index in X and Y.
clear() - Method in class jhplot.HPlot
Clear the current graph including graph settings.
clear(int, int) - Method in class jhplot.HPlot
Clear the graph characterised by an index in X and Y.
clear() - Method in class jhplot.HPlot3D
Clear the current graph including graph settings.
clear(int, int) - Method in class jhplot.HPlot3D
Clear the graph characterized by an index in X and Y.
clear() - Method in class jhplot.HPlot3DP
Clear the current graph including graph settings.
clear(int, int) - Method in class jhplot.HPlot3DP
Clear the graph characterized by an index in X and Y.
clear() - Method in class jhplot.io.CFBook
Remove all objects from the CFBook
clear() - Method in class jhplot.math.num.DoubleArray
Remove all elements from this collection.
clear() - Method in class jhplot.P1D
Clear the container.
clear() - Method in class jhplot.P2D
Clear the container
clear() - Method in class jhplot.P3D
Clear the container
clear() - Method in class jhplot.PND
Clear the container
clear() - Method in class jhplot.PNI
Clear the container
clear() - Method in class jminhep.cluster.DataHolder
Clear current data holder
clear() - Method in class jplot.DataArray
Clears the current array.
clear() - Method in class jplot.DataArray2D
Clears the current array.
clear() - Method in class jplot.DataArray3D
Clears the current array.
clear() - Method in class jplot.GraphGeneral
Clear the graph.
clear() - Method in class jplot.JPlot
Clears the plot-panel, kills eventual plot frames
clear() - Method in class jplot.SimpleEditor
Clears the current canvas
clear() - Method in class jplot.XMLWrite
Resets the string buffer to zero.
clear() - Method in class jplot3dp.ModelView.FunctionsList
 
clear() - Method in class org.apache.commons.io.input.buffer.CircularByteBuffer
Removes all bytes from the buffer.
clear() - Method in class org.apache.commons.math3.fitting.WeightedObservedPoints
Removes all observations from this container.
clear() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Clears the cache used by the default implementation of AbstractRandomGenerator.nextGaussian().
clear() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Clears the cache used by the default implementation of BitsStreamGenerator.nextGaussian.
clear() - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile
Clears the internal state of the Statistic
clear() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.Frequency
Clears the frequency table
clear() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
As the name suggests, clear wipes the internals and reorders everything in the canonical order.
clear() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Clears all data from the model.
clear() - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Clears internal buffers and resets the regression model.
clear() - Method in interface org.apache.commons.math3.util.DoubleArray
Clear the double array
clear() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Clear the array contents, resetting the number of elements to zero.
clear() - Method in class org.apache.commons.math3.util.TransformerMap
Clears all the Class to Transformer mappings.
clear() - Method in interface org.jfree.chart.block.Arrangement
Clears any cached layout information retained by the arrangement.
clear() - Method in class org.jfree.chart.block.BlockContainer
Clears all the blocks from the container.
clear() - Method in class org.jfree.chart.block.BorderArrangement
Clears the layout.
clear() - Method in class org.jfree.chart.block.CenterArrangement
Clears any cached information.
clear() - Method in class org.jfree.chart.block.ColumnArrangement
Clears any cached information.
clear() - Method in class org.jfree.chart.block.FlowArrangement
Clears any cached information.
clear() - Method in class org.jfree.chart.block.GridArrangement
Clears any cached layout information retained by the arrangement.
clear() - Method in class org.jfree.chart.ChartRenderingInfo
Clears the information recorded by this object.
clear() - Method in interface org.jfree.chart.entity.EntityCollection
Clears all entities.
clear() - Method in class org.jfree.chart.entity.StandardEntityCollection
Clears all the entities from the collection.
clear() - Method in class org.jfree.chart.PaintMap
Resets the map to empty.
clear() - Method in class org.jfree.chart.plot.AbstractPieLabelDistributor
Clears the list of labels.
clear() - Method in class org.jfree.chart.StrokeMap
Resets the map to empty.
clear() - Method in class org.jfree.data.category.DefaultCategoryDataset
Clears all data from the dataset and sends a DatasetChangeEvent to all registered listeners.
clear() - Method in class org.jfree.data.ComparableObjectSeries
Removes all data items from the series and, unless the series is already empty, sends a SeriesChangeEvent to all registered listeners.
clear() - Method in class org.jfree.data.DefaultKeyedValues
Clears all values from the collection.
clear() - Method in class org.jfree.data.DefaultKeyedValues2D
Clears all the data and associated keys.
clear() - Method in class org.jfree.data.general.DefaultPieDataset
Clears all data from this dataset and sends a DatasetChangeEvent to all registered listeners (unless the dataset was already empty).
clear() - Method in class org.jfree.data.KeyedObjects
Clears all values from the collection.
clear() - Method in class org.jfree.data.KeyedObjects2D
Clears all the data and associated keys.
clear() - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Clears all data from the dataset and sends a DatasetChangeEvent to all registered listeners.
clear() - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Clears all data from the dataset and sends a DatasetChangeEvent to all registered listeners.
clear() - Method in class org.jfree.data.time.TimeSeries
Removes all data items from the series and sends a SeriesChangeEvent to all registered listeners.
clear() - Method in class org.jfree.data.time.TimeTableXYDataset
Removes all data items from the dataset and sends a DatasetChangeEvent to all registered listeners.
clear() - Method in class org.jfree.data.xy.CategoryTableXYDataset
Clears all data from the dataset and sends a DatasetChangeEvent to all registered listeners.
clear() - Method in class org.jfree.data.xy.XYSeries
Removes all data items from the series and sends a SeriesChangeEvent to all registered listeners.
clear() - Method in class org.jlab.groot.data.DataVector
 
clear() - Method in class org.jlab.groot.data.Directory
 
clear() - Method in class org.jlab.groot.graphics.EmbeddedCanvas
Clears content of all pads.
clear() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
clear() - Method in class org.jlab.groot.math.UserParameters
 
clear() - Method in class org.jlab.groot.tree.DynamicTree
Remove all nodes except the root node.
clear() - Method in class proeic.io.ProMC.ProMCEvent.Builder
 
clear() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
 
clear() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
 
clear() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
 
clear() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
 
clear() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
clear() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
clear() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
clear() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
 
clear() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
 
clear() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
 
clear() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
clear() - Method in class promc.io.PBufFile.Record.Builder
 
clear() - Method in class promc.io.PBufFile.Record.F1D.Builder
 
clear() - Method in class promc.io.PBufFile.Record.F2D.Builder
 
clear() - Method in class promc.io.PBufFile.Record.FND.Builder
 
clear() - Method in class promc.io.PBufFile.Record.FPR.Builder
 
clear() - Method in class promc.io.PBufFile.Record.H1D.Builder
 
clear() - Method in class promc.io.PBufFile.Record.H2D.Builder
 
clear() - Method in class promc.io.PBufFile.Record.P0D.Builder
 
clear() - Method in class promc.io.PBufFile.Record.P0I.Builder
 
clear() - Method in class promc.io.PBufFile.Record.P1D.Builder
 
clear() - Method in class promc.io.PBufFile.Record.PND.Builder
 
clear() - Method in class promc.io.PBufFile.Record.PNI.Builder
 
clear() - Method in class promc.io.PBufFile.Record.PXY.Builder
 
clear() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
 
clear() - Method in class promc.io.PEventFile.HEvent.Builder
 
clear() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
 
clear() - Method in class promc.io.PEventFile.HEvent.Group.Builder
 
clear() - Method in class promc.io.ProMC.ProMCEvent.Builder
 
clear() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
 
clear() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
 
clear() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
 
clear() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
 
clear() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
clear() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
clear() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
clear() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
 
clear() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
clear() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
 
clear() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
 
clear() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
 
clear() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
 
clear() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
 
clear() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
clear() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
clear() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
clear() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
 
clear() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
clear() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
 
clear() - Method in class proreco.io.ProMC.ProMCEvent.Builder
 
clear() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
 
clear() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
 
clear() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
 
clear() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
 
clear() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
 
clear() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
 
clear() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
 
clear() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
 
clear() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
 
clear() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
 
clear() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
 
clear() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
clear() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
clear() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
clear() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
 
clear() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
clearAccumulator() - Method in class jplot3d.LineAccumulator
Clears accumulator.
clearAll - Variable in class graph.Graph2D
If set true (the default) the canvas will be set to the background color (erasing the plot) when the update method is called.
clearAll() - Method in class jhplot.HChart
Clear all graphs from data and settings.
clearAll() - Method in class jhplot.HPlot
Clear all graphs from data and settings.
clearAll() - Method in class jhplot.HPlot3D
Clear all graphs from data and settings.
clearAll() - Method in class jhplot.HPlot3DP
Clear all graphs from data and settings.
ClearAll() - Static method in class jminhep.clcontrol.Display
Clear the plot
clearAllData() - Method in class jhplot.HPlot
Clear all graphs from the input data.
clearAllentries() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional int32 allentries = 11;
clearAllentries() - Method in class promc.io.PBufFile.Record.H2D.Builder
optional int32 allentries = 11;
clearAllLabels() - Method in class jhplot.HPlot
Clear all graph labels
clearAlphaQCD() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QCD = 13;
clearAlphaQCD() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QCD = 13;
clearAlphaQCD() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQCD = 13;
clearAlphaQED() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QED = 11;
clearAlphaQED() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QED = 11;
clearAlphaQED() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQED = 11;
clearAnnotations() - Method in class org.jfree.chart.plot.CategoryPlot
Clears all the annotations and sends a PlotChangeEvent to all registered listeners.
clearAnnotations() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Clears all the annotations.
clearAnnotations() - Method in class org.jfree.chart.plot.XYPlot
Clears all the annotations and sends a PlotChangeEvent to all registered listeners.
clearBarcode() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
clearBarcode() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
clearBarcode() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
clearBins() - Method in class promc.io.PBufFile.Record.H1D.Builder
required int32 bins = 8;
clearBjets() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.BLJets bjets = 5;
clearBtag() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Btag = 5 [packed = true];
clearBtag() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Btag = 5 [packed = true];
clearBtag() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Btag = 5 [packed = true];
clearCategoryLabelToolTips() - Method in class org.jfree.chart.axis.CategoryAxis
Clears the category label tooltips and sends an AxisChangeEvent to all registered listeners.
clearCategoryLabelURLs() - Method in class org.jfree.chart.axis.CategoryAxis
Clears the category label URLs and sends an AxisChangeEvent to all registered listeners.
clearCharge() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
clearCharge() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
clearCharge() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
clearCharge() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
clearCharge() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
clearCharge() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Charge = 7 [packed = true];
clearCharge() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint32 Charge = 4 [packed = true];
clearCharge() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Charge = 7 [packed = true];
clearCharge() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Charge = 7 [packed = true];
clearCharge() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint32 Charge = 4 [packed = true];
clearCharge() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
clearCharge() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Charge = 4 [packed = true];
clearCharge() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
clearCode() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
clearCode() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
clearCode() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
clearCode() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
clearCornerTextItems() - Method in class org.jfree.chart.plot.PolarPlot
Clear the list of corner text items and sends a PlotChangeEvent to all registered listeners.
clearCrossSection() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
clearCrossSection() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
clearCrossSection() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
clearCrossSection() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
clearCrossSection() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
clearCrossSection() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
clearCrossSection() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
clearCrossSection() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
clearCrossSectionAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
clearCrossSectionAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
clearCrossSectionAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
clearCrossSectionAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
clearCrossSectionError() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
clearCrossSectionError() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
clearCrossSectionError() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
clearCrossSectionError() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
clearCrossSectionError() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
clearCrossSectionError() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
clearCrossSectionError() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
clearCrossSectionError() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
clearCrossSectionErrorAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
clearCrossSectionErrorAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
clearCrossSectionErrorAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
clearCrossSectionErrorAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
clearCuts() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
clearDa() - Method in class promc.io.PEventFile.HEvent.Builder
repeated double da = 3 [packed = true];
clearDa() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated double da = 3 [packed = true];
clearData() - Method in class jhplot.HChart
Clear plot from the data
clearData() - Method in class jhplot.HPlot
Clear the current graph from the input data.
clearData(int, int) - Method in class jhplot.HPlot
Clear data of the graph characterised by an index in X and Y.
clearData(int) - Method in class jhplot.HPlot
Remove one data set from the current plot.
clearData() - Method in class jminhep.gui.Plotter
Clear data sets
clearData() - Method in class jplot.JPlot
 
clearData(int) - Method in class jplot.JPlot
 
clearDaughter1() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
clearDaughter1() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
clearDaughter1() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
clearDaughter2() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
clearDaughter2() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
clearDaughter2() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
clearDefinition() - Method in class promc.io.PBufFile.Record.F1D.Builder
required string definition = 2;
clearDefinition() - Method in class promc.io.PBufFile.Record.F2D.Builder
required string definition = 2;
clearDefinition() - Method in class promc.io.PBufFile.Record.FND.Builder
required string definition = 2;
clearDefinition() - Method in class promc.io.PBufFile.Record.FPR.Builder
required string definition = 2;
clearDeltaEta() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
clearDeltaEta() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
clearDeltaEta() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
clearDeltaPhi() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
clearDeltaPhi() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
clearDeltaPhi() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
clearDescription() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
clearDescription() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
clearDescription() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
clearDescription() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
clearDimension() - Method in class promc.io.PBufFile.Record.PND.Builder
required int32 dimension = 3;
clearDimension() - Method in class promc.io.PBufFile.Record.PNI.Builder
required int32 dimension = 3;
clearDivU() - Method in class promc.io.PBufFile.Record.FPR.Builder
required int32 divU = 3;
clearDivV() - Method in class promc.io.PBufFile.Record.FPR.Builder
required int32 divV = 4;
clearDomainAxes() - Method in class org.jfree.chart.plot.CategoryPlot
Clears the domain axes from the plot and sends a PlotChangeEvent to all registered listeners.
clearDomainAxes() - Method in class org.jfree.chart.plot.XYPlot
Clears the domain axes from the plot and sends a PlotChangeEvent to all registered listeners.
clearDomainCrosshairs() - Method in class org.jfree.chart.panel.CrosshairOverlay
Clears all the domain crosshairs from the overlay and sends an OverlayChangeEvent to all registered listeners.
clearDomainMarkers() - Method in class org.jfree.chart.plot.CategoryPlot
Clears all the domain markers for the plot and sends a PlotChangeEvent to all registered listeners.
clearDomainMarkers(int) - Method in class org.jfree.chart.plot.CategoryPlot
Clears all the domain markers for the specified renderer.
clearDomainMarkers() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Clears all the domain markers.
clearDomainMarkers() - Method in class org.jfree.chart.plot.XYPlot
Clears all the (foreground and background) domain markers and sends a PlotChangeEvent to all registered listeners.
clearDomainMarkers(int) - Method in class org.jfree.chart.plot.XYPlot
Clears the (foreground and background) domain markers for a particular renderer and sends a PlotChangeEvent to all registered listeners.
clearECM() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
clearECM() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
clearECM() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
clearECM() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
clearEdges() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double edges = 7 [packed = true];
clearElectrons() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Electrons electrons = 6;
clearEnergy() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float energy = 19 [packed = true];
clearEnergy() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 energy = 19 [packed = true];
clearEnergy() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Energy = 3 [packed = true];
clearEnergy() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Energy = 4 [packed = true];
clearEntries() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated int32 entries = 6 [packed = true];
clearEntries() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated int32 entries = 6 [packed = true];
clearEntry() - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
clearErrors() - Method in class org.lsmp.djep.xjep.ErrorCatchingVisitor
Reset the list of errors.
clearErrors() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double errors = 3 [packed = true];
clearErrors() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double errors = 3 [packed = true];
clearEta() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Eta = 2 [packed = true];
clearEta() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Eta = 2 [packed = true];
clearEta() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Eta = 2 [packed = true];
clearEta() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Eta = 2 [packed = true];
clearEta() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Eta = 2 [packed = true];
clearEta() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Eta = 20 [packed = true];
clearEta() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Eta = 2 [packed = true];
clearEta() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Eta = 2 [packed = true];
clearEtaOuter() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 EtaOuter = 11 [packed = true];
clearEvent() - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
clearEvent() - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
clearEvent() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
clearEvent() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
clearEventHandlers() - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Remove all the event handlers that have been added to the integrator.
clearEventHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Remove all the event handlers that have been added to the integrator.
clearEventHandlers() - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Remove all the event handlers that have been added to the integrator.
clearEventHandlers() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Remove all the event handlers that have been added to the integrator.
clearEvents() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
clearEvents() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
clearEvents() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
clearEvents() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
clearF1D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F1D f1D = 9;
clearF2D() - Method in class jplot3d.JSurfacePanel
 
clearF2D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F2D f2D = 10;
clearFdata() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 17;
clearFdata() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated double fdata = 15 [packed = true];
clearFdata() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 3;
clearFit() - Method in class fitter.Fitter
 
clearFND() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FND fND = 11;
clearFPR() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FPR fPR = 12;
clearFrame() - Method in class jhplot.HChart
Clear the frame.
clearGenerator() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
optional int32 generator = 5;
clearGenjets() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.GenJets genjets = 4;
clearGroup() - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
clearH1D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H1D h1D = 7;
clearH2D() - Method in class jplot3d.JSurfacePanel
 
clearH2D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H2D h2D = 8;
clearHadOverEem() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
clearHadOverEem() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
clearHadOverEem() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
clearHeights() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double heights = 2 [packed = true];
clearHeights() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double heights = 2 [packed = true];
clearHistogram() - Method in class jhplot.utils.SHisto
Resets the values of all bins to zero.
clearId() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
clearId() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
clearId() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
clearId() - Method in class promc.io.PEventFile.HEvent.Builder
optional int64 id = 1;
clearId() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
clearId() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
clearId() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
clearId() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
clearId() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
clearId() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
clearId() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
clearId() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
clearId() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
clearID1() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID1 = 4;
clearId1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
clearID1() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID1 = 4;
clearId1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
clearId1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
clearID1() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID1 = 4 [packed = true];
clearId1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
clearID2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID2 = 5;
clearId2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
clearID2() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID2 = 5;
clearId2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
clearId2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
clearID2() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID2 = 5 [packed = true];
clearId2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
clearIda() - Method in class promc.io.PEventFile.HEvent.Builder
repeated int64 ida = 4 [packed = true];
clearIda() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated int64 ida = 2 [packed = true];
clearIdata() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 18;
clearIdata() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 16 [packed = true];
clearIdata() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 4;
clearIEEEFlags() - Method in class org.apache.commons.math3.dfp.DfpField
Clears the IEEE 854 status flags.
clearIntervals() - Method in class org.jfree.chart.plot.MeterPlot
Clears the intervals for the plot and sends a PlotChangeEvent to all registered listeners.
clearIsFixedBins() - Method in class promc.io.PBufFile.Record.H1D.Builder
required bool isFixedBins = 17;
clearIsFixedBins() - Method in class promc.io.PBufFile.Record.H2D.Builder
required bool isFixedBins = 13;
clearJets() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Jets jets = 3;
clearKey() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
clearKey() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
clearKey() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
required string key = 1;
clearKey() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
required string key = 1;
clearKey() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
clearKey() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
clearKey() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
clearKey() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
clearKey() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
clearKey() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
clearLabels() - Method in class jhplot.HPlot
Clear graph labels for the curent graph.
clearLabels(int, int) - Method in class jhplot.HPlot
Clear Graph settings including labels.
clearLengthUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
clearLengthUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
clearLengthUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
clearLengthUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
clearLifetime() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
clearLifetime() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
clearLifetime() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
clearLifetime() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
clearLiveHandler() - Method in class org.jfree.chart.fx.ChartCanvas
Clears the current live handler.
clearLuminosityAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
clearLuminosityAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
clearLuminosityAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
clearLuminosityAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
ClearMarkers() - Method in class graph.Markers
Clear All markers.
clearMass() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float mass = 4 [packed = true];
clearMass() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
clearMass() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
clearMass() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
clearMass() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
clearMass() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 Mass = 4 [packed = true];
clearMass() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 Mass = 4 [packed = true];
clearMass() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 Mass = 4 [packed = true];
clearMass() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
clearMass() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
clearMax() - Method in class promc.io.PBufFile.Record.F1D.Builder
optional double max = 4;
clearMax() - Method in class promc.io.PBufFile.Record.H1D.Builder
required double max = 10;
clearMaxX() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double maxX = 4;
clearMaxY() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double maxY = 6;
clearMean() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double mean = 16;
clearMeans() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double means = 4 [packed = true];
clearMeansX() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansX = 4 [packed = true];
clearMeansY() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansY = 7 [packed = true];
clearMET() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated uint64 MET = 1 [packed = true];
clearMetaFloat() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
clearMetaFloat() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
clearMetaFloat() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
clearMetaFloat() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
clearMetaFloat() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
clearMetaInt() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
clearMetaInt() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
clearMetaInt() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
clearMetaInt() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
clearMetaInt() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
clearMin() - Method in class promc.io.PBufFile.Record.F1D.Builder
optional double min = 3;
clearMin() - Method in class promc.io.PBufFile.Record.H1D.Builder
required double min = 9;
clearMinX() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double minX = 3;
clearMinY() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double minY = 5;
clearMissingET() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.MissingET missingET = 10;
clearMomentumUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
clearMomentumUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
clearMomentumUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
clearMomentumUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
clearMother1() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
clearMother1() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
clearMother1() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
clearMother2() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
clearMother2() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
clearMother2() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
clearMPI() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 MPI = 3;
clearMPI() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 MPI = 3;
clearMPI() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 MPI = 3 [packed = true];
clearMuons() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Muons muons = 7;
clearNAccepted() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
clearNAccepted() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
clearNAccepted() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
clearNAccepted() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
clearName() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
clearName() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
clearName() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
clearName() - Method in class promc.io.PBufFile.Record.Builder
optional string name = 1;
clearName() - Method in class promc.io.PBufFile.Record.F1D.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.F2D.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.FND.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.FPR.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.H1D.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.H2D.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.P0D.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.P0I.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.P1D.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.PND.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.PNI.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.PXY.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
required string name = 1 [default = "none"];
clearName() - Method in class promc.io.PEventFile.HEvent.Builder
optional string name = 2;
clearName() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
optional string name = 1;
clearName() - Method in class promc.io.PEventFile.HEvent.Group.Builder
optional string name = 1;
clearName() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
clearName() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
clearName() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
clearName() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
clearName() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
clearName() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
clearName() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
clearName() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
clearName() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
clearNameLengthUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
clearNameLengthUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
clearNameLengthUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
clearNameLengthUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
clearNameMomentumUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
clearNameMomentumUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
clearNameMomentumUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
clearNameMomentumUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
clearNentries() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional int32 nentries = 12;
clearNentries() - Method in class promc.io.PBufFile.Record.H2D.Builder
optional int32 nentries = 12;
clearNeventsFailed() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
clearNeventsFailed() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
clearNeventsFailed() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
clearNeventsFailed() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
clearNeventsRequested() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
clearNeventsRequested() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
clearNeventsRequested() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
clearNeventsRequested() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
clearNonConstants() - Method in class org.nfunk.jep.SymbolTable
Remove all non constant elements
clearNSelected() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
clearNSelected() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
clearNSelected() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
clearNSelected() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
clearNTried() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
clearNTried() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
clearNTried() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
clearNTried() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
clearNumber() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
clearNumber() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
clearNumber() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
clearNumber() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 Number = 1 [packed = true];
clearObservations() - Method in class org.apache.commons.math3.fitting.CurveFitter
Deprecated.
Remove all observations.
clearObservations() - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated.
Remove all observations.
clearObservations() - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Removes all current observation data and sends a DatasetChangeEvent to all registered listeners.
clearOutofrange() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double outofrange = 10 [packed = true];
clearOverflow() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double overflow = 14;
clearP0D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0D p0D = 3;
clearP0I() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0I p0I = 2;
clearP1D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P1D p1D = 6;
clearP2D() - Method in class jplot3d.JSurfacePanel
 
clearP3D() - Method in class jplot3d.JSurfacePanel
 
clearParticleData() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
clearParticleData() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
clearParticleData() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
clearParticleData() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
clearParticles() - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
clearParticles() - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
clearParticles() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
clearParticles() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
clearPDF1() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float PDF1 = 6;
clearPdf1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
clearPDF1() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float PDF1 = 6;
clearPdf1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
clearPdf1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
clearPDF1() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF1 = 6 [packed = true];
clearPdf1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
clearPDF2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float PDF2 = 7;
clearPdf2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
clearPDF2() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float PDF2 = 7;
clearPdf2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
clearPdf2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
clearPDF2() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF2 = 7 [packed = true];
clearPdf2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
clearPdfId1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
clearPdfId1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
clearPdfId1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
clearPdfId1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
clearPdfId2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
clearPdfId2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
clearPdfId2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
clearPdfId2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
clearPdgId() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
clearPdgId() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
clearPdgId() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
clearPdgId() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
clearPhi() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Phi = 3 [packed = true];
clearPhi() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Phi = 3 [packed = true];
clearPhi() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Phi = 3 [packed = true];
clearPhi() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Phi = 3 [packed = true];
clearPhi() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated sint64 Phi = 3 [packed = true];
clearPhi() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Phi = 3 [packed = true];
clearPhi() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Phi = 21 [packed = true];
clearPhi() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Phi = 3 [packed = true];
clearPhi() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Phi = 3 [packed = true];
clearPhiOuter() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 PhiOuter = 12 [packed = true];
clearPhotons() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Photons photons = 9;
clearPlot() - Method in class jhplot.HChart
Clear plot.
clearPlot() - Method in class jminhep.gui.Plotter
Clear plot (final)
clearPND() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PND pND = 13;
clearPNI() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PNI pNI = 14;
clearProcessData() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
clearProcessData() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
clearProcessData() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
clearProcessData() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
clearProcessID() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
clearProcessID() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
clearProcessID() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
clearProcessID() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ProcessID = 2 [packed = true];
clearPT() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 PT = 1 [packed = true];
clearPT() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated uint64 PT = 1 [packed = true];
clearPT() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 PT = 1 [packed = true];
clearPT() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 PT = 1 [packed = true];
clearPT() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated uint64 PT = 1 [packed = true];
clearPT() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 PT = 19 [packed = true];
clearPT() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated uint64 PT = 1 [packed = true];
clearPT() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated uint64 PT = 1 [packed = true];
clearPx() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Px = 5 [packed = true];
clearPx() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
clearPx() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 4 [packed = true];
clearPx() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
clearPXY() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXY pXY = 4;
clearPXYZ() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXYZ pXYZ = 5;
clearPy() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Py = 6 [packed = true];
clearPy() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
clearPy() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 5 [packed = true];
clearPy() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
clearPz() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Pz = 7 [packed = true];
clearPz() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
clearPz() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 6 [packed = true];
clearPz() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
clearQ2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Q2 = 16;
clearRangeAxes() - Method in class org.jfree.chart.plot.CategoryPlot
Clears the range axes from the plot and sends a PlotChangeEvent to all registered listeners.
clearRangeAxes() - Method in class org.jfree.chart.plot.XYPlot
Clears the range axes from the plot and sends a PlotChangeEvent to all registered listeners.
clearRangeCrosshairs() - Method in class org.jfree.chart.panel.CrosshairOverlay
Clears all the range crosshairs from the overlay and sends an OverlayChangeEvent to all registered listeners.
clearRangeMarkers() - Method in class org.jfree.chart.plot.CategoryPlot
Clears all the range markers for the plot and sends a PlotChangeEvent to all registered listeners.
clearRangeMarkers(int) - Method in class org.jfree.chart.plot.CategoryPlot
Clears all the range markers for the specified renderer.
clearRangeMarkers() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Clears all the range markers.
clearRangeMarkers() - Method in class org.jfree.chart.plot.XYPlot
Clears all the range markers and sends a PlotChangeEvent to all registered listeners.
clearRangeMarkers(int) - Method in class org.jfree.chart.plot.XYPlot
Clears the (foreground and background) range markers for a particular renderer.
clearRect(int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Clears the specified rectangle by filling it with the current background color.
clearRequestedEvents() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
clearRequestedEvents() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
clearRequestedEvents() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
clearRequestedEvents() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
clearRms() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double rms = 15;
clearRmses() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double rmses = 5 [packed = true];
clearRmsesX() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesX = 5 [packed = true];
clearRmsesY() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesY = 8 [packed = true];
clearS() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
clearS() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
clearS() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
clearS() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
clearScale() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Scale = 12;
clearScale() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Scale = 12;
clearScale() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float Scale = 12;
clearScalePDF() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Scale_PDF = 10;
clearScalepdf() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
clearScalePDF() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Scale_PDF = 10;
clearScalepdf() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
clearScalepdf() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
clearScalePDF() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float ScalePDF = 10;
clearScalepdf() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
clearSectionOutlinePaints(boolean) - Method in class org.jfree.chart.plot.PiePlot
Clears the section outline paint settings for this plot and, if requested, sends a PlotChangeEvent to all registered listeners.
clearSectionOutlineStrokes(boolean) - Method in class org.jfree.chart.plot.PiePlot
Clears the section outline stroke settings for this plot and, if requested, sends a PlotChangeEvent to all registered listeners.
clearSectionPaints(boolean) - Method in class org.jfree.chart.plot.PiePlot
Clears the section paint settings for this plot and, if requested, sends a PlotChangeEvent to all registered listeners.
clearSelection() - Method in class jplot.panels.PanelPlot
Clear all the selected stuff.
clearSeriesLabels(int) - Method in class org.jfree.chart.labels.MultipleXYSeriesLabelGenerator
Clears the extra labels for the specified series.
clearSeriesPaints(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Clears the series paint settings for this renderer and, if requested, sends a RendererChangeEvent to all registered listeners.
clearSeriesStrokes(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Clears the series stroke settings for this renderer and, if requested, sends a RendererChangeEvent to all registered listeners.
clearStatus() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
clearStatus() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
clearStatus() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
clearStepHandlers() - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Remove all the step handlers that have been added to the integrator.
clearStepHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Remove all the step handlers that have been added to the integrator.
clearStepHandlers() - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Remove all the step handlers that have been added to the integrator.
clearStepHandlers() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Remove all the step handlers that have been added to the integrator.
clearSubtitles() - Method in class org.jfree.chart.JFreeChart
Clears all subtitles from the chart and sends a ChartChangeEvent to all registered listeners.
clearSummary() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double summary = 9 [packed = true];
clearT() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float T = 16 [packed = true];
clearT() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
clearT() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
clearTauTag() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 TauTag = 6 [packed = true];
clearTauTag() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 TauTag = 6 [packed = true];
clearTautag() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Tautag = 6 [packed = true];
clearTimestamp() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
clearTimestamp() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
clearTimestamp() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
clearTimestamp() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
clearTracks() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Tracks tracks = 8;
clearUnderflow() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double underflow = 13;
clearValue() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
clearValue() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
clearValue() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
required double value = 2;
clearValue() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
required sint64 value = 2;
clearValue() - Method in class promc.io.PBufFile.Record.P0D.Builder
repeated double value = 2 [packed = true];
clearValue() - Method in class promc.io.PBufFile.Record.P0I.Builder
repeated int64 value = 2 [packed = true];
clearValue() - Method in class promc.io.PBufFile.Record.PND.Builder
repeated double value = 2 [packed = true];
clearValue() - Method in class promc.io.PBufFile.Record.PNI.Builder
repeated int32 value = 2 [packed = true];
clearValue() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
clearValue() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
clearValue() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
clearValue() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
clearValue() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
clearValue() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
clearValues() - Method in class org.lsmp.djep.djep.DSymbolTable
 
clearValues() - Method in class org.nfunk.jep.SymbolTable
Clears the values of all variables.
clearVars() - Method in class promc.io.PBufFile.Record.FND.Builder
required string vars = 3;
clearVersion() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
clearVersion() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
clearVersion() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
clearVersion() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
clearWeight() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional double Weight = 14;
clearWeight() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float weight = 17 [packed = true];
clearWeight() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
clearWeight() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional double Weight = 14;
clearWeight() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
clearWeight() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
clearWeight() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
clearWeight() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
clearWeight() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
clearWidth() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
clearWidth() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
clearWidth() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
clearWidth() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
clearX() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X = 15;
clearX() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float X = 13 [packed = true];
clearX() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double x = 2 [packed = true];
clearX() - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double x = 2 [packed = true];
clearX() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double x = 2 [packed = true];
clearX() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
clearX() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
clearX() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 X = 5 [packed = true];
clearX1() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X1 = 8;
clearX1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
clearX1() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float X1 = 8;
clearX1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
clearX1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
clearX1() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X1 = 8;
clearX1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
clearX2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X2 = 9;
clearX2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
clearX2() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float X2 = 9;
clearX2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
clearX2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
clearX2() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X2 = 9;
clearX2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
clearXleft() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xleft = 4 [packed = true];
clearXOuter() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 XOuter = 8 [packed = true];
clearXright() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xright = 5 [packed = true];
clearXsysleft() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysleft = 8 [packed = true];
clearXsysright() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysright = 9 [packed = true];
clearY() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Y = 14 [packed = true];
clearY() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double y = 3 [packed = true];
clearY() - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double y = 3 [packed = true];
clearY() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double y = 3 [packed = true];
clearY() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
clearY() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
clearY() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Y = 6 [packed = true];
clearYlower() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ylower = 7 [packed = true];
clearYOuter() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 YOuter = 9 [packed = true];
clearYsyslower() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysyslower = 11 [packed = true];
clearYsysupper() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysysupper = 10 [packed = true];
clearYupper() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double yupper = 6 [packed = true];
clearZ() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Z = 15 [packed = true];
clearZ() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double z = 4 [packed = true];
clearZ() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
clearZ() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
clearZ() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Z = 7 [packed = true];
clearZOuter() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 ZOuter = 10 [packed = true];
clickedOK() - Method in class jhepsim.FontChooser
Returns whether the user clicked OK when the dialog was closed.
clickedOK() - Method in class jminhep.gui.FontChooser
Returns whether the user clicked OK when the dialog was closed.
CLimits - Class in jhplot.stat
Algorithm to compute 95% CL limits using the Likelihood ratio semi-Bayesian method.
CLimits(DataSource, int) - Constructor for class jhplot.stat.CLimits
Main constructor.
CLimits(DataSource, int, boolean) - Constructor for class jhplot.stat.CLimits
Main constructor.
CLimits(H1D, H1D, H1D, int) - Constructor for class jhplot.stat.CLimits
Get limits including statistical errors in the calculations.
CLimits(P1D, P1D, P1D, int) - Constructor for class jhplot.stat.CLimits
Initialize limit calculations including statistical errors in the calculations.
CLimits(H1D, H1D, H1D, double, double, double, String, int) - Constructor for class jhplot.stat.CLimits
Initialize limit calculations for one channel with systematic errors.
clip(Shape) - Method in class org.jfree.chart.fx.FXGraphics2D
Clips to the intersection of the current clipping region and the specified shape.
ClipBoardPrintable - Interface in jhplot.math.io
BSD License
clipLine(Line2D, Rectangle2D) - Static method in class org.jfree.chart.util.LineUtilities
Clips the specified line to the given rectangle.
ClipPath - Class in org.jfree.chart
Deprecated.
This class is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
ClipPath() - Constructor for class org.jfree.chart.ClipPath
Deprecated.
Constructor for ClipPath.
ClipPath(double[], double[]) - Constructor for class org.jfree.chart.ClipPath
Deprecated.
Constructor for ClipPath.
ClipPath(double[], double[], boolean, boolean, boolean) - Constructor for class org.jfree.chart.ClipPath
Deprecated.
Constructor for ClipPath.
ClipPath(double[], double[], boolean, boolean, Paint, Paint, Stroke, Composite) - Constructor for class org.jfree.chart.ClipPath
Deprecated.
Constructor for ClipPath.
clipping - Variable in class graph.DataSet
Boolean to control clipping of the data window.
clipRect(int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Clips to the intersection of the current clipping region and the specified rectangle.
clone() - Method in class cern.colt.bitvector.BitMatrix
Cloning this BitMatrix produces a new BitMatrix that is equal to it.
clone() - Method in class cern.colt.bitvector.BitVector
Cloning this BitVector produces a new BitVector that is equal to it.
clone() - Method in class cern.colt.list.AbstractBooleanList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractByteList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractCharList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractDoubleList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractFloatList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractIntList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractLongList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractShortList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.BooleanArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.ByteArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.CharArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.DoubleArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.FloatArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.IntArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.LongArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.ObjectArrayList
Returns a copy of the receiver such that the copy and the receiver share the same elements, but do not share the same array to index them; So modifying an object in the copy modifies the object in the receiver and vice versa; However, structurally modifying the copy (for example changing its size, setting other objects at indexes, etc.) does not affect the receiver and vice versa.
clone() - Method in class cern.colt.list.ShortArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.OpenDoubleIntHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.OpenIntDoubleHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.OpenIntIntHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.OpenIntObjectHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.OpenLongObjectHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.matrix.linalg.Algebra
Returns a copy of the receiver.
clone() - Method in class cern.colt.PersistentObject
Returns a copy of the receiver.
clone() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns a deep copy of the receiver.
clone() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns a deep copy of the receiver.
clone() - Method in class cern.hep.aida.bin.QuantileBin1D
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.AbstractDistribution
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.BreitWignerMeanSquare
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.Empirical
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.EmpiricalWalker
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.engine.MersenneTwister
Returns a copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.NegativeBinomial
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.Poisson
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.sampling.RandomSampler
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.sampling.RandomSamplingAssistant
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.sampling.WeightedRandomSampler
Returns a deep copy of the receiver.
clone() - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Returns a deep copy of the receiver.
clone() - Method in class hep.physics.vec.SpacePoint
Clone
clone() - Method in class hephysics.vec.SpacePoint
Clone
clone() - Method in class Jama.Matrix
Clone the Matrix object.
clone() - Method in class jhplot.math.Complex
 
clone() - Method in class jhplot.math.kalman.jama.Matrix
Clone the Matrix object.
clone() - Method in class jhplot.math.ValueErr
 
clone() - Method in class jhplot.stat.DataSource
Allow cloning
clone() - Method in class org.jfree.chart.annotations.AbstractAnnotation
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.annotations.CategoryTextAnnotation
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.annotations.XYBoxAnnotation
Returns a clone.
clone() - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.annotations.XYDrawableAnnotation
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.annotations.XYImageAnnotation
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.annotations.XYLineAnnotation
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.annotations.XYPolygonAnnotation
Returns a clone.
clone() - Method in class org.jfree.chart.annotations.XYShapeAnnotation
Returns a clone.
clone() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.axis.Axis
Returns a clone of the axis.
clone() - Method in class org.jfree.chart.axis.AxisSpace
Returns a clone of the object.
clone() - Method in class org.jfree.chart.axis.CategoryAxis
Creates a clone of the axis.
clone() - Method in class org.jfree.chart.axis.CategoryAxis3D
Returns a clone of the axis.
clone() - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Returns a clone of the object.
clone() - Method in class org.jfree.chart.axis.DateAxis
Returns a clone of the object.
clone() - Method in class org.jfree.chart.axis.ExtendedCategoryAxis
Returns a clone of this axis.
clone() - Method in class org.jfree.chart.axis.NumberAxis
Returns a clone of the axis.
clone() - Method in class org.jfree.chart.axis.PeriodAxis
Returns a clone of the axis.
clone() - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Returns a clone of the object.
clone() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns a clone of the timeline.
clone() - Method in class org.jfree.chart.axis.Tick
Returns a clone of the tick.
clone() - Method in class org.jfree.chart.axis.TickUnits
Returns a clone of the collection.
clone() - Method in class org.jfree.chart.axis.ValueAxis
Returns a clone of the object.
clone() - Method in class org.jfree.chart.block.AbstractBlock
Returns a clone of this block.
clone() - Method in class org.jfree.chart.block.BlockContainer
Returns a clone of the container.
clone() - Method in class org.jfree.chart.block.EmptyBlock
Returns a clone of the block.
clone() - Method in class org.jfree.chart.block.LabelBlock
Returns a clone of this LabelBlock instance.
clone() - Method in class org.jfree.chart.ChartRenderingInfo
Returns a clone of this object.
clone() - Method in class org.jfree.chart.ClipPath
Deprecated.
Returns a clone of the object (a deeper clone than default to avoid bugs when setting values in cloned object).
clone() - Method in class org.jfree.chart.entity.AxisEntity
Returns a clone of the entity.
clone() - Method in class org.jfree.chart.entity.ChartEntity
Returns a clone of the entity.
clone() - Method in class org.jfree.chart.entity.ContourEntity
Deprecated.
Returns a clone of the entity.
clone() - Method in class org.jfree.chart.entity.JFreeChartEntity
Returns a clone of the entity.
clone() - Method in class org.jfree.chart.entity.LegendItemEntity
Returns a clone of the entity.
clone() - Method in class org.jfree.chart.entity.PlotEntity
Returns a clone of the entity.
clone() - Method in class org.jfree.chart.entity.StandardEntityCollection
Returns a clone of this entity collection.
clone() - Method in class org.jfree.chart.entity.TitleEntity
Returns a clone of the entity.
clone() - Method in class org.jfree.chart.JFreeChart
Clones the object, and takes care of listeners.
clone() - Method in class org.jfree.chart.labels.AbstractCategoryItemLabelGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.AbstractPieItemLabelGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.AbstractXYItemLabelGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.CustomXYToolTipGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.HighLowItemLabelGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.IntervalXYItemLabelGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.MultipleXYSeriesLabelGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.StandardCategorySeriesLabelGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.StandardPieSectionLabelGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.StandardPieToolTipGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.StandardXYItemLabelGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.StandardXYSeriesLabelGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.StandardXYToolTipGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.labels.SymbolicXYItemLabelGenerator
Returns an independent copy of the generator.
clone() - Method in class org.jfree.chart.LegendItem
Returns an independent copy of this object (except that the clone will still reference the same dataset as the original LegendItem).
clone() - Method in class org.jfree.chart.LegendItemCollection
Returns a clone of the collection.
clone() - Method in class org.jfree.chart.needle.ArrowNeedle
Returns a clone of this needle.
clone() - Method in class org.jfree.chart.needle.LineNeedle
Returns a clone of this needle.
clone() - Method in class org.jfree.chart.needle.LongNeedle
Returns a clone of this needle.
clone() - Method in class org.jfree.chart.needle.MiddlePinNeedle
Returns a clone of this needle.
clone() - Method in class org.jfree.chart.needle.PinNeedle
Returns a clone of this needle.
clone() - Method in class org.jfree.chart.needle.PlumNeedle
Returns a clone of this needle.
clone() - Method in class org.jfree.chart.needle.PointerNeedle
Returns a clone of this needle.
clone() - Method in class org.jfree.chart.needle.ShipNeedle
Returns a clone of this needle.
clone() - Method in class org.jfree.chart.PaintMap
Returns a clone of this PaintMap.
clone() - Method in class org.jfree.chart.panel.CrosshairOverlay
Returns a clone of this instance.
clone() - Method in class org.jfree.chart.plot.CategoryPlot
Returns a clone of the plot.
clone() - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns a clone of the palette.
clone() - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Returns a clone of the plot.
clone() - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Returns a clone of the annotation.
clone() - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Returns a clone of the plot.
clone() - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Returns a clone of the plot.
clone() - Method in class org.jfree.chart.plot.CompassPlot
Returns a clone of the plot.
clone() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Extends plot cloning to this plot type
clone() - Method in class org.jfree.chart.plot.Crosshair
Returns an independent copy of this instance.
clone() - Method in class org.jfree.chart.plot.DefaultDrawingSupplier
Returns a clone.
clone() - Method in class org.jfree.chart.plot.dial.AbstractDialLayer
Returns a clone of this instance.
clone() - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Returns a clone of this instance.
clone() - Method in class org.jfree.chart.plot.dial.DialBackground
Returns a clone of this instance.
clone() - Method in class org.jfree.chart.plot.dial.DialCap
Returns a clone of this instance.
clone() - Method in class org.jfree.chart.plot.dial.DialPointer
Returns a clone of the pointer.
clone() - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Returns a clone of this instance.
clone() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns a clone of this instance.
clone() - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Returns a clone of this instance.
clone() - Method in class org.jfree.chart.plot.dial.StandardDialRange
Returns a clone of this instance.
clone() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns a clone of this instance.
clone() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns a clone of the plot.
clone() - Method in class org.jfree.chart.plot.IntervalMarker
Returns a clone of the marker.
clone() - Method in class org.jfree.chart.plot.Marker
Creates a clone of the marker.
clone() - Method in class org.jfree.chart.plot.MeterPlot
Returns an independent copy (clone) of the plot.
clone() - Method in class org.jfree.chart.plot.MultiplePiePlot
Returns a clone of the plot.
clone() - Method in class org.jfree.chart.plot.PiePlot
Returns a clone of the plot.
clone() - Method in class org.jfree.chart.plot.Plot
Creates a clone of the plot.
clone() - Method in class org.jfree.chart.plot.PlotRenderingInfo
Returns a clone of this object.
clone() - Method in class org.jfree.chart.plot.PolarPlot
Returns a clone of the plot.
clone() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns a clone of this plot.
clone() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns a clone of the plot.
clone() - Method in class org.jfree.chart.plot.XYPlot
Returns a clone of the plot.
clone() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns an independent copy of the renderer.
clone() - Method in class org.jfree.chart.renderer.category.AreaRenderer
Returns an independent copy of the renderer.
clone() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns an independent copy of the renderer.
clone() - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Returns an independent copy of the renderer.
clone() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.GrayPaintScale
Returns a clone of this GrayPaintScale instance.
clone() - Method in class org.jfree.chart.renderer.LookupPaintScale
Returns a clone of the instance.
clone() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.ClusteredXYBarRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.SamplingXYLineRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer2
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.VectorRenderer
Returns a clone of this renderer.
clone() - Method in class org.jfree.chart.renderer.xy.WindItemRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer2
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Returns a clone of this renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYBubbleRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYDotRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Returns a clone of this renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.XYStepRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.renderer.xy.YIntervalRenderer
Returns a clone of the renderer.
clone() - Method in class org.jfree.chart.StandardChartTheme
Returns a clone of this theme.
clone() - Method in class org.jfree.chart.StrokeMap
Returns a clone of this StrokeMap.
clone() - Method in class org.jfree.chart.title.LegendGraphic
Returns a clone of this LegendGraphic instance.
clone() - Method in class org.jfree.chart.title.TextTitle
Returns a clone of this object.
clone() - Method in class org.jfree.chart.title.Title
Returns a clone of the title.
clone() - Method in class org.jfree.chart.urls.CustomCategoryURLGenerator
Returns a new generator that is a copy of, and independent from, this generator.
clone() - Method in class org.jfree.chart.urls.CustomPieURLGenerator
Returns a clone of the generator.
clone() - Method in class org.jfree.chart.urls.CustomXYURLGenerator
Returns a new generator that is a copy of, and independent from, this generator.
clone() - Method in class org.jfree.chart.urls.StandardCategoryURLGenerator
Returns an independent copy of the URL generator.
clone() - Method in class org.jfree.chart.util.LogFormat
Returns a clone of this instance.
clone() - Method in class org.jfree.chart.util.RelativeDateFormat
Returns a clone of this instance.
clone() - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns a clone of the dataset.
clone() - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns a clone of this dataset.
clone() - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns an independent copy of the dataset.
clone() - Method in class org.jfree.data.ComparableObjectItem
Returns a clone of this object.
clone(double[][]) - Static method in class org.jfree.data.DataUtilities
Returns a clone of the specified array.
clone() - Method in class org.jfree.data.DefaultKeyedValue
Returns a clone.
clone() - Method in class org.jfree.data.DefaultKeyedValues
Returns a clone.
clone() - Method in class org.jfree.data.DefaultKeyedValues2D
Returns a clone.
clone() - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns an independent copy of the dataset.
clone() - Method in class org.jfree.data.gantt.Task
Returns a clone of the task.
clone() - Method in class org.jfree.data.gantt.TaskSeries
Returns an independent copy of this series.
clone() - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns an independent copy of this dataset.
clone() - Method in class org.jfree.data.gantt.XYTaskDataset
Returns a clone of this dataset.
clone() - Method in class org.jfree.data.general.AbstractDataset
Returns a clone of the dataset.
clone() - Method in class org.jfree.data.general.DatasetGroup
Clones the group.
clone() - Method in class org.jfree.data.general.DefaultHeatMapDataset
Returns an independent copy of this dataset.
clone() - Method in class org.jfree.data.general.DefaultKeyedValueDataset
Creates a clone of the dataset.
clone() - Method in class org.jfree.data.general.DefaultPieDataset
Returns a clone of the dataset.
clone() - Method in class org.jfree.data.general.Series
Returns a clone of the series.
clone() - Method in class org.jfree.data.KeyedObject
Returns a clone of this object.
clone() - Method in class org.jfree.data.KeyedObjects
Returns a clone of this object.
clone() - Method in class org.jfree.data.KeyedObjects2D
Returns a clone.
clone() - Method in class org.jfree.data.KeyToGroupMap
Returns a clone of the map.
clone() - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns a clone of this dataset.
clone() - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns a clone of the plot.
clone() - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns a clone of this instance.
clone() - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns a clone of this dataset.
clone() - Method in class org.jfree.data.statistics.HistogramBin
Returns a clone of the bin.
clone() - Method in class org.jfree.data.statistics.HistogramDataset
Returns a clone of the dataset.
clone() - Method in class org.jfree.data.statistics.SimpleHistogramBin
Returns a clone of the bin.
clone() - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns a clone of the dataset.
clone() - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns a clone of this instance.
clone() - Method in class org.jfree.data.time.TimePeriodValue
Clones the object.
clone() - Method in class org.jfree.data.time.TimePeriodValues
Returns a clone of the collection.
clone() - Method in class org.jfree.data.time.TimeSeries
Returns a clone of the time series.
clone() - Method in class org.jfree.data.time.TimeSeriesCollection
Returns a clone of this time series collection.
clone() - Method in class org.jfree.data.time.TimeSeriesDataItem
Clones the data item.
clone() - Method in class org.jfree.data.time.TimeTableXYDataset
Returns a clone of this dataset.
clone() - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns an independent copy of this dataset.
clone() - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns a clone of this dataset.
clone() - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns an independent copy of this dataset.
clone() - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns an independent copy of this dataset.
clone() - Method in class org.jfree.data.xy.DefaultXYDataset
Creates an independent copy of this dataset.
clone() - Method in class org.jfree.data.xy.DefaultXYZDataset
Creates an independent copy of this dataset.
clone() - Method in class org.jfree.data.xy.IntervalXYDelegate
 
clone() - Method in class org.jfree.data.xy.MatrixSeriesCollection
Returns a clone of this instance.
clone() - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns a clone of this instance.
clone() - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns a clone of this instance.
clone() - Method in class org.jfree.data.xy.XYBarDataset
Returns an independent copy of the dataset.
clone() - Method in class org.jfree.data.xy.XYDataItem
Returns a clone of this object.
clone() - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns a clone of this dataset.
clone() - Method in class org.jfree.data.xy.XYSeries
Returns a clone of the series.
clone() - Method in class org.jfree.data.xy.XYSeriesCollection
Returns a clone of this instance.
clone() - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns a clone of this instance.
clone() - Method in class org.jlab.groot.base.AxisAttributes
 
clone() - Method in class org.jlab.groot.base.DatasetAttributes
 
clone() - Method in class org.jlab.groot.math.Dimension1D
 
clone() - Method in class proeic.io.ProMC.ProMCEvent.Builder
 
clone() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
 
clone() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
 
clone() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
 
clone() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
 
clone() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
clone() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
clone() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
clone() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
 
clone() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
 
clone() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
 
clone() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
clone() - Method in class promc.io.PBufFile.Record.Builder
 
clone() - Method in class promc.io.PBufFile.Record.F1D.Builder
 
clone() - Method in class promc.io.PBufFile.Record.F2D.Builder
 
clone() - Method in class promc.io.PBufFile.Record.FND.Builder
 
clone() - Method in class promc.io.PBufFile.Record.FPR.Builder
 
clone() - Method in class promc.io.PBufFile.Record.H1D.Builder
 
clone() - Method in class promc.io.PBufFile.Record.H2D.Builder
 
clone() - Method in class promc.io.PBufFile.Record.P0D.Builder
 
clone() - Method in class promc.io.PBufFile.Record.P0I.Builder
 
clone() - Method in class promc.io.PBufFile.Record.P1D.Builder
 
clone() - Method in class promc.io.PBufFile.Record.PND.Builder
 
clone() - Method in class promc.io.PBufFile.Record.PNI.Builder
 
clone() - Method in class promc.io.PBufFile.Record.PXY.Builder
 
clone() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
 
clone() - Method in class promc.io.PEventFile.HEvent.Builder
 
clone() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
 
clone() - Method in class promc.io.PEventFile.HEvent.Group.Builder
 
clone() - Method in class promc.io.ProMC.ProMCEvent.Builder
 
clone() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
 
clone() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
 
clone() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
 
clone() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
 
clone() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
clone() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
clone() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
clone() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
 
clone() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
clone() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
 
clone() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
 
clone() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
 
clone() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
 
clone() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
 
clone() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
clone() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
clone() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
clone() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
 
clone() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
clone() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
 
clone() - Method in class proreco.io.ProMC.ProMCEvent.Builder
 
clone() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
 
clone() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
 
clone() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
 
clone() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
 
clone() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
 
clone() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
 
clone() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
 
clone() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
 
clone() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
 
clone() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
 
clone() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
 
clone() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
clone() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
clone() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
clone() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
 
clone() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
cloneImage(BufferedImage) - Static method in class org.jfree.chart.util.PaintAlpha
Clone a BufferedImage.
cloneList(List<?>) - Static method in class org.jfree.chart.util.CloneUtils
Returns a list containing cloned copies of the items in the source list.
cloneMapValues(Map) - Static method in class org.jfree.chart.util.CloneUtils
Returns a new map that contains the same keys and cloned copied of the values.
CloneUtils - Class in org.jfree.chart.util
Utilities for cloning.
CloneUtils() - Constructor for class org.jfree.chart.util.CloneUtils
 
ClopperPearsonInterval - Class in org.apache.commons.math3.stat.interval
Implements the Clopper-Pearson method for creating a binomial proportion confidence interval.
ClopperPearsonInterval() - Constructor for class org.apache.commons.math3.stat.interval.ClopperPearsonInterval
 
close() - Method in interface hep.lcio.io.LCReader
Closes the output file/stream etc.
close() - Method in interface hep.lcio.io.LCWriter
Closes the output file/stream.
close() - Method in class hep.lcio.util.MergeFileParameters
Close the LCReader.
close() - Method in class jhplot.HChart
Close the canvas (and dispose all components) Note: a memory leak is found - no time to investigate it.
close() - Method in class jhplot.HPlot
Close the canvas (and dispose all components).
close() - Method in class jhplot.HPlot3D
Close the canvas (and dispose all components) Note: a memory leak is found - no time to study it.
close() - Method in class jhplot.HPlot3DP
Close the canvas (and dispose all components) Note: a memory leak is found - no time to study it.
close() - Method in class jhplot.HPlotJas
Close the canvas (and dispose all components).
close() - Method in class jhplot.io.db.BaseRecordsFile
Closes the file.
close() - Method in class jhplot.io.db.RecordsFile
Closes the database.
close() - Method in class jhplot.io.EFile
Close the file
close() - Method in class jhplot.io.FileAida
Close the file
close() - Method in class jhplot.io.HBook
Clear all objects and exit.
close() - Method in class jhplot.io.HDataBase
Close the file
close() - Method in class jhplot.io.HFile
Close the file
close() - Method in class jhplot.io.HFileDIF
Close the file if needed.
close() - Method in class jhplot.io.HFileXML
Close the file
close() - Method in class jhplot.io.PFile
Close the file
close() - Method in class jhplot.math.io.LEDataInputStream
 
close() - Method in class jhplot.math.io.LEDataOutputStream
 
close() - Method in class jhplot.math.io.LERandomAccessFile
 
ClosE - Static variable in interface jminhep.gui.Constants
 
close() - Method in class jplot.XMLRead
Closes the current context and moves back to a more global one.
close() - Method in class jplot.XMLWrite
Adds a simple setting to a string(buffer), notifying a closing tag: the tag is preceded by a / (e.g.
close() - Method in class org.apache.commons.io.input.AutoCloseInputStream
Closes the underlying input stream and replaces the reference to it with a ClosedInputStream instance.
close() - Method in class org.apache.commons.io.input.BoundedInputStream
Invokes the delegate's close() method if BoundedInputStream.isPropagateClose() is true.
close() - Method in class org.apache.commons.io.input.BoundedReader
Closes the target
close() - Method in class org.apache.commons.io.input.BrokenInputStream
Throws the configured exception.
close() - Method in class org.apache.commons.io.input.BrokenReader
Throws the configured exception.
close() - Method in class org.apache.commons.io.input.buffer.CircularBufferInputStream
 
close() - Method in class org.apache.commons.io.input.CharSequenceInputStream
 
close() - Method in class org.apache.commons.io.input.CharSequenceReader
Close resets the file back to the start and removes any marked position.
close() - Method in class org.apache.commons.io.input.ClosedReader
 
close() - Method in class org.apache.commons.io.input.CloseShieldInputStream
Replaces the underlying input stream with a ClosedInputStream sentinel.
close() - Method in class org.apache.commons.io.input.CloseShieldReader
Replaces the underlying reader with a ClosedReader sentinel.
close() - Method in class org.apache.commons.io.input.DemuxInputStream
Closes stream associated with current thread.
close() - Method in class org.apache.commons.io.input.NullInputStream
Close this input stream - resets the internal state to the initial values.
close() - Method in class org.apache.commons.io.input.NullReader
Closes this Reader - resets the internal state to the initial values.
close() - Method in class org.apache.commons.io.input.ObservableInputStream
 
close() - Method in class org.apache.commons.io.input.ProxyInputStream
Invokes the delegate's close() method.
close() - Method in class org.apache.commons.io.input.ProxyReader
Invokes the delegate's close() method.
close() - Method in class org.apache.commons.io.input.RandomAccessFileInputStream
 
close() - Method in class org.apache.commons.io.input.ReaderInputStream
Close the stream.
close() - Method in class org.apache.commons.io.input.ReversedLinesFileReader
Closes underlying resources.
close() - Method in class org.apache.commons.io.input.SequenceReader
 
close() - Method in class org.apache.commons.io.input.TeeInputStream
Closes the proxied input stream and, if so configured, the associated output stream.
close() - Method in class org.apache.commons.io.input.TeeReader
Closes the proxied reader and, if so configured, the associated writer.
close() - Method in class org.apache.commons.io.input.UnixLineEndingInputStream
Closes the stream.
close() - Method in class org.apache.commons.io.input.WindowsLineEndingInputStream
Closes the stream.
close() - Method in class org.apache.commons.io.input.XmlStreamReader
Closes the XmlStreamReader stream.
close(Closeable) - Static method in class org.apache.commons.io.IOUtils
Closes the given Closeable as a null-safe operation.
close(Closeable...) - Static method in class org.apache.commons.io.IOUtils
Closes the given Closeable as a null-safe operation.
close(Closeable, IOConsumer<IOException>) - Static method in class org.apache.commons.io.IOUtils
Closes the given Closeable as a null-safe operation.
close(URLConnection) - Static method in class org.apache.commons.io.IOUtils
Closes a URLConnection.
close() - Method in class org.apache.commons.io.LineIterator
Closes the underlying Reader.
close() - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
Closing a ByteArrayOutputStream has no effect.
close() - Method in class org.apache.commons.io.output.AppendableWriter
Closes the stream.
close() - Method in class org.apache.commons.io.output.BrokenOutputStream
Throws the configured exception.
close() - Method in class org.apache.commons.io.output.BrokenWriter
Throws the configured exception.
close() - Method in class org.apache.commons.io.output.ClosedWriter
 
close() - Method in class org.apache.commons.io.output.CloseShieldOutputStream
Replaces the underlying output stream with a ClosedOutputStream sentinel.
close() - Method in class org.apache.commons.io.output.CloseShieldWriter
Replaces the underlying writer with a ClosedWriter sentinel.
close() - Method in class org.apache.commons.io.output.DeferredFileOutputStream
Closes underlying output stream, and mark this as closed
close() - Method in class org.apache.commons.io.output.DemuxOutputStream
Closes stream associated with current thread.
close() - Method in class org.apache.commons.io.output.FileWriterWithEncoding
Close the stream.
close() - Method in class org.apache.commons.io.output.FilterCollectionWriter
 
close() - Method in class org.apache.commons.io.output.LockableFileWriter
Closes the file writer and deletes the lockfile (if possible).
close() - Method in class org.apache.commons.io.output.NullWriter
 
close() - Method in class org.apache.commons.io.output.ProxyCollectionWriter
Invokes the delegate's close() method.
close() - Method in class org.apache.commons.io.output.ProxyOutputStream
Invokes the delegate's close() method.
close() - Method in class org.apache.commons.io.output.ProxyWriter
Invokes the delegate's close() method.
close() - Method in class org.apache.commons.io.output.StringBuilderWriter
Closing this writer has no effect.
close() - Method in class org.apache.commons.io.output.TeeOutputStream
Closes both output streams.
close() - Method in class org.apache.commons.io.output.ThresholdingOutputStream
Closes this output stream and releases any system resources associated with this stream.
close() - Method in class org.apache.commons.io.output.WriterOutputStream
Close the stream.
close() - Method in class org.apache.commons.io.output.XmlStreamWriter
Closes the underlying writer.
close() - Method in class org.jfree.data.jdbc.JDBCPieDataset
Close the database connection
close() - Method in class org.jfree.data.jdbc.JDBCXYDataset
Close the database connection
close() - Method in class org.jlab.groot.tree.TreeFile
 
closed() - Method in class org.apache.commons.io.input.ObservableInputStream.Observer
Called to indicate that the ObservableInputStream has been closed.
CLOSED_INPUT_STREAM - Static variable in class org.apache.commons.io.input.ClosedInputStream
A singleton.
CLOSED_OUTPUT_STREAM - Static variable in class org.apache.commons.io.output.ClosedOutputStream
A singleton.
CLOSED_READER - Static variable in class org.apache.commons.io.input.ClosedReader
A singleton.
CLOSED_WRITER - Static variable in class org.apache.commons.io.output.ClosedWriter
A singleton.
ClosedInputStream - Class in org.apache.commons.io.input
Closed input stream.
ClosedInputStream() - Constructor for class org.apache.commons.io.input.ClosedInputStream
 
ClosedOutputStream - Class in org.apache.commons.io.output
Throws an exception on all attempts to write to the stream.
ClosedOutputStream() - Constructor for class org.apache.commons.io.output.ClosedOutputStream
 
ClosedReader - Class in org.apache.commons.io.input
Closed reader.
ClosedReader() - Constructor for class org.apache.commons.io.input.ClosedReader
 
ClosedWriter - Class in org.apache.commons.io.output
Throws an exception on all attempts to write with ClosedWriter.close() implemented as a noop.
ClosedWriter() - Constructor for class org.apache.commons.io.output.ClosedWriter
 
closeQuietly(Closeable) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use the try-with-resources statement or handle suppressed exceptions manually.
closeQuietly(Closeable...) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use the try-with-resources statement or handle suppressed exceptions manually.
closeQuietly(Closeable, Consumer<IOException>) - Static method in class org.apache.commons.io.IOUtils
Closes the given Closeable as a null-safe operation while consuming IOException by the given consumer.
closeQuietly(InputStream) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use the try-with-resources statement or handle suppressed exceptions manually.
closeQuietly(OutputStream) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use the try-with-resources statement or handle suppressed exceptions manually.
closeQuietly(Reader) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use the try-with-resources statement or handle suppressed exceptions manually.
closeQuietly(Selector) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use the try-with-resources statement or handle suppressed exceptions manually.
closeQuietly(ServerSocket) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use the try-with-resources statement or handle suppressed exceptions manually.
closeQuietly(Socket) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use the try-with-resources statement or handle suppressed exceptions manually.
closeQuietly(Writer) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use the try-with-resources statement or handle suppressed exceptions manually.
closeQuietly(LineIterator) - Static method in class org.apache.commons.io.LineIterator
Deprecated.
As of 2.6 deprecated without replacement. Please use the try-with-resources statement or handle suppressed exceptions manually.
closeReplayFile() - Method in class org.apache.commons.math3.random.ValueServer
Closes valuesFileURL after use in REPLAY_MODE.
CloseShieldInputStream - Class in org.apache.commons.io.input
Proxy stream that prevents the underlying input stream from being closed.
CloseShieldInputStream(InputStream) - Constructor for class org.apache.commons.io.input.CloseShieldInputStream
Creates a proxy that shields the given input stream from being closed.
CloseShieldOutputStream - Class in org.apache.commons.io.output
Proxy stream that prevents the underlying output stream from being closed.
CloseShieldOutputStream(OutputStream) - Constructor for class org.apache.commons.io.output.CloseShieldOutputStream
Creates a proxy that shields the given output stream from being closed.
CloseShieldReader - Class in org.apache.commons.io.input
Proxy stream that prevents the underlying reader from being closed.
CloseShieldReader(Reader) - Constructor for class org.apache.commons.io.input.CloseShieldReader
Creates a proxy that shields the given reader from being closed.
CloseShieldWriter - Class in org.apache.commons.io.output
Proxy stream that prevents the underlying writer from being closed.
CloseShieldWriter(Writer) - Constructor for class org.apache.commons.io.output.CloseShieldWriter
Creates a proxy that shields the given writer from being closed.
closestPoint(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Compute the point of the instance closest to another line.
closeWriter() - Method in class hep.lcio.util.LCIOConcat
 
ClusCenter - Static variable in class jminhep.gui.SetEnv
 
Cluster - Interface in hep.lcio.event
The LCIO cluster.
CLUSTER - Static variable in interface hep.lcio.event.LCIO
 
Cluster<T extends Clusterable> - Class in org.apache.commons.math3.ml.clustering
Cluster holding a set of Clusterable points.
Cluster() - Constructor for class org.apache.commons.math3.ml.clustering.Cluster
Build a cluster centered at a specified point.
cluster(Collection<T>) - Method in class org.apache.commons.math3.ml.clustering.Clusterer
Perform a cluster analysis on the given set of Clusterable instances.
cluster(Collection<T>) - Method in class org.apache.commons.math3.ml.clustering.DBSCANClusterer
Performs DBSCAN cluster analysis.
cluster(Collection<T>) - Method in class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Performs Fuzzy K-Means cluster analysis.
cluster(Collection<T>) - Method in class org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer
Runs the K-means++ clustering algorithm.
cluster(Collection<T>) - Method in class org.apache.commons.math3.ml.clustering.MultiKMeansPlusPlusClusterer
Runs the K-means++ clustering algorithm.
Cluster<T extends Clusterable<T>> - Class in org.apache.commons.math3.stat.clustering
Deprecated.
As of 3.2 (to be removed in 4.0), use Cluster instead
Cluster(T) - Constructor for class org.apache.commons.math3.stat.clustering.Cluster
Deprecated.
Build a cluster centered at a specified point.
cluster(Collection<T>) - Method in class org.apache.commons.math3.stat.clustering.DBSCANClusterer
Deprecated.
Performs DBSCAN cluster analysis.
cluster(Collection<T>, int, int, int) - Method in class org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer
Deprecated.
Runs the K-means++ clustering algorithm.
cluster(Collection<T>, int, int) - Method in class org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer
Deprecated.
Runs the K-means++ clustering algorithm.
Clusterable - Interface in org.apache.commons.math3.ml.clustering
Interface for n-dimensional points that can be clustered together.
Clusterable<T> - Interface in org.apache.commons.math3.stat.clustering
Deprecated.
As of 3.2 (to be removed in 4.0), use Clusterable instead
ClusteredXYBarRenderer - Class in org.jfree.chart.renderer.xy
An extension of XYBarRenderer that displays bars for different series values at the same x next to each other.
ClusteredXYBarRenderer() - Constructor for class org.jfree.chart.renderer.xy.ClusteredXYBarRenderer
Default constructor.
ClusteredXYBarRenderer(double, boolean) - Constructor for class org.jfree.chart.renderer.xy.ClusteredXYBarRenderer
Constructs a new XY clustered bar renderer.
Clusterer<T extends Clusterable> - Class in org.apache.commons.math3.ml.clustering
Base class for clustering algorithms.
ClusterEvaluator<T extends Clusterable> - Class in org.apache.commons.math3.ml.clustering.evaluation
Base class for cluster evaluation methods.
ClusterEvaluator() - Constructor for class org.apache.commons.math3.ml.clustering.evaluation.ClusterEvaluator
Creates a new cluster evaluator with an EuclideanDistance as distance measure.
ClusterEvaluator(DistanceMeasure) - Constructor for class org.apache.commons.math3.ml.clustering.evaluation.ClusterEvaluator
Creates a new cluster evaluator with the given distance measure.
Clusters() - Static method in class jminhep.clcontrol.Display
Fill clusters to dataset to be shown latter
cm - Static variable in class cern.clhep.Units
 
cm2 - Static variable in class cern.clhep.Units
 
cm3 - Static variable in class cern.clhep.Units
 
CMAESOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
An implementation of the active Covariance Matrix Adaptation Evolution Strategy (CMA-ES) for non-linear, non-convex, non-smooth, global function minimization.
CMAESOptimizer(int, double, boolean, int, int, RandomGenerator, boolean, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
 
CMAESOptimizer - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
CMAESOptimizer() - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
As of version 3.1: Parameter lambda must be passed with the call to optimize (whereas in the current code it is set to an undocumented value).
CMAESOptimizer(int) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
As of version 3.1: Parameter lambda must be passed with the call to optimize (whereas in the current code it is set to an undocumented value)..
CMAESOptimizer(int, double[]) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
As of version 3.1: Parameters lambda and inputSigma must be passed with the call to optimize.
CMAESOptimizer(int, double[], int, double, boolean, int, int, RandomGenerator, boolean) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
CMAESOptimizer(int, double[], int, double, boolean, int, int, RandomGenerator, boolean, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
As of version 3.1: Parameters lambda and inputSigma must be passed with the call to optimize.
CMAESOptimizer(int, double, boolean, int, int, RandomGenerator, boolean, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
 
CMAESOptimizer.PopulationSize - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
Population size.
CMAESOptimizer.PopulationSize - Class in org.apache.commons.math3.optimization.direct
Deprecated.
Population size.
CMAESOptimizer.Sigma - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
Input sigma values.
CMAESOptimizer.Sigma - Class in org.apache.commons.math3.optimization.direct
Deprecated.
Input sigma values.
CODE_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
CODE_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
CODE_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
CODE_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
codeOrRealDisplay(String) - Static method in class jminhep.utils.ResourceLoader
 
codeOrRealMsg(String) - Static method in class jminhep.utils.ResourceLoader
 
collector(BivariateFunction, UnivariateFunction, double) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Returns a MultivariateFunction h(x[]) defined by
collector(BivariateFunction, double) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Returns a MultivariateFunction h(x[]) defined by
CollectPowers - Class in org.lsmp.djep.rewrite
Collect powers together so that x*x -> x^2 and x^n*x -> x^(n+1).
CollectPowers(XJep) - Constructor for class org.lsmp.djep.rewrite.CollectPowers
 
COLON - Static variable in interface org.nfunk.jep.ParserConstants
 
color - Variable in class jplot3dp.ModelView.AxesDefinition
 
color_factor - Variable in class jplot3d.JSurface
 
COLOR_MODEL_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
ColorBar - Class in org.jfree.chart.axis
Deprecated.
This class is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
ColorBar(String) - Constructor for class org.jfree.chart.axis.ColorBar
Deprecated.
Constructs a horizontal colorbar axis, using default values where necessary.
ColorBlock - Class in org.jfree.chart.block
A block that is filled with a single color.
ColorBlock(Paint, double, double) - Constructor for class org.jfree.chart.block.ColorBlock
Creates a new block.
ColorChooser - Class in net.java.dev.colorchooser
A color chooser which can pop up a pluggable set of palettes.
ColorChooser() - Constructor for class net.java.dev.colorchooser.ColorChooser
Create a color chooser
ColorChooser(Color) - Constructor for class net.java.dev.colorchooser.ColorChooser
Create a color chooser initialized to the passed color, defaulted to show a continuous palette on initial click.
ColorChooser(Palette[], Color) - Constructor for class net.java.dev.colorchooser.ColorChooser
Create a color chooser with the passed array of 8 palettes and initialized with the passed color.
ColorChooser(Palette[]) - Constructor for class net.java.dev.colorchooser.ColorChooser
Create a color chooser with the passed array of 8 or fewer palettes.
ColorChooserBeanInfo - Class in net.java.dev.colorchooser
 
ColorChooserBeanInfo() - Constructor for class net.java.dev.colorchooser.ColorChooserBeanInfo
 
ColorChooserUI - Class in net.java.dev.colorchooser
Parent class of UI delegates for color choosers.
ColorDialog - Class in jplot3d
 
ColorDialog(Frame, Color) - Constructor for class jplot3d.ColorDialog
 
ColorModel - Class in jplot3d
Stands for a Color Model
ColorModel(byte, float, float, float, float, float) - Constructor for class jplot3d.ColorModel
 
colorModel - Variable in class jplot3d.SurfaceModelCanvas
 
ColorModelSet - Class in jplot3d
A simple ColorModel that uses two ColorMode per plot type.
ColorModelSet() - Constructor for class jplot3d.ColorModelSet
 
ColorPalette - Class in org.jfree.chart.plot
Deprecated.
This class is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
ColorPalette() - Constructor for class org.jfree.chart.plot.ColorPalette
Deprecated.
Default contructor.
ColorPalette - Class in org.jlab.groot.base
 
ColorPalette() - Constructor for class org.jlab.groot.base.ColorPalette
 
ColorPalette(int) - Method in class org.jlab.groot.base.ColorPalette
 
ColorPixel - Class in jhplot.utils
Static methods which help to convert colors and vectors with pixels.
ColorPixel() - Constructor for class jhplot.utils.ColorPixel
 
ColorPreview - Class in jplot.panels
A customized preview panel for the color chooser.
ColorPreview() - Constructor for class jplot.panels.ColorPreview
 
colorToString(Color) - Static method in class net.java.dev.colorchooser.ColorChooser
Get a string representation of a color, if possible returning a named, localized constant if the passed color matches one of the SVG constants; else returning a String representing RGB values.
cols(Zmat, int, int) - Static method in class Jampack.Swap
Interchances two columns of a Zmat (altered).
colt.hep.aida - package colt.hep.aida
Interfaces for compact, extensible, modular and performant histogramming functionality.
ColumnArrangement - Class in org.jfree.chart.block
Arranges blocks in a column layout.
ColumnArrangement() - Constructor for class org.jfree.chart.block.ColumnArrangement
Creates a new instance.
ColumnArrangement(HorizontalAlignment, VerticalAlignment, double, double) - Constructor for class org.jfree.chart.block.ColumnArrangement
Creates a new instance.
columns() - Method in class cern.colt.bitvector.BitMatrix
Returns the number of columns of the receiver.
columns() - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Returns the number of columns.
columns() - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Returns the number of columns.
COLUMNS - Static variable in class cern.jet.random.engine.RandomSeedTable
The number of columns of the matrix (currently COLUMNS = 2).
columnVector(double[]) - Static method in class jhplot.math.DoubleArray
Converts an n element array into an n x 1 matrix.
CombinationDataset - Interface in org.jfree.data.general
Deprecated.
1.0.13
Combinations - Class in org.apache.commons.math3.util
Utility to create combinations (n, k) of k elements in a set of n elements.
Combinations(int, int) - Constructor for class org.apache.commons.math3.util.Combinations
Creates an instance whose range is the k-element subsets of {0, ..., n - 1} represented as int[] arrays.
combinationsIterator(int, int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Returns an iterator whose range is the k-element subsets of {0, ..., n - 1} represented as int[] arrays.
CombinatoricsUtils - Class in org.apache.commons.math3.util
Combinatorial utilities.
combine(BivariateFunction, UnivariateFunction, UnivariateFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Returns the univariate function h(x) = combiner(f(x), g(x)).
combine(double, double, RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Returns a new vector representing a * this + b * y, the linear combination of this and y.
combine(double, double, RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Returns a new vector representing a * this + b * y, the linear combination of this and y.
combine(Range, Range) - Static method in class org.jfree.data.Range
Creates a new range by combining two existing ranges.
combine(Dimension2D) - Method in class org.jlab.groot.math.Dimension2D
 
combine(Dimension3D) - Method in class org.jlab.groot.math.Dimension3D
 
CombinedDataset - Class in org.jfree.data.general
Deprecated.
As of version 1.0.13. This class will be removed from JFreeChart 1.2.0 onwards. Anyone needing this facility will need to maintain it outside of JFreeChart.
CombinedDataset() - Constructor for class org.jfree.data.general.CombinedDataset
Deprecated.
Default constructor for an empty combination.
CombinedDataset(SeriesDataset[]) - Constructor for class org.jfree.data.general.CombinedDataset
Deprecated.
Creates a CombinedDataset initialized with an array of SeriesDatasets.
CombinedDomainCategoryPlot - Class in org.jfree.chart.plot
A combined category plot where the domain axis is shared.
CombinedDomainCategoryPlot() - Constructor for class org.jfree.chart.plot.CombinedDomainCategoryPlot
Default constructor.
CombinedDomainCategoryPlot(CategoryAxis) - Constructor for class org.jfree.chart.plot.CombinedDomainCategoryPlot
Creates a new plot.
CombinedDomainXYPlot - Class in org.jfree.chart.plot
An extension of XYPlot that contains multiple subplots that share a common domain axis.
CombinedDomainXYPlot() - Constructor for class org.jfree.chart.plot.CombinedDomainXYPlot
Default constructor.
CombinedDomainXYPlot(ValueAxis) - Constructor for class org.jfree.chart.plot.CombinedDomainXYPlot
Creates a new combined plot that shares a domain axis among multiple subplots.
CombinedRangeCategoryPlot - Class in org.jfree.chart.plot
A combined category plot where the range axis is shared.
CombinedRangeCategoryPlot() - Constructor for class org.jfree.chart.plot.CombinedRangeCategoryPlot
Default constructor.
CombinedRangeCategoryPlot(ValueAxis) - Constructor for class org.jfree.chart.plot.CombinedRangeCategoryPlot
Creates a new plot.
CombinedRangeXYPlot - Class in org.jfree.chart.plot
An extension of XYPlot that contains multiple subplots that share a common range axis.
CombinedRangeXYPlot() - Constructor for class org.jfree.chart.plot.CombinedRangeXYPlot
Default constructor.
CombinedRangeXYPlot(ValueAxis) - Constructor for class org.jfree.chart.plot.CombinedRangeXYPlot
Creates a new plot.
combineErr(int) - Method in class jhplot.P1D
Add 1st and 2nd level in quadrature and attribute the combined error to 1st level error.
combineIgnoringNaN(Range, Range) - Static method in class org.jfree.data.Range
Returns a new range that spans both range1 and range2.
combineToSelf(double, double, RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Updates this with the linear combination of this and y.
combineToSelf(double, double, RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Updates this with the linear combination of this and y.
combobox - Variable in class jplot.Utils.LabeledComboBox
 
COMMA - Static variable in interface org.nfunk.jep.ParserConstants
 
CommandElement - Class in org.nfunk.jep.evaluation
 
CommandElement() - Constructor for class org.nfunk.jep.evaluation.CommandElement
 
CommandEvaluator - Class in org.nfunk.jep.evaluation
 
CommandEvaluator() - Constructor for class org.nfunk.jep.evaluation.CommandEvaluator
 
CommandHandler - Class in hep.lcio.util
A CommandHandler handles the command-line options for a single command in the CommandLineTool.
CommandHandler(String, String) - Constructor for class hep.lcio.util.CommandHandler
CommandHandler ctor.
CommandHandler(String) - Constructor for class hep.lcio.util.CommandHandler
Ctor with default description.
CommandLineTool - Class in hep.lcio.util
CommandLineTool provides a command-line interface to LCIO utilities, similar to how the cvs command works.
CommandVisitor - Class in org.lsmp.djep.xjep
Executes commands like diff and eval embedded in expression trees.
CommandVisitor() - Constructor for class org.lsmp.djep.xjep.CommandVisitor
private default constructor to prevent init without a tree utils
CommandVisitorI - Interface in org.lsmp.djep.xjep
Interface defining the special actions performed during the preprocess stage.
CommonGUI - Class in jhplot.gui
Common components for all GUI
CommonGUI() - Constructor for class jhplot.gui.CommonGUI
 
COMMUTATIVE - Static variable in class org.lsmp.djep.xjep.XOperator
Commutative operators x*y = y*x.
Compactness - Static variable in class jminhep.clcontrol.Global
 
compactness(double[][], int[], int, double[][]) - Static method in class jminhep.cluster.Get
This method returns the cluster compactness
ComparableObjectItem - Class in org.jfree.data
Represents one (Comparable, Object) data item for use in a ComparableObjectSeries.
ComparableObjectItem(Comparable, Object) - Constructor for class org.jfree.data.ComparableObjectItem
Constructs a new data item.
ComparableObjectSeries - Class in org.jfree.data
A (possibly ordered) list of (Comparable, Object) data items.
ComparableObjectSeries(Comparable) - Constructor for class org.jfree.data.ComparableObjectSeries
Creates a new empty series.
ComparableObjectSeries(Comparable, boolean, boolean) - Constructor for class org.jfree.data.ComparableObjectSeries
Constructs a new series that contains no data.
Comparative - Class in org.nfunk.jep.function
Implements the comparative operations <, >, <=, >=, != and ==.
Comparative(int) - Constructor for class org.nfunk.jep.function.Comparative
Constructor.
comparator() - Method in class org.apache.commons.math3.util.Combinations
Defines a lexicographic ordering of combinations.
comparatorPermutation(List<S>, Comparator<S>) - Static method in class org.apache.commons.math3.genetics.RandomKey
Generates a representation of a permutation corresponding to the data sorted by comparator.
compare(byte, byte) - Method in interface cern.colt.function.ByteComparator
Compares its two arguments for order.
compare(char, char) - Method in interface cern.colt.function.CharComparator
Compares its two arguments for order.
compare(double, double) - Method in interface cern.colt.function.DoubleComparator
Compares its two arguments for order.
compare(float, float) - Method in interface cern.colt.function.FloatComparator
Compares its two arguments for order.
compare(int, int) - Method in interface cern.colt.function.IntComparator
Compares its two arguments for order.
compare(long, long) - Method in interface cern.colt.function.LongComparator
Compares its two arguments for order.
compare(short, short) - Method in interface cern.colt.function.ShortComparator
Compares its two arguments for order.
compare(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.doublealgo.DoubleMatrix1DComparator
Compares its two arguments for order.
compare(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.doublealgo.DoubleMatrix2DComparator
Compares its two arguments for order.
compare(ObjectMatrix1D, ObjectMatrix1D) - Method in interface cern.colt.matrix.objectalgo.ObjectMatrix1DComparator
Compares its two arguments for order.
compare(ObjectMatrix2D, ObjectMatrix2D) - Method in interface cern.colt.matrix.objectalgo.ObjectMatrix2DComparator
Compares its two arguments for order.
compare - Static variable in class cern.jet.math.Functions
Function that returns a < b ? -1 : a > b ? 1 : 0.
compare(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a < b ? -1 : a > b ? 1 : 0.
compare - Static variable in class cern.jet.math.IntFunctions
Function that returns a < b ? -1 : a > b ? 1 : 0.
compare(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a < b ? -1 : a > b ? 1 : 0.
compare(Object, Object) - Method in class hep.lcio.util.ObjectComparator
 
compare(Vector3) - Method in class j4np.physics.Vector3
 
compare(File, File) - Method in class org.apache.commons.io.comparator.CompositeFileComparator
Compare the two files using delegate comparators.
compare(File, File) - Method in class org.apache.commons.io.comparator.DefaultFileComparator
Compare the two files using the File.compareTo(File) method.
compare(File, File) - Method in class org.apache.commons.io.comparator.DirectoryFileComparator
Compare the two files using the File.isDirectory() method.
compare(File, File) - Method in class org.apache.commons.io.comparator.ExtensionFileComparator
Compare the extensions of two files the specified case sensitivity.
compare(File, File) - Method in class org.apache.commons.io.comparator.LastModifiedFileComparator
Compares the last the last modified date/time of two files.
compare(File, File) - Method in class org.apache.commons.io.comparator.NameFileComparator
Compare the names of two files with the specified case sensitivity.
compare(File, File) - Method in class org.apache.commons.io.comparator.PathFileComparator
Compare the paths of two files the specified case sensitivity.
compare(File, File) - Method in class org.apache.commons.io.comparator.SizeFileComparator
Compare the length of two files.
compare(Neuron, Neuron) - Method in class org.apache.commons.math3.ml.neuralnet.Network.NeuronIdentifierComparator
compare(Object, Object) - Method in class org.jfree.data.KeyedValueComparator
Compares two KeyedValue instances and returns an int that indicates the relative order of the two objects.
compare(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.BigReals
 
compare(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Integers
 
compare(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
compare(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Reals
 
compare(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Zn
 
compare(Number, Number) - Method in interface org.lsmp.djep.groupJep.interfaces.OrderedSetI
Returns -1,0,1 depending on whether a is less than, equal to or greater than b.
compare(Node, Node) - Method in class org.lsmp.djep.sjep.PolynomialCreator
Compares two nodes.
compareAndSetFeatures(double[], double[]) - Method in class org.apache.commons.math3.ml.neuralnet.Neuron
Tries to atomically update the neuron's features.
CompareCommandHandler - Class in hep.lcio.util
CommandHandler for the compare command.
CompareCommandHandler() - Constructor for class hep.lcio.util.CompareCommandHandler
 
CompareEvents - Class in hep.lcio.test
Simple program that compares the events in two lcio files, e.g.
CompareEvents() - Constructor for class hep.lcio.test.CompareEvents
 
compareLCEvent(Object, Object) - Method in class hep.lcio.util.ObjectComparator
 
compareObject(Object, Object) - Method in class hep.lcio.util.ObjectComparator
 
compareTo(BFunc) - Method in class fitter.BFunc
 
compareTo(ParticleD) - Method in class hephysics.jet.ParticleD
Comparator.
compareTo(ParticleF) - Method in class hephysics.jet.ParticleF
Comparator.
compareTo(LParticle) - Method in class hephysics.particle.LParticle
Comparator.
compareTo(Object) - Method in class jplot3d.JPoint
 
compareTo(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
Compares this object to another based on size.
compareTo(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
Compares this object to another based on size.
compareTo(Chromosome) - Method in class org.apache.commons.math3.genetics.Chromosome
Compares two chromosomes based on their fitness.
compareTo(OrderedTuple) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
Deprecated.
Compares this ordered T-uple with the specified object.
compareTo(BigReal) - Method in class org.apache.commons.math3.util.BigReal
compareTo(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
The current implementation returns the same value as new Double(this.doubleValue()).compareTo(new Double(o.doubleValue()))
compareTo(double, double, double) - Static method in class org.apache.commons.math3.util.Precision
Compares two numbers given some amount of allowed error.
compareTo(double, double, int) - Static method in class org.apache.commons.math3.util.Precision
Compares two numbers given some amount of allowed error.
compareTo(Object) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Will compare this Segment with another Segment (from Comparable interface).
compareTo(Object) - Method in class org.jfree.chart.axis.TickUnit
Compares this tick unit to an arbitrary object.
compareTo(Object) - Method in class org.jfree.chart.plot.PieLabelRecord
Compares this object to an arbitrary object.
compareTo(Object) - Method in class org.jfree.chart.renderer.Outlier
Compares this object with the specified object for order, based on the outlier's point.
compareTo(Object) - Method in class org.jfree.data.ComparableObjectItem
Returns an integer indicating the order of this object relative to another object.
compareTo(Object) - Method in class org.jfree.data.statistics.SimpleHistogramBin
Compares the bin to an arbitrary object and returns the relative ordering.
compareTo(Object) - Method in class org.jfree.data.time.Day
Returns an integer indicating the order of this Day object relative to the specified object: negative == before, zero == same, positive == after.
compareTo(Object) - Method in class org.jfree.data.time.FixedMillisecond
Returns an integer indicating the order of this Millisecond object relative to the specified object: negative == before, zero == same, positive == after.
compareTo(Object) - Method in class org.jfree.data.time.Hour
Returns an integer indicating the order of this Hour object relative to the specified object: negative == before, zero == same, positive == after.
compareTo(Object) - Method in class org.jfree.data.time.Millisecond
Returns an integer indicating the order of this Millisecond object relative to the specified object: negative == before, zero == same, positive == after.
compareTo(Object) - Method in class org.jfree.data.time.Minute
Returns an integer indicating the order of this Minute object relative to the specified object: negative == before, zero == same, positive == after.
compareTo(Object) - Method in class org.jfree.data.time.Month
Returns an integer indicating the order of this Month object relative to the specified object: negative == before, zero == same, positive == after.
compareTo(Object) - Method in class org.jfree.data.time.Quarter
Returns an integer indicating the order of this Quarter object relative to the specified object: negative == before, zero == same, positive == after.
compareTo(Object) - Method in class org.jfree.data.time.Second
Returns an integer indicating the order of this Second object relative to the specified object: negative == before, zero == same, positive == after.
compareTo(Object) - Method in class org.jfree.data.time.SimpleTimePeriod
Returns an integer that indicates the relative ordering of two time periods.
compareTo(Object) - Method in class org.jfree.data.time.TimeSeriesDataItem
Returns an integer indicating the order of this data pair object relative to another object.
compareTo(Object) - Method in class org.jfree.data.time.Week
Returns an integer indicating the order of this Week object relative to the specified object: negative == before, zero == same, positive == after.
compareTo(Object) - Method in class org.jfree.data.time.Year
Returns an integer indicating the order of this Year object relative to the specified object: negative == before, zero == same, positive == after.
compareTo(Object) - Method in class org.jfree.data.xy.OHLCDataItem
Compares this object with the specified object for order.
compareTo(Object) - Method in class org.jfree.data.xy.XYCoordinate
Compares this instance against an arbitrary object.
compareTo(Object) - Method in class org.jfree.data.xy.XYDataItem
Returns an integer indicating the order of this object relative to another object.
compareTo(Object) - Method in class org.lsmp.djep.groupJep.values.Rational
 
compareTo(PNodeI) - Method in class org.lsmp.djep.sjep.AbstractPNode
this < arg ---> -1 this > arg ---> 1
compareTo(PNodeI) - Method in class org.lsmp.djep.sjep.Monomial
Compare this to argument.
compareTo(PConstant) - Method in class org.lsmp.djep.sjep.PConstant
 
compareTo(PFunction) - Method in class org.lsmp.djep.sjep.PFunction
this < arg ---> -1 this > arg ---> 1
compareTo(PNodeI) - Method in interface org.lsmp.djep.sjep.PNodeI
Compares this expression to argument.
compareTo(PNodeI) - Method in class org.lsmp.djep.sjep.Polynomial
this < arg ---> -1 this > arg ---> 1
compareTo(Polynomial) - Method in class org.lsmp.djep.sjep.Polynomial
 
compareTo(POperator) - Method in class org.lsmp.djep.sjep.POperator
this < arg ---> -1 this > arg ---> 1
compareTo(PVariable) - Method in class org.lsmp.djep.sjep.PVariable
this < arg ---> -1 this > arg ---> 1
compareWeighted(Vector3) - Method in class j4np.physics.Vector3
 
compareWith(AbstractBin1D) - Method in class cern.hep.aida.bin.AbstractBin1D
Computes the deviations from the receiver's measures to another bin's measures.
compareWith(AbstractBin1D) - Method in class cern.hep.aida.bin.MightyStaticBin1D
Computes the deviations from the receiver's measures to another bin's measures.
compareWith(AbstractBin1D) - Method in class cern.hep.aida.bin.QuantileBin1D
Computes the deviations from the receiver's measures to another bin's measures.
CompassFormat - Class in org.jfree.chart.axis
A formatter that displays numbers as directions.
CompassFormat() - Constructor for class org.jfree.chart.axis.CompassFormat
Creates a new formatter using English identifiers.
CompassFormat(String, String, String, String) - Constructor for class org.jfree.chart.axis.CompassFormat
Creates a new formatter using the specified identifiers for the base wind directions.
CompassFormat(String[]) - Constructor for class org.jfree.chart.axis.CompassFormat
Creates a new formatter using the specified identifiers.
CompassPlot - Class in org.jfree.chart.plot
A specialised plot that draws a compass to indicate a direction based on the value from a ValueDataset.
CompassPlot() - Constructor for class org.jfree.chart.plot.CompassPlot
Default constructor.
CompassPlot(ValueDataset) - Constructor for class org.jfree.chart.plot.CompassPlot
Constructs a new compass plot.
compile(MatrixVariableI, Node) - Method in class org.lsmp.djep.mrpe.MRpEval
compile an expression of the type var = node.
compile(Node) - Method in class org.lsmp.djep.mrpe.MRpEval
Compile the expressions to produce a set of commands in reverse Polish notation.
compile(Node) - Method in class org.lsmp.djep.rpe.RpEval
Compile the expressions to produce a set of commands in reverse Polish notation.
compile(String) - Method in class org.lsmp.djepExamples.MRpDiffExample
Compile a sequence of equations.
compile(Node) - Method in class org.nfunk.jep.evaluation.ExpressionCompiler
 
complainIfNotSupported(String) - Method in class org.apache.commons.math3.ode.AbstractParameterizable
Check if a parameter is supported and throw an IllegalArgumentException if not.
Complex - Class in jhplot.math
Complex implements a complex number and defines complex arithmetic and mathematical functions Last Updated February 27, 2001 Copyright 1997-2001
Complex(double, double) - Constructor for class jhplot.math.Complex
Constructs the complex number z = u + i*v
Complex - Class in org.apache.commons.math3.complex
Representation of a Complex number, i.e.
Complex(double) - Constructor for class org.apache.commons.math3.complex.Complex
Create a complex number given only the real part.
Complex(double, double) - Constructor for class org.apache.commons.math3.complex.Complex
Create a complex number given the real and imaginary parts.
Complex - Class in org.nfunk.jep.type
Represents a complex number with double precision real and imaginary components.
Complex() - Constructor for class org.nfunk.jep.type.Complex
Default constructor.
Complex(double) - Constructor for class org.nfunk.jep.type.Complex
Constructor from a single double value.
Complex(Number) - Constructor for class org.nfunk.jep.type.Complex
Construct from a Number.
Complex(Complex) - Constructor for class org.nfunk.jep.type.Complex
Copy constructor
Complex(double, double) - Constructor for class org.nfunk.jep.type.Complex
Initialize the real and imaginary components to the values given by the parameters.
COMPLEX_I - Static variable in class org.lsmp.djep.xjep.PrintVisitor
Print Complex as 3+2 i
ComplexField - Class in org.apache.commons.math3.complex
Representation of the complex numbers field.
ComplexFormat - Class in org.apache.commons.math3.complex
Formats a Complex number in cartesian format "Re(c) + Im(c)i".
ComplexFormat() - Constructor for class org.apache.commons.math3.complex.ComplexFormat
Create an instance with the default imaginary character, 'i', and the default number format for both real and imaginary parts.
ComplexFormat(NumberFormat) - Constructor for class org.apache.commons.math3.complex.ComplexFormat
Create an instance with a custom number format for both real and imaginary parts.
ComplexFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.complex.ComplexFormat
Create an instance with a custom number format for the real part and a custom number format for the imaginary part.
ComplexFormat(String) - Constructor for class org.apache.commons.math3.complex.ComplexFormat
Create an instance with a custom imaginary character, and the default number format for both real and imaginary parts.
ComplexFormat(String, NumberFormat) - Constructor for class org.apache.commons.math3.complex.ComplexFormat
Create an instance with a custom imaginary character, and a custom number format for both real and imaginary parts.
ComplexFormat(String, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.complex.ComplexFormat
Create an instance with a custom imaginary character, a custom number format for the real part, and a custom number format for the imaginary part.
ComplexPFMC - Class in org.nfunk.jep.function
Converts a pair of real numbers to a complex number Complex(x,y)=x+i y.
ComplexPFMC() - Constructor for class org.nfunk.jep.function.ComplexPFMC
 
ComplexTest - Class in org.nfunk.jeptesting
 
ComplexTest(String) - Constructor for class org.nfunk.jeptesting.ComplexTest
 
ComplexUtils - Class in org.apache.commons.math3.complex
Static implementations of common Complex utilities functions.
complexValue(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
Returns the Complex value represented by node
complexValueOf(Object) - Static method in class org.lsmp.djep.groupJep.GroupJep
A utility function which returns the complex aproximation of a number.
complexValueTest(String, Complex, double) - Method in class org.lsmp.djepJUnit.JepTest
Test parse-evaluate with complex number and given tollerence.
complexValueTest(String, Complex, double) - Method in class org.lsmp.djepJUnit.MRpTest
 
complexValueTest(String, Complex, double) - Method in class org.lsmp.djepJUnit.RpTest
 
complexValueTest(String, Complex, double) - Method in class org.lsmp.djepJUnit.SJepTest
 
componentHidden(ComponentEvent) - Method in class jhplot.gui.GHFrame
 
componentHidden(ComponentEvent) - Method in class jhplot.gui.GHPanel
 
componentMoved(ComponentEvent) - Method in class jhplot.gui.GHFrame
 
componentMoved(ComponentEvent) - Method in class jhplot.gui.GHPanel
 
componentResized(ComponentEvent) - Method in class jhplot.gui.GHPanel
 
componentShown(ComponentEvent) - Method in class jhplot.gui.GHFrame
 
componentShown(ComponentEvent) - Method in class jhplot.gui.GHPanel
 
compose(DoubleMatrix2D[][]) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a block matrix made from the given parts.
compose(ObjectMatrix2D[][]) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a block matrix made from the given parts.
compose(Vector3) - Method in class j4np.physics.TransMatrix
 
compose(IOFunction<? super V, ? extends T>) - Method in interface org.apache.commons.io.function.IOFunction
Returns a composed IOFunction that first applies the before function to its input, and then applies this function to the result.
compose(Function<? super V, ? extends T>) - Method in interface org.apache.commons.io.function.IOFunction
Returns a composed IOFunction that first applies the before function to its input, and then applies this function to the result.
compose(IOSupplier<? extends T>) - Method in interface org.apache.commons.io.function.IOFunction
Returns a composed IOFunction that first applies the before function to its input, and then applies this function to the result.
compose(Supplier<? extends T>) - Method in interface org.apache.commons.io.function.IOFunction
Returns a composed IOFunction that first applies the before function to its input, and then applies this function to the result.
compose(double...) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute composition of the instance by a univariate function.
compose(double[], int, double[], double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute composition of a derivative structure by a function.
compose(double, double) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute composition of the instance by a univariate function.
compose(UnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Composes functions.
compose(UnivariateDifferentiableFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Composes functions.
compose(DifferentiableUnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
compose(FieldRotation<T>, RotationConvention) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Compose the instance with another rotation.
compose(Rotation, RotationConvention) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Compose the instance with another rotation.
compose(Rotation, RotationConvention) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Compose the instance with another rotation.
composeDiagonal(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a diagonal block matrix from the given parts (the direct sum of two matrices).
composeDiagonal(DoubleMatrix2D, DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a diagonal block matrix from the given parts.
composeDiagonal(ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a diagonal block matrix from the given parts (the direct sum of two matrices).
composeDiagonal(ObjectMatrix2D, ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a diagonal block matrix from the given parts.
composeInverse(FieldRotation<T>, RotationConvention) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Compose the inverse of the instance with another rotation.
composeInverse(Rotation, RotationConvention) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Compose the inverse of the instance with another rotation.
composeInverse(Rotation, RotationConvention) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Compose the inverse of the instance with another rotation.
COMPOSITE - Static variable in class org.lsmp.djep.xjep.XOperator
composite operators, like a-b which is a+(-b)
CompositeFileComparator - Class in org.apache.commons.io.comparator
Compare two files using a set of delegate file Comparator.
CompositeFileComparator(Comparator<File>...) - Constructor for class org.apache.commons.io.comparator.CompositeFileComparator
Create a composite comparator for the set of delegate comparators.
CompositeFileComparator(Iterable<Comparator<File>>) - Constructor for class org.apache.commons.io.comparator.CompositeFileComparator
Create a composite comparator for the set of delegate comparators.
CompositeFormat - Class in org.apache.commons.math3.util
Base class for formatters of composite objects (complex numbers, vectors ...).
CompositeTitle - Class in org.jfree.chart.title
A title that contains multiple titles within a BlockContainer.
CompositeTitle() - Constructor for class org.jfree.chart.title.CompositeTitle
Creates a new composite title with a default border arrangement.
CompositeTitle(BlockContainer) - Constructor for class org.jfree.chart.title.CompositeTitle
Creates a new title using the specified container.
compute(double[], double[]) - Method in class org.apache.commons.math3.ml.distance.CanberraDistance
Compute the distance between two n-dimensional vectors.
compute(double[], double[]) - Method in class org.apache.commons.math3.ml.distance.ChebyshevDistance
Compute the distance between two n-dimensional vectors.
compute(double[], double[]) - Method in interface org.apache.commons.math3.ml.distance.DistanceMeasure
Compute the distance between two n-dimensional vectors.
compute(double[], double[]) - Method in class org.apache.commons.math3.ml.distance.EarthMoversDistance
Compute the distance between two n-dimensional vectors.
compute(double[], double[]) - Method in class org.apache.commons.math3.ml.distance.EuclideanDistance
Compute the distance between two n-dimensional vectors.
compute(double[], double[]) - Method in class org.apache.commons.math3.ml.distance.ManhattanDistance
Compute the distance between two n-dimensional vectors.
compute(MathArrays.Function) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Performs an operation on the addressable elements of the array.
computeAngle(double[], double[], double[]) - Static method in class jplot.Geometry
Find the angle between twree points.
computeCorrelationMatrix(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.KendallsCorrelation
Computes the Kendall's Tau rank correlation matrix for the columns of the input matrix.
computeCorrelationMatrix(double[][]) - Method in class org.apache.commons.math3.stat.correlation.KendallsCorrelation
Computes the Kendall's Tau rank correlation matrix for the columns of the input rectangular array.
computeCorrelationMatrix(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Computes the correlation matrix for the columns of the input matrix, using PearsonsCorrelation.correlation(double[], double[]).
computeCorrelationMatrix(double[][]) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Computes the correlation matrix for the columns of the input rectangular array.
computeCorrelationMatrix(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Computes the Spearman's rank correlation matrix for the columns of the input matrix.
computeCorrelationMatrix(double[][]) - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Computes the Spearman's rank correlation matrix for the columns of the input rectangular array.
computeCovariances(double[], double) - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Deprecated.
Get the covariance matrix of the optimized parameters.
computeCovariances(double[], double) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated.
Get the covariance matrix of the optimized parameters.
computeCrossProduct(double[], double[]) - Static method in class jplot.Geometry
Compute the cross product (a vector) of two vectors.
computeDerivatives(T, T[]) - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Compute the derivatives and check the number of evaluations.
computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Compute the derivatives and check the number of evaluations.
computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get the current time derivative of the complete state vector.
computeDerivatives(T, T[]) - Method in class org.apache.commons.math3.ode.FieldExpandableODE
Get the current time derivative of the complete state vector.
computeDerivatives(T, T[], T[], T[]) - Method in interface org.apache.commons.math3.ode.FieldSecondaryEquations
Compute the derivatives related to the secondary state parameters.
computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math3.ode.FirstOrderConverter
Get the current time derivative of the state vector.
computeDerivatives(double, double[], double[]) - Method in interface org.apache.commons.math3.ode.FirstOrderDifferentialEquations
Get the current time derivative of the state vector.
computeDerivatives(T, T[]) - Method in interface org.apache.commons.math3.ode.FirstOrderFieldDifferentialEquations
Get the current time derivative of the state vector.
computeDerivatives(double, double[], double[], double[], double[]) - Method in interface org.apache.commons.math3.ode.SecondaryEquations
Compute the derivatives related to the secondary state parameters.
computeDistribution() - Method in class org.apache.commons.math3.random.ValueServer
Computes the empirical distribution using values from the file in valuesFileURL, using the default number of bins.
computeDistribution(int) - Method in class org.apache.commons.math3.random.ValueServer
Computes the empirical distribution using values from the file in valuesFileURL and binCount bins.
computeDotProduct(double[], double[]) - Static method in class jplot.Geometry
Compute the dot product (a scalar) between two vectors.
computeExp(Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.DfpField
Compute exp(a).
computeHitHistogram(Iterable<double[]>, NeuronSquareMesh2D, DistanceMeasure) - Static method in class org.apache.commons.math3.ml.neuralnet.MapUtils
Computes the "hit" histogram of a two-dimensional map.
computeImage(NeuronSquareMesh2D, Iterable<double[]>) - Method in class org.apache.commons.math3.ml.neuralnet.twod.util.HitHistogram
Creates an image of the data metrics when represented by the map.
computeImage(NeuronSquareMesh2D, Iterable<double[]>) - Method in interface org.apache.commons.math3.ml.neuralnet.twod.util.MapDataVisualization
Creates an image of the data metrics when represented by the map.
computeImage(NeuronSquareMesh2D) - Method in interface org.apache.commons.math3.ml.neuralnet.twod.util.MapVisualization
Creates an image of the map.
computeImage(NeuronSquareMesh2D, Iterable<double[]>) - Method in class org.apache.commons.math3.ml.neuralnet.twod.util.QuantizationError
Creates an image of the data metrics when represented by the map.
computeImage(NeuronSquareMesh2D, Iterable<double[]>) - Method in class org.apache.commons.math3.ml.neuralnet.twod.util.SmoothedDataHistogram
Creates an image of the data metrics when represented by the map.
computeImage(NeuronSquareMesh2D, Iterable<double[]>) - Method in class org.apache.commons.math3.ml.neuralnet.twod.util.TopographicErrorHistogram
Creates an image of the data metrics when represented by the map.
computeImage(NeuronSquareMesh2D) - Method in class org.apache.commons.math3.ml.neuralnet.twod.util.UnifiedDistanceMatrix
Creates an image of the map.
computeJacobian(double[]) - Method in interface org.apache.commons.math3.fitting.leastsquares.ValueAndJacobianFunction
Compute the Jacobian.
computeLn(Dfp, Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.DfpField
Compute ln(a).
computeMainStateJacobian(double, double[], double[], double[][]) - Method in interface org.apache.commons.math3.ode.MainStateJacobianProvider
Compute the jacobian matrix of ODE with respect to main state.
computeNbrOfChars(int, int) - Static method in class net.jafama.NumbersUtils
 
computeNbrOfChars(long, int) - Static method in class net.jafama.NumbersUtils
 
computeNbrOfChars(int, int, int) - Static method in class net.jafama.NumbersUtils
 
computeNbrOfChars(long, int, int) - Static method in class net.jafama.NumbersUtils
 
computeNbrOfDigits(int, int) - Static method in class net.jafama.NumbersUtils
 
computeNbrOfDigits(long, int) - Static method in class net.jafama.NumbersUtils
 
computeNbrOfDigits(int, int, int) - Static method in class net.jafama.NumbersUtils
 
computeNbrOfDigits(long, int, int) - Static method in class net.jafama.NumbersUtils
 
computeObjectiveValue(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateOptimizer
Computes the objective function value.
computeParameterJacobian(double, double[], double[], String, double[]) - Method in interface org.apache.commons.math3.ode.ParameterJacobianProvider
Compute the Jacobian matrix of ODE with respect to one parameter.
computePlotArea() - Method in class jplot3d.JSurface
Common method for contour plot and density plot that computes the best plot area size and position.
computePointOnLine(double[], double[], double) - Static method in class jplot.Geometry
Find the point on the line p0,p1 [x,y,z] a given fraction from p0.
computePointOnLine(double, double, double, double, double) - Static method in class jplot.Geometry
Find the point on the line defined by x0,y0,x1,y1 a given fraction from x0,y0.
computePolygonArea(double[], double[]) - Static method in class jplot.Geometry
Compute the area of the specfied polygon.
computePolygonArea(double[]) - Static method in class jplot.Geometry
Compute the area of the specfied polygon.
computePolygonCentroid(double[], double[]) - Static method in class jplot.Geometry
Compute centorid (center of gravity) of specified polygon.
computeQuantizationError(Iterable<double[]>, Iterable<Neuron>, DistanceMeasure) - Static method in class org.apache.commons.math3.ml.neuralnet.MapUtils
Computes the quantization error.
computeRoots(int) - Method in class org.apache.commons.math3.complex.RootsOfUnity
Computes the n-th roots of unity.
computeSecondDerivatives(double, double[], double[], double[]) - Method in interface org.apache.commons.math3.ode.SecondOrderDifferentialEquations
Get the current time derivative of the state vector.
computeSigma(double[], double) - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Deprecated.
Computes an estimate of the standard deviation of the parameters.
computeSigma(double[], double) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated.
Computes an estimate of the standard deviation of the parameters.
computeTicks(double, double, int, boolean) - Static method in class jplot.Axis
this is the central method of this class.
computeTopographicError(Iterable<double[]>, Network, DistanceMeasure) - Static method in class org.apache.commons.math3.ml.neuralnet.MapUtils
Computes the topographic error.
computeU(NeuronSquareMesh2D, DistanceMeasure) - Static method in class org.apache.commons.math3.ml.neuralnet.MapUtils
Computes the U-matrix of a two-dimensional map.
computeValue(double[]) - Method in interface org.apache.commons.math3.fitting.leastsquares.ValueAndJacobianFunction
Compute the value.
concat(Object[]) - Static method in class jminhep.utils.StringUtil
Takes a list of objects and concatenates the toString() representation of each object and returns the result.
concat(String, String) - Static method in class org.apache.commons.io.FilenameUtils
Concatenates a fileName to a base path using normal command line style rules.
Concatenate - Class in hep.lcio.util
Concatenation utility to combined many LCIO files into one.
Concatenate() - Constructor for class hep.lcio.util.Concatenate
 
concatenate(List, File) - Static method in class hep.lcio.util.Concatenate
Method to concatenate list of LCIO files to outfile.
concatenate(File, File) - Static method in class jhplot.math.io.ASCIIFile
 
concatenate(double[]...) - Static method in class org.apache.commons.math3.util.MathArrays
Concatenates a sequence of arrays.
ConcatenateCommandHandler - Class in hep.lcio.util
Command-line handling for concat command.
concatFiles() - Method in class hep.lcio.util.LCIOConcat
 
cond(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the condition of matrix A, which is the ratio of largest to smallest singular value.
cond() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the two norm condition number, which is max(S) / min(S).
cond() - Method in class Jama.Matrix
Matrix condition (2 norm)
cond() - Method in class Jama.SingularValueDecomposition
Two norm condition number
cond(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
cond() - Method in class jhplot.math.SingularValueDecomposition
Two norm condition number
ConditionalFileFilter - Interface in org.apache.commons.io.filefilter
Defines operations for conditional file filters.
ConfidenceInterval - Class in org.apache.commons.math3.stat.interval
Represents an interval estimate of a population parameter.
ConfidenceInterval(double, double, double) - Constructor for class org.apache.commons.math3.stat.interval.ConfidenceInterval
Create a confidence interval with the given bounds and confidence level.
ConfidenceLevel - Class in jhplot.stat
Confidence level calculations.
ConfidenceLevel() - Constructor for class jhplot.stat.ConfidenceLevel
Default constructor.
ConfidenceLevel(int) - Constructor for class jhplot.stat.ConfidenceLevel
Construct ConfLevel
ConfidenceLevel(int, boolean) - Constructor for class jhplot.stat.ConfidenceLevel
Build confidence level.
configure() - Method in class org.jfree.chart.axis.Axis
Configures the axis to work with the current plot.
configure() - Method in class org.jfree.chart.axis.CategoryAxis
Configures the axis against the current plot.
configure(ContourPlot) - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Configures the color bar.
configure() - Method in class org.jfree.chart.axis.DateAxis
Configures the axis to work with the specified plot.
configure() - Method in class org.jfree.chart.axis.LogAxis
Configures the axis.
configure() - Method in class org.jfree.chart.axis.NumberAxis
Configures the axis to work with the specified plot.
configure() - Method in class org.jfree.chart.axis.PeriodAxis
Configures the axis to work with the current plot.
configure() - Method in interface org.jlab.groot.tree.ITree
 
configure() - Method in class org.jlab.groot.tree.Tree
 
configureDomainAxes() - Method in class org.jfree.chart.plot.CategoryPlot
Configures the domain axes.
configureDomainAxes() - Method in class org.jfree.chart.plot.XYPlot
Configures the domain axes.
configureRangeAxes() - Method in class org.jfree.chart.plot.CategoryPlot
Configures the range axes.
configureRangeAxes() - Method in class org.jfree.chart.plot.XYPlot
Configures the range axes.
Conj(Z) - Method in class Jampack.Z
Computes the conjugate of a Z.
conj() - Method in class jhplot.math.Complex
Complex conjugate of this Complex number (the conjugate of x+i*y is x-i*y).
conj(Object) - Method in class org.nfunk.jep.function.Conjugate
 
conj() - Method in class org.nfunk.jep.type.Complex
Returns the complex conjugate.
conjugate() - Method in class org.apache.commons.math3.complex.Complex
Returns the conjugate of this complex number.
Conjugate - Class in org.nfunk.jep.function
The complex conjugate of a number conj(c)
Conjugate() - Constructor for class org.nfunk.jep.function.Conjugate
 
ConjugateGradient - Class in org.apache.commons.math3.linear
This is an implementation of the conjugate gradient method for RealLinearOperator.
ConjugateGradient(int, double, boolean) - Constructor for class org.apache.commons.math3.linear.ConjugateGradient
Creates a new instance of this class, with default stopping criterion.
ConjugateGradient(IterationManager, double, boolean) - Constructor for class org.apache.commons.math3.linear.ConjugateGradient
Creates a new instance of this class, with default stopping criterion and custom iteration manager.
ConjugateGradientFormula - Enum in org.apache.commons.math3.optimization.general
Deprecated.
As of 3.1 (to be removed in 4.0).
Console - Class in org.lsmp.djepExamples
This class implements a simple command line utility for evaluating mathematical expressions.
Console() - Constructor for class org.lsmp.djepExamples.Console
Constructor
CONST - Static variable in class org.lsmp.djep.rpe.RpEval
Index for each command
CONST - Static variable in class org.nfunk.jep.evaluation.CommandElement
 
constant(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns the constant c.
constant(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns the constant c.
Constant - Class in org.apache.commons.math3.analysis.function
Constant function.
Constant(double) - Constructor for class org.apache.commons.math3.analysis.function.Constant
 
CONSTANT_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Always return mu
ConstantRealDistribution - Class in org.apache.commons.math3.distribution
Implementation of the constant real distribution.
ConstantRealDistribution(double) - Constructor for class org.apache.commons.math3.distribution.ConstantRealDistribution
Create a constant real distribution with the given value.
Constants - Class in cern.jet.math
Defines some useful constants.
Constants - Interface in jhplot.math.num
Common constants found in mathematical formulas.
Constants - Interface in jminhep.gui
Set main constants
constrain(double) - Method in class org.jfree.data.Range
Returns the value within the range that is closest to the specified value.
constructWithCopy(double[][]) - Static method in class Jama.Matrix
Construct a matrix from a copy of a 2-D array.
constructWithCopy(double[][]) - Static method in class jhplot.math.kalman.jama.Matrix
Construct a matrix from a copy of a 2-D array.
consume() - Method in class org.apache.commons.io.input.ObservableInputStream
Reads all data from the underlying InputStream, while notifying the observers.
consume(InputStream) - Static method in class org.apache.commons.io.IOUtils
Consumes bytes from a InputStream and ignores them.
contained(long, long) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns true if this segment is contained in an interval.
contains(boolean) - Method in class cern.colt.list.AbstractBooleanList
Returns true if the receiver contains the specified element.
contains(byte) - Method in class cern.colt.list.AbstractByteList
Returns true if the receiver contains the specified element.
contains(char) - Method in class cern.colt.list.AbstractCharList
Returns true if the receiver contains the specified element.
contains(double) - Method in class cern.colt.list.AbstractDoubleList
Returns true if the receiver contains the specified element.
contains(float) - Method in class cern.colt.list.AbstractFloatList
Returns true if the receiver contains the specified element.
contains(int) - Method in class cern.colt.list.AbstractIntList
Returns true if the receiver contains the specified element.
contains(long) - Method in class cern.colt.list.AbstractLongList
Returns true if the receiver contains the specified element.
contains(short) - Method in class cern.colt.list.AbstractShortList
Returns true if the receiver contains the specified element.
contains(Object, boolean) - Method in class cern.colt.list.ObjectArrayList
Returns true if the receiver contains the specified element.
contains(double, double) - Method in class jhplot.shapes.HShape
 
contains(double, double) - Method in class jplot.GraphLabel
Checks whether x,y falls within the bounding box of the current text.
contains(double, double, float) - Method in class jplot.GraphLabel
 
contains(P) - Method in class org.apache.commons.math3.geometry.enclosing.EnclosingBall
Check if a point is within the ball or at boundary.
contains(P, double) - Method in class org.apache.commons.math3.geometry.enclosing.EnclosingBall
Check if a point is within an enlarged ball or at boundary.
contains(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Check if the instance contains a point.
contains(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Check if the instance contains a point.
contains(Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Check if the line contains a point.
contains(Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check if the instance entirely contains another region.
contains(Region<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Check if the instance entirely contains another region.
contains(long) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns true if a particular millisecond is contained in this segment.
contains(long, long) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns true if an interval is contained in this segment.
contains(SegmentedTimeline.Segment) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns true if a segment is contained in this segment.
contains(double) - Method in class org.jfree.data.Range
Returns true if the range contains the specified value and false otherwise.
contains(double) - Method in class org.jlab.groot.math.Dimension1D
 
contains(double, double) - Method in class org.jlab.groot.math.Dimension2D
 
containsAll(double[]) - Method in class jhplot.P0D
Tests the collection to determine if all of the elements in array are present.
containsAll(double[]) - Method in class jhplot.P0I
Tests the collection to determine if all of the elements in array are present.
containsClass(Class<?>) - Method in class org.apache.commons.math3.util.TransformerMap
Tests if a Class is present in the TransformerMap.
containsDomainRange(long, long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns true if a range of values are contained in the timeline.
containsDomainRange(Date, Date) - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns true if a range of values are contained in the timeline.
containsDomainRange(long, long) - Method in interface org.jfree.chart.axis.Timeline
Returns true if a range of values are contained in the timeline.
containsDomainRange(Date, Date) - Method in interface org.jfree.chart.axis.Timeline
Returns true if a range of dates are contained in the timeline.
containsDomainValue(long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns true if a value is contained in the timeline.
containsDomainValue(Date) - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns true if a value is contained in the timeline.
containsDomainValue(long) - Method in interface org.jfree.chart.axis.Timeline
Returns true if a value is contained in the timeline values.
containsDomainValue(Date) - Method in interface org.jfree.chart.axis.Timeline
Returns true if a date is contained in the timeline values.
containsKey(double) - Method in class cern.colt.map.AbstractDoubleIntMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.AbstractIntDoubleMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.AbstractIntIntMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.AbstractIntObjectMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.AbstractLongObjectMap
Returns true if the receiver contains the specified key.
containsKey(double) - Method in class cern.colt.map.OpenDoubleIntHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.OpenIntDoubleHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.OpenIntIntHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.OpenIntObjectHashMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.OpenLongObjectHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Check if a value is associated with a key.
containsKey(int) - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Check if a value is associated with a key.
containsKey(Comparable) - Method in class org.jfree.chart.PaintMap
Returns true if the map contains the specified key, and false otherwise.
containsKey(Comparable) - Method in class org.jfree.chart.StrokeMap
Returns true if the map contains the specified key, and false otherwise.
containsRequired() - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
containsTransformer(NumberTransformer) - Method in class org.apache.commons.math3.util.TransformerMap
Tests if a NumberTransformer is present in the TransformerMap.
containsValue(int) - Method in class cern.colt.map.AbstractDoubleIntMap
Returns true if the receiver contains the specified value.
containsValue(double) - Method in class cern.colt.map.AbstractIntDoubleMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.AbstractIntIntMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.AbstractIntObjectMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.AbstractLongObjectMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.OpenDoubleIntHashMap
Returns true if the receiver contains the specified value.
containsValue(double) - Method in class cern.colt.map.OpenIntDoubleHashMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.OpenIntIntHashMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.OpenIntObjectHashMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.OpenLongObjectHashMap
Returns true if the receiver contains the specified value.
contentEquals(File, File) - Static method in class org.apache.commons.io.FileUtils
Compares the contents of two files to determine if they are equal or not.
contentEquals(InputStream, InputStream) - Static method in class org.apache.commons.io.IOUtils
Compares the contents of two Streams to determine if they are equal or not.
contentEquals(Reader, Reader) - Static method in class org.apache.commons.io.IOUtils
Compares the contents of two Readers to determine if they are equal or not.
contentEqualsIgnoreEOL(File, File, String) - Static method in class org.apache.commons.io.FileUtils
Compares the contents of two files to determine if they are equal or not.
contentEqualsIgnoreEOL(Reader, Reader) - Static method in class org.apache.commons.io.IOUtils
Compares the contents of two Readers to determine if they are equal or not, ignoring EOL characters.
ContinuedFraction - Class in jhplot.math.num
This class provides the means to evaluate continued fractions (1).
ContinuedFraction - Class in org.apache.commons.math3.util
Provides a generic means to evaluate continued fractions.
continueParse() - Method in class org.nfunk.jep.Parser
Continue parsing without re-initilising stream.
continueParsing() - Method in class org.lsmp.djep.xjep.XJep
Continue parsing without re-initilising the stream.
ContinuousDistribution - Class in jhplot.math.num.pdf
Base continuous distribution.
ContinuousDistribution() - Constructor for class jhplot.math.num.pdf.ContinuousDistribution
 
ContinuousOutputFieldModel<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode
This class stores all information provided by an ODE integrator during the integration process and build a continuous model of the solution from this.
ContinuousOutputFieldModel() - Constructor for class org.apache.commons.math3.ode.ContinuousOutputFieldModel
Simple constructor.
ContinuousOutputModel - Class in org.apache.commons.math3.ode
This class stores all information provided by an ODE integrator during the integration process and build a continuous model of the solution from this.
ContinuousOutputModel() - Constructor for class org.apache.commons.math3.ode.ContinuousOutputModel
Simple constructor.
ContinuousRandomVariable - Interface in jhplot.math.num.random
A random variable generator for a continuous distribution.
Contour - Class in graph
This class extends the interactive graphics class G2Dint to incorporate contouring.
Contour() - Constructor for class graph.Contour
Instantaite the class
Contour - Class in jplot
 
Contour(boolean, int, int, boolean, int) - Constructor for class jplot.Contour
 
CONTOUR - Static variable in class jplot.LinePars
 
contour(int, int) - Method in class org.freehep.math.minuit.MnContours
 
contour(int, int, double) - Method in class org.freehep.math.minuit.MnContours
 
contour(int, int, double, int) - Method in class org.freehep.math.minuit.MnContours
Causes a CONTOURS error analysis and returns the result in form of ContoursError.
CONTOUR_2D - Static variable in class jplot.GraphSettings
Graphtype, contour type most people want (and the default).
contour_lines - Variable in class jplot3d.JSurface
 
CONTOUR_LINES_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
contour_stepz - Variable in class jplot3d.JSurface
 
contour_vertex - Variable in class jplot3d.JSurface
 
contourConvertX(float) - Method in class jplot3d.JSurface
Converts normalized x coordinate (-10..+10) to screen x coordinate
contourConvertY(float) - Method in class jplot3d.JSurface
Converts normalized y coordinate (-10..+10) to screen y coordinate
ContourDataset - Interface in org.jfree.data.contour
Deprecated.
This interface is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
ContourEntity - Class in org.jfree.chart.entity
Deprecated.
This class is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
ContourEntity(Shape, String) - Constructor for class org.jfree.chart.entity.ContourEntity
Deprecated.
Constructor for ContourEntity.
ContourEntity(Shape, String, String) - Constructor for class org.jfree.chart.entity.ContourEntity
Deprecated.
Constructor for ContourEntity.
ContourPlot - Class in org.jfree.chart.plot
Deprecated.
This plot is no longer supported, please use XYPlot with an XYBlockRenderer.
ContourPlot() - Constructor for class org.jfree.chart.plot.ContourPlot
Deprecated.
Creates a new plot with no dataset or axes.
ContourPlot(ContourDataset, ValueAxis, ValueAxis, ColorBar) - Constructor for class org.jfree.chart.plot.ContourPlot
Deprecated.
Constructs a contour plot with the specified axes (other attributes take default values).
ContourPlotUtilities - Class in org.jfree.chart.plot
Deprecated.
This class is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
ContourPlotUtilities() - Constructor for class org.jfree.chart.plot.ContourPlotUtilities
Deprecated.
 
contourRenderer(Graphics2D, Rectangle2D, PlotRenderingInfo, ContourPlot, ValueAxis, ValueAxis, ColorBar, ContourDataset, CrosshairState) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Fills the plot.
ContoursError - Class in org.freehep.math.minuit
 
ContourToolTipGenerator - Interface in org.jfree.chart.labels
Deprecated.
This interface is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
ContourValuePlot - Interface in org.jfree.chart.plot
Deprecated.
This interface is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
contract() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Contracts the storage array to the (size of the element set) + 1 - to avoid a zero length array.
converged(int, LeastSquaresProblem.Evaluation, LeastSquaresProblem.Evaluation) - Method in class org.apache.commons.math3.fitting.leastsquares.EvaluationRmsChecker
Check if the optimization algorithm has converged.
converged(int, PAIR, PAIR) - Method in class org.apache.commons.math3.optim.AbstractConvergenceChecker
Check if the optimization algorithm has converged.
converged(int, PAIR, PAIR) - Method in interface org.apache.commons.math3.optim.ConvergenceChecker
Check if the optimization algorithm has converged.
converged(int, PAIR, PAIR) - Method in class org.apache.commons.math3.optim.SimplePointChecker
Check if the optimization algorithm has converged considering the last two points.
converged(int, PointValuePair, PointValuePair) - Method in class org.apache.commons.math3.optim.SimpleValueChecker
Check if the optimization algorithm has converged considering the last two points.
converged(int, PointVectorValuePair, PointVectorValuePair) - Method in class org.apache.commons.math3.optim.SimpleVectorValueChecker
Check if the optimization algorithm has converged considering the last two points.
converged(int, UnivariatePointValuePair, UnivariatePointValuePair) - Method in class org.apache.commons.math3.optim.univariate.SimpleUnivariateValueChecker
Check if the optimization algorithm has converged considering the last two points.
converged(int, PAIR, PAIR) - Method in class org.apache.commons.math3.optimization.AbstractConvergenceChecker
Deprecated.
Check if the optimization algorithm has converged.
converged(int, PAIR, PAIR) - Method in interface org.apache.commons.math3.optimization.ConvergenceChecker
Deprecated.
Check if the optimization algorithm has converged.
converged(int, PAIR, PAIR) - Method in class org.apache.commons.math3.optimization.SimplePointChecker
Deprecated.
Check if the optimization algorithm has converged considering the last two points.
converged(int, PointValuePair, PointValuePair) - Method in class org.apache.commons.math3.optimization.SimpleValueChecker
Deprecated.
Check if the optimization algorithm has converged considering the last two points.
converged(int, PointVectorValuePair, PointVectorValuePair) - Method in class org.apache.commons.math3.optimization.SimpleVectorValueChecker
Deprecated.
Check if the optimization algorithm has converged considering the last two points.
converged(int, UnivariatePointValuePair, UnivariatePointValuePair) - Method in class org.apache.commons.math3.optimization.univariate.SimpleUnivariateValueChecker
Deprecated.
Check if the optimization algorithm has converged considering the last two points.
ConvergenceChecker<PAIR> - Interface in org.apache.commons.math3.optim
This interface specifies how to check if an optimization algorithm has converged.
ConvergenceChecker<PAIR> - Interface in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
ConvergenceException - Exception in jhplot.math.num
The exception raised when an iterative method fails to converge.
ConvergenceException(String) - Constructor for exception jhplot.math.num.ConvergenceException
Create an execption with the given message.
ConvergenceException - Exception in org.apache.commons.math3.exception
Error thrown when a numerical computation can not be performed because the numerical result failed to converge to a finite value.
ConvergenceException() - Constructor for exception org.apache.commons.math3.exception.ConvergenceException
Construct the exception.
ConvergenceException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.ConvergenceException
Construct the exception with a specific context and arguments.
converSubScript(String) - Static method in class org.jlab.groot.ui.LatexTextTools
 
converSuperScript(String) - Static method in class org.jlab.groot.ui.LatexTextTools
 
convert(StdhepEvent) - Method in class hep.physics.stdhep.convert.StdhepConverter
Convert from a StdhepEvent to an MCEvent.
convert(MCEvent) - Method in class hep.physics.stdhep.convert.StdhepConverter
Convert from an EventHeader to a StdhepEvent.
convert(double, Dimension1D) - Method in class org.jlab.groot.math.Dimension1D
 
convert(TH1, String) - Static method in class root.Converter
 
convert(TH2, String) - Static method in class root.Converter
 
convert(TProfile, String) - Static method in class root.Converter
 
Converter - Class in cern.hep.aida.ref
Histogram conversions, for example to String and XML format; This class requires the Colt distribution, whereas the rest of the package is entirelly stand-alone.
Converter() - Constructor for class cern.hep.aida.ref.Converter
Creates a new histogram converter.
Converter - Class in root
Adapts Root histograms and Trees to their corresponding AIDA interfaces
Converter() - Constructor for class root.Converter
 
convertFileCollectionToFileArray(Collection<File>) - Static method in class org.apache.commons.io.FileUtils
Converts a Collection containing java.io.File instanced into array representation.
convertFromUnit(double) - Method in class org.jlab.groot.math.Axis
Scales the range by a specified unit
convertToChar(String) - Static method in class jplot.Translate
Convert a reference to a unicode character.
convertToComplex(double[]) - Static method in class org.apache.commons.math3.complex.ComplexUtils
Convert an array of primitive doubles to an array of Complex objects.
convertToLong(int[]) - Static method in class org.apache.commons.math3.random.RandomGeneratorFactory
Converts seed from one representation to another.
convertToRPN(String, Map<String, Function>, Map<String, Operator>, Set<String>) - Static method in class jhplot.math.exp4j.shuntingyard.ShuntingYard
Convert a Set of tokens from infix to reverse polish notation
convertToString(Character) - Static method in class jplot.Translate
Convert a character to a character entity reference.
convertToString(int) - Static method in class jplot.Translate
Convert a character to a numeric character reference.
convertUnicode(String) - Static method in class org.jlab.groot.ui.LatexTextTools
 
ConvexHull<S extends Space,P extends Point<S>> - Interface in org.apache.commons.math3.geometry.hull
This class represents a convex hull.
ConvexHull2D - Class in org.apache.commons.math3.geometry.euclidean.twod.hull
This class represents a convex hull in an two-dimensional euclidean space.
ConvexHull2D(Vector2D[], double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.hull.ConvexHull2D
Simple constructor.
ConvexHullGenerator<S extends Space,P extends Point<S>> - Interface in org.apache.commons.math3.geometry.hull
Interface for convex hull generators.
ConvexHullGenerator2D - Interface in org.apache.commons.math3.geometry.euclidean.twod.hull
Interface for convex hull generators in the two-dimensional euclidean space.
convolve(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the convolution between two sequences.
coordToIndex(double) - Method in class cern.hep.aida.ref.FixedAxis
 
coordToIndex(double) - Method in class cern.hep.aida.ref.VariableAxis
 
coordToIndex(double) - Method in interface colt.hep.aida.IAxis
Converts a coordinate on the axis to a bin number.
cop - Variable in class jplot3d.JSurface
 
copy() - Method in class cern.colt.bitvector.BitMatrix
Returns a shallow clone of the receiver; calls clone() and casts the result.
copy() - Method in class cern.colt.bitvector.BitVector
Returns a deep copy of the receiver; calls clone() and casts the result.
copy() - Method in class cern.colt.list.BooleanArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.ByteArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.CharArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.DoubleArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.FloatArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.IntArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.LongArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.ObjectArrayList
Returns a copy of the receiver; call clone() and casts the result.
copy() - Method in class cern.colt.list.ShortArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.AbstractDoubleIntMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.AbstractIntDoubleMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.AbstractIntIntMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.AbstractIntObjectMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.AbstractLongObjectMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a deep copy of the receiver.
copy(ParticleD) - Method in class hephysics.jet.ParticleD
Copy a particle.
copy() - Method in class hephysics.particle.HEParticle
Make an exact copy of this particle
copy() - Method in class hephysics.particle.LParticle
Make an exact copy of this particle
copy(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
New copy
copy() - Method in class hephysics.vec.HepLorentzVector
Make exact copy
copy(LorentzVector) - Method in class j4np.physics.LorentzVector
 
copy(Vector3) - Method in class j4np.physics.Vector3
 
copy() - Method in class Jama.Matrix
Make a deep copy of a matrix
copy() - Method in class jhplot.H1D
Make a copy of the data holder
copy(String) - Method in class jhplot.H1D
Get exact copy of the current histogram.
copy(String) - Method in class jhplot.H2D
Get exact copy of the current histogram.
copy() - Method in class jhplot.H2D
Make a copy of the data holder
copy() - Method in class jhplot.HProf1D
Make a copy of the data holder
copy(String) - Method in class jhplot.HProf1D
Get exact copy of the current histogram.
copy(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(long[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(float[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(double[]) - Static method in class jhplot.math.DoubleArray
Generate a copy of an array
copy(double[][]) - Static method in class jhplot.math.DoubleArray
Generate a copy of a matrix
copy(int[]) - Static method in class jhplot.math.IntegerArray
 
copy(int[][]) - Static method in class jhplot.math.IntegerArray
 
copy() - Method in class jhplot.math.kalman.jama.Matrix
Make a deep copy of a matrix
copy(ValueErr) - Static method in class jhplot.math.ValueErr
Copy value
copy() - Method in class jhplot.math.ValueErr
Copy a single ValueErr
copy(ValueErr[]) - Method in class jhplot.math.ValueErr
 
copy(ValueErr[][]) - Method in class jhplot.math.ValueErr
Deep copy a 2D array of ValueErr numbers
copy() - Method in class jhplot.P0D
Get a copy of the current holder
copy(String) - Method in class jhplot.P0D
Create an exact copy of the current P0D.
copy() - Method in class jhplot.P0I
Get a copy of the current holder
copy(String) - Method in class jhplot.P0I
Create an exact copy of the current P0I.
copy(String) - Method in class jhplot.P1D
create a copy of this container.
copy() - Method in class jhplot.P1D
Make a new data holder with the same title from the current one.
copy() - Method in class jhplot.P2D
Get a copy of the current holder
copy(String) - Method in class jhplot.P2D
create an exact of the current holder
copy(String) - Method in class jhplot.PND
Create an exact copy of the current P0D.
copy(String) - Method in class jhplot.PNI
Create an exact copy of the current P0D.
copy() - Method in class jhplot.stat.DataKeeper
Make a copy
copy(int[]) - Static method in class jminhep.utils.ArrayOps
#12 Make and return a copy of the array nums.
copy(GraphLabel) - Method in class jplot.GraphLabel
Constructor, builds the class with another graph label.
copy(LinePars) - Method in class jplot.LinePars
Copy operator, builds the class from specified values.
copy(byte[], OutputStream) - Static method in class org.apache.commons.io.CopyUtils
Deprecated.
Copy bytes from a byte[] to an OutputStream.
copy(byte[], Writer) - Static method in class org.apache.commons.io.CopyUtils
Deprecated.
copy(byte[], Writer, String) - Static method in class org.apache.commons.io.CopyUtils
Deprecated.
Copy and convert bytes from a byte[] to chars on a Writer, using the specified encoding.
copy(InputStream, OutputStream) - Static method in class org.apache.commons.io.CopyUtils
Deprecated.
Copy bytes from an InputStream to an OutputStream.
copy(Reader, Writer) - Static method in class org.apache.commons.io.CopyUtils
Deprecated.
Copy chars from a Reader to a Writer.
copy(InputStream, Writer) - Static method in class org.apache.commons.io.CopyUtils
Deprecated.
copy(InputStream, Writer, String) - Static method in class org.apache.commons.io.CopyUtils
Deprecated.
Copy and convert bytes from an InputStream to chars on a Writer, using the specified encoding.
copy(Reader, OutputStream) - Static method in class org.apache.commons.io.CopyUtils
copy(Reader, OutputStream, String) - Static method in class org.apache.commons.io.CopyUtils
Deprecated.
Serialize chars from a Reader to bytes on an OutputStream, and flush the OutputStream.
copy(String, OutputStream) - Static method in class org.apache.commons.io.CopyUtils
copy(String, OutputStream, String) - Static method in class org.apache.commons.io.CopyUtils
Deprecated.
Serialize chars from a String to bytes on an OutputStream, and flush the OutputStream.
copy(String, Writer) - Static method in class org.apache.commons.io.CopyUtils
Deprecated.
Copy chars from a String to a Writer.
copy(InputStream, OutputStream) - Static method in class org.apache.commons.io.IOUtils
Copies bytes from an InputStream to an OutputStream.
copy(InputStream, OutputStream, int) - Static method in class org.apache.commons.io.IOUtils
Copies bytes from an InputStream to an OutputStream using an internal buffer of the given size.
copy(InputStream, Writer) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
copy(InputStream, Writer, Charset) - Static method in class org.apache.commons.io.IOUtils
Copies bytes from an InputStream to chars on a Writer using the specified character encoding.
copy(InputStream, Writer, String) - Static method in class org.apache.commons.io.IOUtils
Copies bytes from an InputStream to chars on a Writer using the specified character encoding.
copy(Reader, Appendable) - Static method in class org.apache.commons.io.IOUtils
Copies chars from a Reader to a Appendable.
copy(Reader, Appendable, CharBuffer) - Static method in class org.apache.commons.io.IOUtils
Copies chars from a Reader to an Appendable.
copy(Reader, OutputStream) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
copy(Reader, OutputStream, Charset) - Static method in class org.apache.commons.io.IOUtils
Copies chars from a Reader to bytes on an OutputStream using the specified character encoding, and calling flush.
copy(Reader, OutputStream, String) - Static method in class org.apache.commons.io.IOUtils
Copies chars from a Reader to bytes on an OutputStream using the specified character encoding, and calling flush.
copy(Reader, Writer) - Static method in class org.apache.commons.io.IOUtils
Copies chars from a Reader to a Writer.
copy() - Method in class org.apache.commons.math3.analysis.interpolation.InterpolatingMicrosphere
Perform a copy.
copy() - Method in class org.apache.commons.math3.analysis.interpolation.InterpolatingMicrosphere2D
Perform a copy.
copy() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Make a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Make a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Returns a (deep) copy of this vector.
copy() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Make a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns a (deep) copy of this.
copy() - Method in interface org.apache.commons.math3.linear.FieldMatrix
Make a (deep) copy of this.
copy() - Method in interface org.apache.commons.math3.linear.FieldVector
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Returns a (deep) copy of this vector.
copy() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.RealVector
Returns a (deep) copy of this vector.
copy() - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Make a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.ml.neuralnet.Network
Performs a deep copy of this instance.
copy() - Method in class org.apache.commons.math3.ml.neuralnet.Neuron
Performs a deep copy of this instance.
copy() - Method in class org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D
Performs a deep copy of this instance.
copy() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Copy the instance.
copy() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Copy the instance.
copy() - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy() - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns a copy of this DescriptiveStatistics instance with the same internal state.
copy(DescriptiveStatistics, DescriptiveStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Returns a copy of the statistic with the same internal state.
copy(GeometricMean, GeometricMean) - Static method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Returns a copy of the statistic with the same internal state.
copy(Kurtosis, Kurtosis) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns a copy of the statistic with the same internal state.
copy(Mean, Mean) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Returns a copy of the statistic with the same internal state.
copy(SecondMoment, SecondMoment) - Static method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns a copy of the statistic with the same internal state.
copy(SemiVariance, SemiVariance) - Static method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Returns a copy of the statistic with the same internal state.
copy(Skewness, Skewness) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns a copy of the statistic with the same internal state.
copy(StandardDeviation, StandardDeviation) - Static method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns a copy of the statistic with the same internal state.
copy(Variance, Variance) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Returns a copy of the statistic with the same internal state.
copy(Max, Max) - Static method in class org.apache.commons.math3.stat.descriptive.rank.Max
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Returns a copy of the statistic with the same internal state.
copy(Min, Min) - Static method in class org.apache.commons.math3.stat.descriptive.rank.Min
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns a copy of the statistic with the same internal state.
copy(Percentile, Percentile) - Static method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Deprecated.
as of 3.4 this method does not work anymore, as it fails to copy internal states between instances configured with different estimation type, NaN handling strategies and kthSelector, it therefore always throw MathUnsupportedOperationException
copy() - Method in class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile
Returns a copy of the statistic with the same internal state.
copy() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns a copy of the statistic with the same internal state.
copy(Product, Product) - Static method in class org.apache.commons.math3.stat.descriptive.summary.Product
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Returns a copy of the statistic with the same internal state.
copy(Sum, Sum) - Static method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Returns a copy of the statistic with the same internal state.
copy(SumOfLogs, SumOfLogs) - Static method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Returns a copy of the statistic with the same internal state.
copy(SumOfSquares, SumOfSquares) - Static method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns a copy of this SummaryStatistics instance with the same internal state.
copy(SummaryStatistics, SummaryStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns a copy of this SynchronizedDescriptiveStatistics instance with the same internal state.
copy(SynchronizedDescriptiveStatistics, SynchronizedDescriptiveStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns a copy of this SynchronizedSummaryStatistics instance with the same internal state.
copy(SynchronizedSummaryStatistics, SynchronizedSummaryStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Copies source to dest.
copy() - Method in interface org.apache.commons.math3.stat.descriptive.UnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy(ResizableDoubleArray, ResizableDoubleArray) - Static method in class org.apache.commons.math3.util.ResizableDoubleArray
Copies source to dest, copying the underlying data, so dest is a new, independent copy of source.
copy() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns a copy of the ResizableDoubleArray.
copy() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns a copy of ourselves or null if there was an exception during cloning.
copy(Attributes) - Method in class org.jlab.groot.base.Attributes
makes a copy of an attributes.
copy(PadMargins) - Method in class org.jlab.groot.base.PadMargins
 
copy(DataVector) - Method in class org.jlab.groot.data.DataVector
 
copy(GraphErrors) - Method in class org.jlab.groot.data.GraphErrors
 
copy(Dimension1D) - Method in class org.jlab.groot.math.Dimension1D
 
copy(Dimension2D) - Method in class org.jlab.groot.math.Dimension2D
 
copy(Dimension3D) - Method in class org.jlab.groot.math.Dimension3D
 
copy(PaveText) - Method in class org.jlab.groot.ui.PaveText
 
copy() - Method in class org.lsmp.djep.vectorJep.values.Matrix
 
copy() - Method in interface org.lsmp.djep.vectorJep.values.MatrixValueI
returns a copy of this value.
copy() - Method in class org.lsmp.djep.vectorJep.values.MVector
 
copy() - Method in class org.lsmp.djep.vectorJep.values.Scaler
 
copy() - Method in class org.lsmp.djep.vectorJep.values.Tensor
 
COPY_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Copy action command.
copyArea(int, int, int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Not yet implemented.
copyAttributes(DatasetAttributes, IDataSet) - Static method in class org.jlab.groot.data.DataSetSerializer
 
copyChildren(Node, Node[]) - Method in class org.lsmp.djep.xjep.NodeFactory
Sets the children of node to be those specified in array.
copyChildrenIfNeeded(Node, Node[]) - Static method in class org.lsmp.djep.xjep.TreeUtils
Sets the children of a node if they have changed for it current children.
copyConstants(SymbolTable) - Method in class org.lsmp.djep.xjep.XSymbolTable
Copy the values of all constants into this from the supplied symbol table.
copyDirectory(Path, Path, CopyOption...) - Static method in class org.apache.commons.io.file.PathUtils
Copies a directory to another directory.
copyDirectory(File, File) - Static method in class org.apache.commons.io.FileUtils
Copies a whole directory to a new location preserving the file dates.
copyDirectory(File, File, boolean) - Static method in class org.apache.commons.io.FileUtils
Copies a whole directory to a new location.
copyDirectory(File, File, FileFilter) - Static method in class org.apache.commons.io.FileUtils
Copies a filtered directory to a new location preserving the file dates.
copyDirectory(File, File, FileFilter, boolean) - Static method in class org.apache.commons.io.FileUtils
Copies a filtered directory to a new location.
copyDirectory(File, File, FileFilter, boolean, CopyOption...) - Static method in class org.apache.commons.io.FileUtils
Copies a filtered directory to a new location.
copyDirectoryToDirectory(File, File) - Static method in class org.apache.commons.io.FileUtils
Copies a directory to within another directory preserving the file dates.
CopyDirectoryVisitor - Class in org.apache.commons.io.file
Copies a source directory to a target directory.
CopyDirectoryVisitor(Counters.PathCounters, Path, Path, CopyOption...) - Constructor for class org.apache.commons.io.file.CopyDirectoryVisitor
Constructs a new visitor that deletes files except for the files and directories explicitly given.
copyFile(File, File) - Static method in class jhepsim.Util
Copies the contents of any disk file to a specified output file.
copyFile(File, File) - Static method in class jhplot.math.io.DataFile
 
copyFile(File, File) - Static method in class jhplot.utils.Util
Copies the contents of any disk file to a specified output file.
copyFile(File, File) - Static method in class jminhep.utils.Util
Copies the contents of any disk file to a specified output file.
copyFile(URL, Path, CopyOption...) - Static method in class org.apache.commons.io.file.PathUtils
Copies a URL to a directory.
copyFile(File, File) - Static method in class org.apache.commons.io.FileUtils
Copies a file to a new location preserving the file date.
copyFile(File, File, boolean) - Static method in class org.apache.commons.io.FileUtils
Copies a file to a new location.
copyFile(File, File, boolean, CopyOption...) - Static method in class org.apache.commons.io.FileUtils
Copies a file to a new location.
copyFile(File, OutputStream) - Static method in class org.apache.commons.io.FileUtils
Copy bytes from a File to an OutputStream.
copyFileToDirectory(Path, Path, CopyOption...) - Static method in class org.apache.commons.io.file.PathUtils
Copies a file to a directory.
copyFileToDirectory(URL, Path, CopyOption...) - Static method in class org.apache.commons.io.file.PathUtils
Copies a URL to a directory.
copyFileToDirectory(File, File) - Static method in class org.apache.commons.io.FileUtils
Copies a file to a directory preserving the file date.
copyFileToDirectory(File, File, boolean) - Static method in class org.apache.commons.io.FileUtils
Copies a file to a directory optionally preserving the file date.
copyInputStreamToFile(InputStream, File) - Static method in class org.apache.commons.io.FileUtils
Copies bytes from an InputStream source to a file destination.
copyLarge(InputStream, OutputStream) - Static method in class org.apache.commons.io.IOUtils
Copies bytes from a large (over 2GB) InputStream to an OutputStream.
copyLarge(InputStream, OutputStream, byte[]) - Static method in class org.apache.commons.io.IOUtils
Copies bytes from a large (over 2GB) InputStream to an OutputStream.
copyLarge(InputStream, OutputStream, long, long) - Static method in class org.apache.commons.io.IOUtils
Copies some or all bytes from a large (over 2GB) InputStream to an OutputStream, optionally skipping input bytes.
copyLarge(InputStream, OutputStream, long, long, byte[]) - Static method in class org.apache.commons.io.IOUtils
Copies some or all bytes from a large (over 2GB) InputStream to an OutputStream, optionally skipping input bytes.
copyLarge(Reader, Writer) - Static method in class org.apache.commons.io.IOUtils
Copies chars from a large (over 2GB) Reader to a Writer.
copyLarge(Reader, Writer, char[]) - Static method in class org.apache.commons.io.IOUtils
Copies chars from a large (over 2GB) Reader to a Writer.
copyLarge(Reader, Writer, long, long) - Static method in class org.apache.commons.io.IOUtils
Copies some or all chars from a large (over 2GB) InputStream to an OutputStream, optionally skipping input chars.
copyLarge(Reader, Writer, long, long, char[]) - Static method in class org.apache.commons.io.IOUtils
Copies some or all chars from a large (over 2GB) InputStream to an OutputStream, optionally skipping input chars.
copyLinePars(LinePars) - Method in class jhplot.DrawOptions
Copy drawing options.
copyOf(int[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates a copy of the source array.
copyOf(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates a copy of the source array.
copyOf(int[], int) - Static method in class org.apache.commons.math3.util.MathArrays
Creates a copy of the source array.
copyOf(double[], int) - Static method in class org.apache.commons.math3.util.MathArrays
Creates a copy of the source array.
copyOfRange(double[], int, int) - Static method in class org.apache.commons.math3.util.MathArrays
Creates a copy of the source array.
copySelf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Copy the instance.
copySelf() - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Copy the instance.
copySelf() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Copy the instance.
copySelf() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.spherical.oned.LimitAngle
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Copy the instance.
copySign(float, float) - Static method in class net.jafama.FastMath
A sign of NaN can be interpreted as positive or negative.
copySign(double, double) - Static method in class net.jafama.FastMath
A sign of NaN can be interpreted as positive or negative.
copySign(float, float) - Static method in class net.jafama.StrictFastMath
A sign of NaN is interpreted as positive.
copySign(double, double) - Static method in class net.jafama.StrictFastMath
A sign of NaN is interpreted as positive.
copySign(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Returns the instance with the sign of the argument.
copySign(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Returns the instance with the sign of the argument.
copySign(SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Returns the instance with the sign of the argument.
copySign(double) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Returns the instance with the sign of the argument.
copysign(Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.Dfp
Creates an instance that is the same as x except that it has the sign of y.
copySign(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Returns the instance with the sign of the argument.
copySign(double) - Method in class org.apache.commons.math3.dfp.Dfp
Returns the instance with the sign of the argument.
copySign(T) - Method in interface org.apache.commons.math3.RealFieldElement
Returns the instance with the sign of the argument.
copySign(double) - Method in interface org.apache.commons.math3.RealFieldElement
Returns the instance with the sign of the argument.
copySign(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Returns the instance with the sign of the argument.
copySign(double) - Method in class org.apache.commons.math3.util.Decimal64
Returns the instance with the sign of the argument.
copySign(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Returns the first argument with the sign of the second argument.
copySign(float, float) - Static method in class org.apache.commons.math3.util.FastMath
Returns the first argument with the sign of the second argument.
copySign(byte, byte) - Static method in class org.apache.commons.math3.util.MathUtils
Returns the first argument with the sign of the second argument.
copySign(short, short) - Static method in class org.apache.commons.math3.util.MathUtils
Returns the first argument with the sign of the second argument.
copySign(int, int) - Static method in class org.apache.commons.math3.util.MathUtils
Returns the first argument with the sign of the second argument.
copySign(long, long) - Static method in class org.apache.commons.math3.util.MathUtils
Returns the first argument with the sign of the second argument.
copyState(RTextLine) - Method in class graph.RTextLine
Copy the state of the parsed Textline into the existing object.
copyState() - Method in class graph.TextLine
Create a New Textline object copying the state of the existing object into the new one.
copyState(TextLine) - Method in class graph.TextLine
Copy the state of the parsed Textline into the existing object.
copySubMatrix(int, int, int, int, T[][]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Copy a submatrix.
copySubMatrix(int[], int[], T[][]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Copy a submatrix.
copySubMatrix(int, int, int, int, double[][]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Copy a submatrix.
copySubMatrix(int[], int[], double[][]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Copy a submatrix.
copySubMatrix(int, int, int, int, T[][]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Copy a submatrix.
copySubMatrix(int[], int[], T[][]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Copy a submatrix.
copySubMatrix(int, int, int, int, double[][]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Copy a submatrix.
copySubMatrix(int[], int[], double[][]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Copy a submatrix.
copyToClipboard() - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
copyToDirectory(File, File) - Static method in class org.apache.commons.io.FileUtils
Copies a file or directory to within another directory preserving the file dates.
copyToDirectory(Iterable<File>, File) - Static method in class org.apache.commons.io.FileUtils
Copies a files to a directory preserving each file's date.
copyToFile(InputStream, File) - Static method in class org.apache.commons.io.FileUtils
Copies bytes from an InputStream source to a file destination.
copyToVecMat(MatrixValueI) - Method in class org.lsmp.djep.mrpe.MRpRes
Copy the value into res.
copyURLToFile(URL, File) - Static method in class jhplot.utils.Util
Generate a file from URL location.
copyURLToFile(URL, File) - Static method in class org.apache.commons.io.FileUtils
Copies bytes from the URL source to a file destination.
copyURLToFile(URL, File, int, int) - Static method in class org.apache.commons.io.FileUtils
Copies bytes from the URL source to a file destination.
CopyUtils - Class in org.apache.commons.io
Deprecated.
Use IOUtils. Will be removed in 2.0. Methods renamed to IOUtils.write() or IOUtils.copy(). Null handling behavior changed in IOUtils (null data does not throw NullPointerException).
CopyUtils() - Constructor for class org.apache.commons.io.CopyUtils
Deprecated.
Instances should NOT be constructed in standard programming.
copyValues(Attributes) - Method in class org.jlab.groot.base.Attributes
from given attributes copies values of entries that exist in this class
corejava - package corejava
C-like number formatting that follows printf conventions.
Correct(Matrix) - Method in class jhplot.math.kalman.JKalman
Adjusts model state.
correct(double[]) - Method in class org.apache.commons.math3.filter.KalmanFilter
Correct the current state estimate with an actual measurement.
correct(RealVector) - Method in class org.apache.commons.math3.filter.KalmanFilter
Correct the current state estimate with an actual measurement.
correl(double[], double[]) - Static method in class jhplot.stat.StatUtils
Compute the correlation of a vector with another vector b.
CorrelatedRandomVectorGenerator - Class in org.apache.commons.math3.random
A RandomVectorGenerator that generates vectors with with correlated components.
CorrelatedRandomVectorGenerator(double[], RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Builds a correlated random vector generator from its mean vector and covariance matrix.
CorrelatedRandomVectorGenerator(RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Builds a null mean random correlated vector generator from its covariance matrix.
correlation(DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Modifies the given covariance matrix to be a correlation matrix (in-place).
correlation(DynamicBin1D) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the correlation of two bins, which is corr(x,y) = covariance(x,y) / (stdDev(x)*stdDev(y)) (Pearson's correlation coefficient).
correlation(DoubleArrayList, double, DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the correlation of two data sequences.
correlation(double[], double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the (linear) correlation between two arrays.
correlation(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the (linear) correlation between two arrays.
correlation(double[], double[]) - Static method in class jhplot.math.StatisticSample
Correlation coefficient, covariance(v1, v2) / Math.sqrt(variance(v1) * variance(v2)
correlation(double[][], double[][]) - Static method in class jhplot.math.StatisticSample
Correlation coefficient, covariance(v1, v2) / Math.sqrt(variance(v1) * variance(v2)
correlation(double[][]) - Static method in class jhplot.math.StatisticSample
Correlation
correlation(P0D) - Method in class jhplot.P0D
Returns the correlation coefficient.
correlation(P0I) - Method in class jhplot.P0I
Returns the correlation coefficient.
correlation(double[], double[]) - Static method in class jhplot.stat.Statistics
Correlation coefficient, covariance(v1, v2) / Math.sqrt(variance(v1) * variance(v2)
correlation(double[][], double[][]) - Static method in class jhplot.stat.Statistics
Correlation coefficient, covariance(v1, v2) / Math.sqrt(variance(v1) * variance(v2)
correlation(double[][]) - Static method in class jhplot.stat.Statistics
Correlation
correlation(double[], double[]) - Method in class org.apache.commons.math3.stat.correlation.KendallsCorrelation
Computes the Kendall's Tau rank correlation coefficient between the two arrays.
correlation(double[], double[]) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Computes the Pearson's product-moment correlation coefficient between two arrays.
correlation(double[], double[]) - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Computes the Spearman's rank correlation coefficient between the two arrays.
cos - Static variable in class cern.jet.math.Functions
Function that returns Math.cos(a).
cos() - Method in class jhplot.math.Complex
Cosine of this Complex number (doesn't change this Complex number).
cos(ValueErr) - Method in class jhplot.math.ValueErr
Cosine of a value wth error
COS - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
cos(double) - Static method in class net.jafama.FastMath
 
cos(double) - Static method in class net.jafama.StrictFastMath
 
cos() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Cosine operation.
cos(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute cosine of a derivative structure.
cos() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Cosine operation.
Cos - Class in org.apache.commons.math3.analysis.function
Cosine function.
Cos() - Constructor for class org.apache.commons.math3.analysis.function.Cos
 
cos() - Method in class org.apache.commons.math3.complex.Complex
Compute the cosine of this complex number.
cos() - Method in class org.apache.commons.math3.dfp.Dfp
Cosine operation.
cos(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the cosine of the argument.
cos() - Method in interface org.apache.commons.math3.RealFieldElement
Cosine operation.
cos() - Method in class org.apache.commons.math3.util.Decimal64
Cosine operation.
cos(double) - Static method in class org.apache.commons.math3.util.FastMath
Cosine function.
cos(Object) - Method in class org.nfunk.jep.function.Cosine
 
cos() - Method in class org.nfunk.jep.type.Complex
Returns the cosine of this complex number.
cosAngle(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the cosine of the angle between two vectors.
COSEC - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
COSECH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
cosh(double) - Static method in class graph.SpecialFunction
 
cosh() - Method in class jhplot.math.Complex
Hyperbolic cosine of this Complex number (doesn't change this Complex number).
cosh(double) - Static method in class jhplot.math.num.special.Trigonometric
Returns the hyperbolic cosine of x.
cosh(ValueErr) - Method in class jhplot.math.ValueErr
Hyperbolic cosine
COSH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
cosh(double) - Static method in class net.jafama.FastMath
Some properties of cosh(x) = (exp(x)+exp(-x))/2: 1) defined on ]-Infinity,+Infinity[ 2) result in [1,+Infinity[ 3) cosh(0) = 1 4) cosh(x) = cosh(-x) 5) lim(cosh(x),x->+Infinity) = +Infinity (y increasing exponentially faster than x) 6) reaches +Infinity (double overflow) for x >= 710.475860073944, i.e.
cosh(double) - Static method in class net.jafama.StrictFastMath
Some properties of cosh(x) = (exp(x)+exp(-x))/2: 1) defined on ]-Infinity,+Infinity[ 2) result in [1,+Infinity[ 3) cosh(0) = 1 4) cosh(x) = cosh(-x) 5) lim(cosh(x),x->+Infinity) = +Infinity (y increasing exponentially faster than x) 6) reaches +Infinity (double overflow) for x >= 710.475860073944, i.e.
cosh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Hyperbolic cosine operation.
cosh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute hyperbolic cosine of a derivative structure.
cosh() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Hyperbolic cosine operation.
Cosh - Class in org.apache.commons.math3.analysis.function
Hyperbolic cosine function.
Cosh() - Constructor for class org.apache.commons.math3.analysis.function.Cosh
 
cosh() - Method in class org.apache.commons.math3.complex.Complex
Compute the hyperbolic cosine of this complex number.
cosh() - Method in class org.apache.commons.math3.dfp.Dfp
Hyperbolic cosine operation.
cosh() - Method in interface org.apache.commons.math3.RealFieldElement
Hyperbolic cosine operation.
cosh() - Method in class org.apache.commons.math3.util.Decimal64
Hyperbolic cosine operation.
cosh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the hyperbolic cosine of a number.
cosh(Object) - Method in class org.nfunk.jep.function.CosineH
 
cosh() - Method in class org.nfunk.jep.type.Complex
 
coshm1(double) - Static method in class net.jafama.FastMath
Much more accurate than cosh(value)-1, for arguments (and results) close to zero.
coshm1(double) - Static method in class net.jafama.StrictFastMath
Much more accurate than cosh(value)-1, for arguments (and results) close to zero.
cosine(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Computes the cosine of the angle between this vector and the argument.
Cosine - Class in org.nfunk.jep.function
 
Cosine() - Constructor for class org.nfunk.jep.function.Cosine
 
CosineH - Class in org.nfunk.jep.function
 
CosineH() - Constructor for class org.nfunk.jep.function.CosineH
 
cosPhi() - Method in class hep.physics.vec.SpacePoint
cos(phi)
cosPhi() - Method in class hephysics.vec.SpacePoint
cos(phi)
cosQuick(double) - Static method in class net.jafama.FastMath
Quick cos, with accuracy of about 1.6e-3 (PI/) for |angle| < 6588397.0 (Integer.MAX_VALUE * (2*PI/)), and no accuracy at all for larger values.
cosQuick(double) - Static method in class net.jafama.StrictFastMath
Quick cos, with accuracy of about 1.6e-3 (PI/) for |angle| < 6588397.0 (Integer.MAX_VALUE * (2*PI/)), and no accuracy at all for larger values.
cosTheta() - Method in class hep.physics.vec.SpacePoint
cos(theta)
cosTheta(Hep3Vector) - Static method in class hep.physics.vec.VecOp
 
cosTheta() - Method in class hephysics.vec.Hep3Vector
cosTheta
cosTheta(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Cosine Theta
cosTheta() - Method in class hephysics.vec.HepLorentzVector
cosTheta
cosTheta() - Method in class hephysics.vec.SpacePoint
cos(theta)
cosTheta(Hep3Vector) - Static method in class hephysics.vec.VecOp
 
COT - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
COTH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
coulomb - Static variable in class cern.clhep.Units
 
countDirectory(Path) - Static method in class org.apache.commons.io.file.PathUtils
Counts aspects of a directory including sub-directories.
Counters - Class in org.apache.commons.io.file
Provides counters for files, directories, and sizes, as a visit proceeds.
Counters() - Constructor for class org.apache.commons.io.file.Counters
 
Counters.Counter - Interface in org.apache.commons.io.file
Counts using a number.
Counters.PathCounters - Interface in org.apache.commons.io.file
Counts files, directories, and sizes, as a visit proceeds.
countEvaluations(LeastSquaresProblem, Incrementor) - Static method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresFactory
Count the evaluations of a particular problem.
countHeaders(PrintStream, List, boolean, boolean, boolean) - Static method in class hep.lcio.util.HeaderCount
Count number of events and runs.
CountingInputStream - Class in org.apache.commons.io.input
A decorating input stream that counts the number of bytes that have passed through the stream so far.
CountingInputStream(InputStream) - Constructor for class org.apache.commons.io.input.CountingInputStream
Constructs a new CountingInputStream.
CountingOutputStream - Class in org.apache.commons.io.output
A decorating output stream that counts the number of bytes that have passed through the stream so far.
CountingOutputStream(OutputStream) - Constructor for class org.apache.commons.io.output.CountingOutputStream
Constructs a new CountingOutputStream.
CountingPathVisitor - Class in org.apache.commons.io.file
Counts files, directories, and sizes, as a visit proceeds.
CountingPathVisitor(Counters.PathCounters) - Constructor for class org.apache.commons.io.file.CountingPathVisitor
Constructs a new instance.
countObservers() - Method in class org.nfunk.jep.SymbolTable
 
countSortFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Sorts the specified range of the receiver into ascending numerical order (false < true).
countSortFromTo(int, int) - Method in class cern.colt.list.ByteArrayList
Sorts the specified range of the receiver into ascending numerical order.
covariance(DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Constructs and returns the covariance matrix of the given matrix.
covariance(DynamicBin1D) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the covariance of two bins, which is cov(x,y) = (1/size()) * Sum((x[i]-mean(x)) * (y[i]-mean(y))).
covariance(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the covariance of two data sequences, which is cov(x,y) = (1/(size()-1)) * Sum((x[i]-mean(x)) * (y[i]-mean(y))).
covariance(double[], double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the covariance.
covariance(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the covariance.
covariance(double[], double[]) - Static method in class jhplot.math.StatisticSample
Covariance
covariance(double[][], double[][]) - Static method in class jhplot.math.StatisticSample
Covariance
covariance(double[][]) - Static method in class jhplot.math.StatisticSample
Covariance
covariance(P0D) - Method in class jhplot.P0D
Returns the covariance
covariance(P0I) - Method in class jhplot.P0I
Returns the covariance
covariance(double[], double[]) - Static method in class jhplot.stat.Statistics
Covariance
covariance(double[][], double[][]) - Static method in class jhplot.stat.Statistics
Covariance
covariance(double[][]) - Static method in class jhplot.stat.Statistics
Covariance
Covariance - Class in org.apache.commons.math3.stat.correlation
Computes covariances for pairs of arrays or columns of a matrix.
Covariance() - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
Create a Covariance with no data
Covariance(double[][], boolean) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
Create a Covariance matrix from a rectangular array whose columns represent covariates.
Covariance(double[][]) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
Create a Covariance matrix from a rectangular array whose columns represent covariates.
Covariance(RealMatrix, boolean) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
Create a covariance matrix from a matrix whose columns represent covariates.
Covariance(RealMatrix) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
Create a covariance matrix from a matrix whose columns represent covariates.
covariance(double[], double[], boolean) - Method in class org.apache.commons.math3.stat.correlation.Covariance
Computes the covariance between the two arrays.
covariance(double[], double[]) - Method in class org.apache.commons.math3.stat.correlation.Covariance
Computes the covariance between the two arrays, using the bias-corrected formula.
covariance() - Method in class org.freehep.math.minuit.MnApplication
 
CovarianceMatrixEVDCalculator - Interface in jhplot.math.pca.covmatrixevd
Calculates eigenvalue decomposition of the covariance matrix of the given data
covarianceToCorrelation(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Derives a correlation matrix from a covariance matrix.
CPUtime - Static variable in class jminhep.clcontrol.Global
 
create(String) - Method in class cern.colt.matrix.impl.FormerFactory
Constructs and returns a new format instance.
create(File, TailerListener, long, boolean, int) - Static method in class org.apache.commons.io.input.Tailer
Creates and starts a Tailer for the given file.
create(File, TailerListener, long, boolean, boolean, int) - Static method in class org.apache.commons.io.input.Tailer
Creates and starts a Tailer for the given file.
create(File, Charset, TailerListener, long, boolean, boolean, int) - Static method in class org.apache.commons.io.input.Tailer
Creates and starts a Tailer for the given file.
create(File, TailerListener, long, boolean) - Static method in class org.apache.commons.io.input.Tailer
Creates and starts a Tailer for the given file with default buffer size.
create(File, TailerListener, long, boolean, boolean) - Static method in class org.apache.commons.io.input.Tailer
Creates and starts a Tailer for the given file with default buffer size.
create(File, TailerListener, long) - Static method in class org.apache.commons.io.input.Tailer
Creates and starts a Tailer for the given file, starting at the beginning of the file
create(File, TailerListener) - Static method in class org.apache.commons.io.input.Tailer
Creates and starts a Tailer for the given file, starting at the beginning of the file with the default delay of 1.0s
create() - Static method in class org.apache.commons.math3.fitting.GaussianCurveFitter
Creates a default curve fitter.
create() - Static method in class org.apache.commons.math3.fitting.HarmonicCurveFitter
Creates a default curve fitter.
create(MultivariateJacobianFunction, RealVector, RealVector, RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int, boolean, ParameterValidator) - Static method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresFactory
Create a LeastSquaresProblem from the given elements.
create(MultivariateJacobianFunction, RealVector, RealVector, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresFactory
Create a LeastSquaresProblem from the given elements.
create(MultivariateJacobianFunction, RealVector, RealVector, RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresFactory
Create a LeastSquaresProblem from the given elements.
create(MultivariateVectorFunction, MultivariateMatrixFunction, double[], double[], RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresFactory
Create a LeastSquaresProblem from the given elements.
create(int) - Static method in class org.apache.commons.math3.fitting.PolynomialCurveFitter
Creates a default curve fitter.
create(ParametricUnivariateFunction, double[]) - Static method in class org.apache.commons.math3.fitting.SimpleCurveFitter
Creates a curve fitter.
create(RealLinearOperator) - Static method in class org.apache.commons.math3.linear.JacobiPreconditioner
Creates a new instance of this class.
create() - Static method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Factory method that creates a default instance.
create(K, V) - Static method in class org.apache.commons.math3.util.Pair
Convenience factory method that calls the constructor.
create() - Method in class org.jfree.chart.fx.FXGraphics2D
Creates a new graphics object that is a copy of this graphics object.
create(String, int, DataVector, DataVector) - Static method in class org.jlab.groot.data.H1F
 
create(String, int, DataVector) - Static method in class org.jlab.groot.data.H1F
 
create(String, int, int, DataVector, DataVector) - Static method in class org.jlab.groot.data.H2F
creates 2D histogram from given DataVectors, min and max are determined by data vectors.
createAdaptor(RandomGenerator) - Static method in class org.apache.commons.math3.random.RandomAdaptor
Factory method to create a Random using the supplied RandomGenerator.
createAreaChart(String, String, String, CategoryDataset) - Static method in class org.jfree.chart.ChartFactory
Creates an area chart with default settings.
createAreaChart(String, String, String, CategoryDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates an area chart with default settings.
createArrow(int[], int[], double, double, double) - Static method in class jplot.Geometry
Create the geometry of an arrow.
createArrow(int, int, int, int, double, double, double) - Static method in class jplot.Geometry
Create geometry for an arrow along the specified line and with tip at x1,y1.
createAttributedLabel(String) - Method in class org.jfree.chart.axis.Axis
Creates and returns an AttributedString with the specified text and the labelFont and labelPaint applied as attributes.
createAttributes() - Static method in class org.jlab.groot.base.TStyle
 
createAxis(int) - Method in class graph.Graph2D
Create and attach an Axis to the graph.
createBarChart(String, String, String, CategoryDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a bar chart with a vertical orientation.
createBarChart(String, String, String, CategoryDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a bar chart.
createBarChart3D(String, String, String, CategoryDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a bar chart with a 3D effect.
createBarChart3D(String, String, String, CategoryDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a bar chart with a 3D effect.
createBlocksLayout(Field<T>, int, int) - Static method in class org.apache.commons.math3.linear.BlockFieldMatrix
Create a data array in blocks layout.
createBlocksLayout(int, int) - Static method in class org.apache.commons.math3.linear.BlockRealMatrix
Create a data array in blocks layout.
createBoxAndWhiskerChart(String, String, String, BoxAndWhiskerCategoryDataset, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates and returns a default instance of a box and whisker chart based on data from a BoxAndWhiskerCategoryDataset.
createBoxAndWhiskerChart(String, String, String, BoxAndWhiskerXYDataset, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates and returns a default instance of a box and whisker chart.
createBubbleChart(String, String, String, XYZDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a bubble chart with default settings.
createBubbleChart(String, String, String, XYZDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a bubble chart with default settings.
createBufferedImage(int, int) - Method in class org.jfree.chart.JFreeChart
Creates and returns a buffered image into which the chart has been drawn.
createBufferedImage(int, int, ChartRenderingInfo) - Method in class org.jfree.chart.JFreeChart
Creates and returns a buffered image into which the chart has been drawn.
createBufferedImage(int, int, int, ChartRenderingInfo) - Method in class org.jfree.chart.JFreeChart
Creates and returns a buffered image into which the chart has been drawn.
createBufferedImage(int, int, double, double, ChartRenderingInfo) - Method in class org.jfree.chart.JFreeChart
Creates and returns a buffered image into which the chart has been drawn.
createCandlestickChart(String, String, String, OHLCDataset, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates and returns a default instance of a candlesticks chart.
createCategoryDataset(String, String, double[][]) - Static method in class org.jfree.data.general.DatasetUtilities
Creates a CategoryDataset that contains a copy of the data in an array (instances of Double are created to represent the data items).
createCategoryDataset(String, String, Number[][]) - Static method in class org.jfree.data.general.DatasetUtilities
Creates a CategoryDataset that contains a copy of the data in an array.
createCategoryDataset(Comparable[], Comparable[], double[][]) - Static method in class org.jfree.data.general.DatasetUtilities
Creates a CategoryDataset that contains a copy of the data in an array (instances of Double are created to represent the data items).
createCategoryDataset(Comparable, KeyedValues) - Static method in class org.jfree.data.general.DatasetUtilities
Creates a CategoryDataset by copying the data from the supplied KeyedValues instance.
createChartPrintJob() - Method in class org.jfree.chart.ChartPanel
Creates a print job for the chart.
createChebyshevPolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
Create a Chebyshev polynomial of the first kind.
createCheckBox(String, boolean) - Static method in class jplot.Utils
 
createCircle(int, int, int) - Static method in class jplot.Geometry
Create geometry for a circle.
createCircle(double, double, double) - Static method in class jplot.Geometry
Create geometry for a circle.
createColumnFieldMatrix(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Creates a column FieldMatrix using the data from the input array.
createColumnRealMatrix(double[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Creates a column RealMatrix using the data from the input array.
createComplexArray(double[][]) - Static method in class org.apache.commons.math3.transform.TransformUtils
Builds a new array of Complex from the specified two dimensional array of real and imaginary parts.
createConsolidatedPieDataset(PieDataset, Comparable, double) - Static method in class org.jfree.data.general.DatasetUtilities
Creates a new pie dataset based on the supplied dataset, but modified by aggregating all the low value items (those whose value is lower than the percentThreshold) into a single item with the key "Other".
createConsolidatedPieDataset(PieDataset, Comparable, double, int) - Static method in class org.jfree.data.general.DatasetUtilities
Creates a new pie dataset based on the supplied dataset, but modified by aggregating all the low value items (those whose value is lower than the percentThreshold) into a single item.
createConstant(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Create a constant compatible with instance order and number of parameters.
createConstant(double) - Static method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Factory method creating a constant.
createContinuousPalette(String, Dimension, float) - Static method in class net.java.dev.colorchooser.Palette
 
createContour() - Method in class jplot3d.JSurface
Creates contour plot of a single area division.
createContributingStatistics() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Creates and returns a SummaryStatistics whose data will be aggregated with those of this AggregateSummaryStatistics.
createCopy(int, int) - Method in class org.jfree.data.time.TimePeriodValues
Creates a new instance by copying a subset of the data in this collection.
createCopy(int, int) - Method in class org.jfree.data.time.TimeSeries
Creates a new timeseries by copying a subset of the data in this time series.
createCopy(RegularTimePeriod, RegularTimePeriod) - Method in class org.jfree.data.time.TimeSeries
Creates a new timeseries by copying a subset of the data in this time series.
createCopy(int, int) - Method in class org.jfree.data.xy.XYSeries
Creates a new series by copying a subset of the data in this time series.
createDarknessTheme() - Static method in class org.jfree.chart.StandardChartTheme
Creates and returns a theme called "Darkness".
createDebugH1F(int) - Static method in class org.jlab.groot.math.FunctionFactory
 
createDefaultMergeFiles(File[]) - Method in class hep.lcio.util.MergeCommandHandler
Create the default merge options, which is one event from the file per merged output event.
createDefaultPaintArray() - Static method in class org.jfree.chart.ChartColor
Convenience method to return an array of Paint objects that represent the pre-defined colors in the Color and ChartColor objects.
createDefaultSurfaceModel() - Method in class jplot3d.JSurfacePanel
 
createDemoPanel() - Static method in class org.jfree.chart.demo.PieChartDemo1
Creates a panel for the demo (used by SuperDemo.java).
createDemoPanel() - Static method in class org.jfree.chart.demo.TimeSeriesChartDemo1
Creates a panel for the demo (used by SuperDemo.java).
createDerivative(DVariable, String[], Node) - Method in class org.lsmp.djep.djep.DVariableFactory
Creates a partial derivative of a given variable.
createDerivative(DVariable, String[], Node) - Method in class org.lsmp.djep.matrixJep.MatrixVariableFactory
create a derivative
createDownRotationLabelPositions(double) - Static method in class org.jfree.chart.axis.CategoryLabelPositions
Creates a new instance where the category labels angled downwards by the specified amount.
createDropShadow(BufferedImage) - Method in class org.jfree.chart.util.DefaultShadowGenerator
Creates and returns an image containing the drop shadow for the specified source image.
createDropShadow(BufferedImage) - Method in interface org.jfree.chart.util.ShadowGenerator
Creates and returns an image containing the drop shadow for the specified source image.
createEditor(JFreeChart) - Method in interface org.jfree.chart.editor.ChartEditorFactory
Creates an editor for the given chart.
createEditor(JFreeChart) - Method in class org.jfree.chart.editor.DefaultChartEditorFactory
Returns a new instance of a ChartEditor.
createEllipse(int[], int[]) - Static method in class jplot.Geometry
Return the geometry of an ellipse based on its four top points.
createEllipse(int, int, int, int) - Static method in class jplot.Geometry
Create the geometry for an unrotated, unskewed ellipse.
createEllipse(double, double, double, double) - Static method in class jplot.Geometry
Create the geometry for an unrotated, unskewed ellipse.
createEvent(int, int) - Method in class hep.physics.event.generator.GeneratorFactory
Create a new event
createFieldDiagonalMatrix(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns a diagonal matrix with specified elements.
createFieldIdentityMatrix(Field<T>, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns dimension x dimension identity matrix.
createFieldMatrix(Field<T>, int, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns a FieldMatrix with specified dimensions.
createFieldMatrix(T[][]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns a FieldMatrix whose entries are the the values in the the input array.
createFieldVector(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Creates a FieldVector using the data from the input array.
createFiles(String[]) - Static method in class hep.lcio.util.FileUtil
Return an array of @see File objects from an array of paths.
createFromDouble(double, int) - Static method in class org.jlab.groot.ui.LatexText
 
createFunction(int) - Static method in class org.jlab.groot.math.FunctionFactory
 
createGanttChart(String, String, String, IntervalCategoryDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a Gantt chart using the supplied attributes plus default values where required.
createGanttChart(String, String, String, IntervalCategoryDataset, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a Gantt chart using the supplied attributes plus default values where required.
createGrid(String, double, double, double, double) - Method in class jplot.Contour
Create a grid from a function
createGrid(Vector<PlotPoint>, double, double, double, double) - Method in class jplot.Contour
Create a grid from a points
createGrid(double, double, double, double) - Method in class jplot.Contour
Create a grid from a H2D histogram
createGrid(String[], int[], double[], double[], int) - Static method in class org.jlab.groot.matrix.SparseGridIO
 
createGrid(String, String, String, int) - Static method in class org.jlab.groot.matrix.SparseGridIO
 
createH1F(int, int, int) - Static method in class org.jlab.groot.math.FunctionFactory
 
createHeatMapImage(HeatMapDataset, PaintScale) - Static method in class org.jfree.data.general.HeatMapUtilities
Creates an image that displays the values from the specified dataset.
createHermitePolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
Create a Hermite polynomial.
createHighLowChart(String, String, String, OHLCDataset, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates and returns a default instance of a high-low-open-close chart.
createHighLowChart(String, String, String, OHLCDataset, Timeline, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates and returns a default instance of a high-low-open-close chart with a special timeline.
createHistogram(String, String, String, IntervalXYDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a histogram chart.
createInstance(Date, TimeZone) - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Deprecated.
As of 1.0.13, use the method that specifies the locale also.
createInstance(Date, TimeZone, Locale) - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Creates a time period that includes the specified millisecond, assuming the given time zone.
createInstance(Class, Date, TimeZone) - Static method in class org.jfree.data.time.RegularTimePeriod
Creates a time period that includes the specified millisecond, assuming the given time zone.
createIntegerTickUnits() - Static method in class org.jfree.chart.axis.NumberAxis
Returns a collection of tick units for integer values.
createIntegerTickUnits(Locale) - Static method in class org.jfree.chart.axis.NumberAxis
Returns a collection of tick units for integer values.
createInterval(int, int, double) - Method in class org.apache.commons.math3.stat.interval.AgrestiCoullInterval
Create a confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, successes and confidence level.
createInterval(int, int, double) - Method in interface org.apache.commons.math3.stat.interval.BinomialConfidenceInterval
Create a confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, successes and confidence level.
createInterval(int, int, double) - Method in class org.apache.commons.math3.stat.interval.ClopperPearsonInterval
Create a confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, successes and confidence level.
createInterval(int, int, double) - Method in class org.apache.commons.math3.stat.interval.NormalApproximationInterval
Create a confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, successes and confidence level.
createInterval(int, int, double) - Method in class org.apache.commons.math3.stat.interval.WilsonScoreInterval
Create a confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, successes and confidence level.
createJacobiPolynomial(int, int, int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
Create a Jacobi polynomial.
createJFreeTheme() - Static method in class org.jfree.chart.StandardChartTheme
Creates and returns the default 'JFree' chart theme.
createLaguerrePolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
Create a Laguerre polynomial.
createLCReader() - Method in class hep.lcio.implementation.sio.SIOFactory
 
createLCReader(int) - Method in class hep.lcio.implementation.sio.SIOFactory
 
createLCReader() - Method in interface hep.lcio.io.ILCFactory
Creates an LCReader object for the current persistency type.
createLCReader(int) - Method in interface hep.lcio.io.ILCFactory
Creates an LCReader object for the current persistency type.
createLCWriter() - Method in class hep.lcio.implementation.sio.SIOFactory
 
createLCWriter() - Method in interface hep.lcio.io.ILCFactory
Creates an LCWriter object for the current persistency type.
createLegacyTheme() - Static method in class org.jfree.chart.StandardChartTheme
Creates and returns a ChartTheme that doesn't apply any changes to the JFreeChart defaults.
createLegendrePolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
Create a Legendre polynomial.
createLineChart(String, String, String, CategoryDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a line chart with default settings.
createLineChart(String, String, String, CategoryDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a line chart with default settings.
createLineChart3D(String, String, String, CategoryDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a line chart with default settings.
createLineChart3D(String, String, String, CategoryDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a line chart with default settings.
createLogTickUnits(Locale) - Static method in class org.jfree.chart.axis.LogAxis
Deprecated.
This method is no longer used internally and will be removed from a future version. If you need this method, copy the source code into your project.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Create a new FieldMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new FieldMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Create a new FieldMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Create a new FieldMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Create a new FieldMatrix of the same type as the instance with the supplied row and column dimensions.
createMergeFiles(List) - Method in class hep.lcio.util.MergeCommandHandler
Create a list of @see MergeFileParameters objects from the input file specified with -f.
createMovingAverage(TimeSeriesCollection, String, int, int) - Static method in class org.jfree.data.time.MovingAverage
Creates a new TimeSeriesCollection containing a moving average series for each series in the source collection.
createMovingAverage(TimeSeries, String, int, int) - Static method in class org.jfree.data.time.MovingAverage
Creates a new TimeSeries containing moving average values for the given series.
createMovingAverage(XYDataset, String, long, long) - Static method in class org.jfree.data.time.MovingAverage
Creates a new XYDataset containing the moving averages of each series in the source dataset.
createMovingAverage(XYDataset, String, double, double) - Static method in class org.jfree.data.time.MovingAverage
Creates a new XYDataset containing the moving averages of each series in the source dataset.
createMovingAverage(XYDataset, int, String, double, double) - Static method in class org.jfree.data.time.MovingAverage
Creates a new XYSeries containing the moving averages of one series in the source dataset.
createMultiplePieChart(String, CategoryDataset, TableOrder, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a chart that displays multiple pie plots.
createMultiplePieChart3D(String, CategoryDataset, TableOrder, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a chart that displays multiple pie plots.
createNeuron(double[]) - Method in class org.apache.commons.math3.ml.neuralnet.Network
Creates a neuron and assigns it a unique identifier.
createNewGraphErrors() - Method in class org.jlab.groot.studio.StudioUI
 
createNewHistogram() - Method in class org.jlab.groot.studio.StudioUI
 
createNewHistogram2D() - Method in class org.jlab.groot.studio.StudioUI
 
createNumber(String) - Method in class org.nfunk.jep.type.DoubleNumberFactory
Creates a Double object initialized to the value of the parameter.
createNumber(double) - Method in class org.nfunk.jep.type.DoubleNumberFactory
 
createNumber(Number) - Method in class org.nfunk.jep.type.DoubleNumberFactory
 
createNumber(boolean) - Method in class org.nfunk.jep.type.DoubleNumberFactory
 
createNumber(float) - Method in class org.nfunk.jep.type.DoubleNumberFactory
 
createNumber(int) - Method in class org.nfunk.jep.type.DoubleNumberFactory
 
createNumber(short) - Method in class org.nfunk.jep.type.DoubleNumberFactory
 
createNumber(Complex) - Method in class org.nfunk.jep.type.DoubleNumberFactory
 
createNumber(String) - Method in interface org.nfunk.jep.type.NumberFactory
Creates a number object and initializes its value.
createNumber(double) - Method in interface org.nfunk.jep.type.NumberFactory
Creates a number object with given double value.
createNumber(int) - Method in interface org.nfunk.jep.type.NumberFactory
Create a number object with given int value
createNumber(short) - Method in interface org.nfunk.jep.type.NumberFactory
Create a number object with given short value
createNumber(float) - Method in interface org.nfunk.jep.type.NumberFactory
Create a number object with given float value
createNumber(boolean) - Method in interface org.nfunk.jep.type.NumberFactory
Create a number object with given boolean value
createNumber(Number) - Method in interface org.nfunk.jep.type.NumberFactory
Creates a number object from a class implementing Number, May actually just return the class.
createNumber(Complex) - Method in interface org.nfunk.jep.type.NumberFactory
Create a number object with given Complex value
createNumberArray(double[]) - Static method in class org.jfree.data.DataUtilities
Constructs an array of Number objects from an array of double primitives.
createNumberArray(double[]) - Static method in class org.jfree.data.xy.DefaultHighLowDataset
Constructs an array of Number objects from an array of doubles.
createNumberArray2D(double[][]) - Static method in class org.jfree.data.DataUtilities
Constructs an array of arrays of Number objects from a corresponding structure containing double primitives.
createOperations(JFrame, Map<String, IDataSet>) - Static method in class org.jlab.groot.data.DatasetOperations
 
createPage1() - Method in class jhepsim.AboutDialog
 
createPage1() - Method in class jhplot.utils.AboutDialog
 
createPage1() - Method in class jhplot.utils.HelpDialog
 
createPage1() - Method in class jminhep.gui.AboutDialog
 
createPage2() - Method in class jhepsim.AboutDialog
 
createPage2() - Method in class jhplot.utils.AboutDialog
 
createPage2() - Method in class jminhep.gui.AboutDialog
 
createParticle(Hep3Vector, HepLorentzVector, ParticleType, int, double) - Method in class hep.physics.event.generator.GeneratorFactory
Create a new particle
createPieChart(String, PieDataset, boolean, boolean, Locale) - Static method in class org.jfree.chart.ChartFactory
Creates a pie chart with default settings.
createPieChart(String, PieDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a pie chart with default settings.
createPieChart(String, PieDataset, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a pie chart with default settings.
createPieChart(String, PieDataset, PieDataset, int, boolean, boolean, boolean, Locale, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a pie chart with default settings that compares 2 datasets.
createPieChart(String, PieDataset, PieDataset, int, boolean, boolean, boolean, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a pie chart with default settings that compares 2 datasets.
createPieChart3D(String, PieDataset, boolean, boolean, Locale) - Static method in class org.jfree.chart.ChartFactory
Creates a 3D pie chart using the specified dataset.
createPieChart3D(String, PieDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a 3D pie chart using the specified dataset.
createPieChart3D(String, PieDataset, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a 3D pie chart using the specified dataset.
createPieDatasetForColumn(CategoryDataset, Comparable) - Static method in class org.jfree.data.general.DatasetUtilities
Creates a pie dataset from a table dataset by taking all the values for a single column.
createPieDatasetForColumn(CategoryDataset, int) - Static method in class org.jfree.data.general.DatasetUtilities
Creates a pie dataset from a CategoryDataset by taking all the values for a single column.
createPieDatasetForRow(CategoryDataset, Comparable) - Static method in class org.jfree.data.general.DatasetUtilities
Creates a pie dataset from a table dataset by taking all the values for a single row.
createPieDatasetForRow(CategoryDataset, int) - Static method in class org.jfree.data.general.DatasetUtilities
Creates a pie dataset from a table dataset by taking all the values for a single row.
createPointMovingAverage(TimeSeries, String, int) - Static method in class org.jfree.data.time.MovingAverage
Creates a new TimeSeries containing moving average values for the given series, calculated by number of points (irrespective of the 'age' of those points).
createPolarChart(String, XYDataset, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a polar plot for the specified dataset (x-values interpreted as angles in degrees).
createPoly(Node) - Method in class org.lsmp.djep.sjep.PolynomialCreator
Converts an expression into the polynomial representation.
createPolygon(int[], int[], int, boolean) - Method in class org.jfree.chart.fx.FXGraphics2D
Creates a polygon from the specified x and y coordinate arrays.
createPredefinedPalette(String, Color[], String[]) - Static method in class net.java.dev.colorchooser.Palette
 
CreateRandomEvent - Class in hep.lcio.test
Simple program that creates an slcio file containing a random event.
CreateRandomEvent() - Constructor for class hep.lcio.test.CreateRandomEvent
 
createRandomGenerator(Random) - Static method in class org.apache.commons.math3.random.RandomGeneratorFactory
Creates a RandomDataGenerator instance that wraps a Random instance.
createRealDiagonalMatrix(double[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns a diagonal matrix with specified elements.
createRealIdentityMatrix(int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns dimension x dimension identity matrix.
createRealImaginaryArray(Complex[]) - Static method in class org.apache.commons.math3.transform.TransformUtils
Builds a new two dimensional array of double filled with the real and imaginary parts of the specified Complex numbers.
createRealMatrix(int, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns a RealMatrix with specified dimensions.
createRealMatrix(double[][]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns a RealMatrix whose entries are the the values in the the input array.
createRealVector(double[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Creates a RealVector using the data from the input array.
createRectangle(int, int, int, int) - Static method in class jplot.Geometry
Create geometry for a rectangle.
createRectangle(double, double, double, double) - Static method in class jplot.Geometry
Create geometry for a rectangle.
createRegion() - Method in class org.apache.commons.math3.geometry.euclidean.twod.hull.ConvexHull2D
Returns a new region that is enclosed by the convex hull.
createRegion() - Method in interface org.apache.commons.math3.geometry.hull.ConvexHull
Returns a new region that is enclosed by the convex hull.
createRingChart(String, PieDataset, boolean, boolean, Locale) - Static method in class org.jfree.chart.ChartFactory
Creates a ring chart with default settings.
createRingChart(String, PieDataset, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a ring chart with default settings.
createRowFieldMatrix(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Create a row FieldMatrix using the data from the input array.
createRowRealMatrix(double[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Create a row RealMatrix using the data from the input array.
createScatterPlot(String, String, String, XYDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a scatter plot with default settings.
createScatterPlot(String, String, String, XYDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a scatter plot with default settings.
createSector(int, int, int, int, double, double) - Static method in class jplot.Geometry
Create the geometry of a sector of an ellipse.
createSector(int, int, int, double, double) - Static method in class jplot.Geometry
Create the geometry of a sector of a circle.
createStackedAreaChart(String, String, String, CategoryDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a stacked area chart with default settings.
createStackedAreaChart(String, String, String, CategoryDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a stacked area chart with default settings.
createStackedBarChart(String, String, String, CategoryDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a stacked bar chart with default settings.
createStackedBarChart(String, String, String, CategoryDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a stacked bar chart with default settings.
createStackedBarChart3D(String, String, String, CategoryDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a stacked bar chart with a 3D effect and default settings.
createStackedBarChart3D(String, String, String, CategoryDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a stacked bar chart with a 3D effect and default settings.
createStackedXYAreaChart(String, String, String, TableXYDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a stacked XY area plot.
createStackedXYAreaChart(String, String, String, TableXYDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a stacked XY area plot.
createStandardDateTickUnits() - Static method in class org.jfree.chart.axis.DateAxis
Returns a collection of standard date tick units that uses the default time zone.
createStandardDateTickUnits(TimeZone, Locale) - Static method in class org.jfree.chart.axis.DateAxis
Returns a collection of standard date tick units.
createStandardDateTickUnits(TimeZone) - Static method in class org.jfree.chart.axis.DateAxis
Deprecated.
Since 1.0.11, use DateAxis.createStandardDateTickUnits( TimeZone, Locale) to explicitly set the locale as well as the time zone.
createStandardSeriesShapes() - Static method in class org.jfree.chart.plot.DefaultDrawingSupplier
Creates an array of standard shapes to display for the items in series on charts.
createStandardTickUnits() - Static method in class org.jfree.chart.axis.NumberAxis
Creates the standard tick units.
createStandardTickUnits(Locale) - Static method in class org.jfree.chart.axis.NumberAxis
Creates a collection of standard tick units.
createStar(int, int, int, int, int) - Static method in class jplot.Geometry
Create geometry of a star.
createStar(double, double, double, double, int) - Static method in class jplot.Geometry
Create geometry of a star.
createStore() - Method in class root.RootStoreFactory
 
createStore() - Method in class root.XrootdStoreFactory
 
createStrokedShape(Shape) - Method in class org.jlab.groot.base.BrushStroke
 
createStrokedShape(Shape) - Method in class org.jlab.groot.base.WobbleStroke
 
createTimeSeriesChart(String, String, String, XYDataset) - Static method in class org.jfree.chart.ChartFactory
Creates and returns a time series chart.
createTimeSeriesChart(String, String, String, XYDataset, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates and returns a time series chart.
createUpRotationLabelPositions(double) - Static method in class org.jfree.chart.axis.CategoryLabelPositions
Creates a new instance where the category labels angled upwards by the specified amount.
createValidateOptions() - Static method in class hep.lcio.util.ValidateCommandHandler
Creates commandline options for the validate command.
createVariable(int, double) - Static method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Factory method creating an independent variable.
createVariable(String, Object) - Method in class org.lsmp.djep.djep.DVariableFactory
 
createVariable(String) - Method in class org.lsmp.djep.djep.DVariableFactory
 
createVariable(String, Object) - Method in class org.lsmp.djep.matrixJep.MatrixVariableFactory
Create a variable with a given value.
createVariable(String) - Method in class org.lsmp.djep.matrixJep.MatrixVariableFactory
Create a variable with a given value.
createVariable(String, Object) - Method in class org.lsmp.djep.xjep.XVariableFactory
 
createVariable(String) - Method in class org.lsmp.djep.xjep.XVariableFactory
 
createVariable(String, Object) - Method in class org.nfunk.jep.VariableFactory
Create a variable with a name and value
createVariable(String) - Method in class org.nfunk.jep.VariableFactory
Create a variable with a name but not value
createVector(double[], double[]) - Static method in class jplot.Geometry
Construct the vector specified by two points.
createWaferMapChart(String, WaferMapDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a wafer map chart.
createWaterfallChart(String, String, String, CategoryDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a waterfall chart.
createWindPlot(String, String, String, WindDataset, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a wind plot with default settings.
createXAxis() - Method in class graph.G2Dint
Create Xaxis to be used for the drag scaling
createXYAreaChart(String, String, String, XYDataset) - Static method in class org.jfree.chart.ChartFactory
Creates an area chart using an XYDataset.
createXYAreaChart(String, String, String, XYDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates an area chart using an XYDataset.
createXYBarChart(String, String, boolean, String, IntervalXYDataset) - Static method in class org.jfree.chart.ChartFactory
Creates and returns a default instance of an XY bar chart.
createXYBarChart(String, String, boolean, String, IntervalXYDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates and returns a default instance of an XY bar chart.
createXYLineChart(String, String, String, XYDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a line chart (based on an XYDataset) with default settings.
createXYLineChart(String, String, String, XYDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a line chart (based on an XYDataset) with default settings.
createXYStepAreaChart(String, String, String, XYDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a filled stepped XY plot with default settings.
createXYStepAreaChart(String, String, String, XYDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a filled stepped XY plot with default settings.
createXYStepChart(String, String, String, XYDataset) - Static method in class org.jfree.chart.ChartFactory
Creates a stepped XY plot with default settings.
createXYStepChart(String, String, String, XYDataset, PlotOrientation, boolean, boolean, boolean) - Static method in class org.jfree.chart.ChartFactory
Creates a stepped XY plot with default settings.
createYAxis() - Method in class graph.G2Dint
Create Yaxis to be used for the drag scaling
critical - Variable in class jplot3d.JSurface
 
CRITICAL - Static variable in class org.jfree.chart.plot.ThermometerPlot
A constant for the 'critical' range.
cross(Hep3Vector, Hep3Vector) - Static method in class hep.physics.vec.VecOp
 
cross(Hep3Vector, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Cross product of 2 vectors
cross(Hep3Vector, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
cross(Vector3) - Method in class j4np.physics.Vector3
 
CROSS - Static variable in class org.lsmp.djep.rpe.RpEval
 
Cross - Class in org.nfunk.jep.function
 
Cross() - Constructor for class org.nfunk.jep.function.Cross
 
cross(Object, Object) - Method in class org.nfunk.jep.function.Cross
 
cross(Vector, Vector) - Method in class org.nfunk.jep.function.Cross
 
CROSS - Static variable in interface org.nfunk.jep.ParserConstants
 
CROSS_SECTION_ACCUMULATED_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
CROSS_SECTION_ACCUMULATED_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat
 
CROSS_SECTION_ACCUMULATED_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat
 
CROSS_SECTION_ACCUMULATED_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat
 
CROSS_SECTION_ERROR_ACCUMULATED_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
CROSS_SECTION_ERROR_ACCUMULATED_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat
 
CROSS_SECTION_ERROR_ACCUMULATED_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat
 
CROSS_SECTION_ERROR_ACCUMULATED_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat
 
CROSS_SECTION_ERROR_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
CROSS_SECTION_ERROR_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
CROSS_SECTION_ERROR_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
CROSS_SECTION_ERROR_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
CROSS_SECTION_ERROR_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
CROSS_SECTION_ERROR_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
CROSS_SECTION_ERROR_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
CROSS_SECTION_ERROR_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
CROSS_SECTION_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
CROSS_SECTION_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
CROSS_SECTION_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
CROSS_SECTION_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
CROSS_SECTION_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
CROSS_SECTION_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
CROSS_SECTION_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
CROSS_SECTION_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
crossCorrelation(double[], double[], int, int, int) - Static method in class jhplot.stat.StatUtils
Return a new array that is the cross-correlation of the two argument arrays, starting and ending at user-specified lag values.
crossCorrelationAt(double[], double[], int, int) - Static method in class jhplot.stat.StatUtils
Return the cross-correlation of two arrays at a certain lag value.
Crosshair - Class in org.jfree.chart.plot
A crosshair for display on a plot.
Crosshair() - Constructor for class org.jfree.chart.plot.Crosshair
Creates a new crosshair with value 0.0.
Crosshair(double) - Constructor for class org.jfree.chart.plot.Crosshair
Creates a new crosshair with the specified value.
Crosshair(double, Paint, Stroke) - Constructor for class org.jfree.chart.plot.Crosshair
Creates a new crosshair value with the specified value and line style.
CrosshairLabelGenerator - Interface in org.jfree.chart.labels
A label generator for crosshairs.
CrosshairOverlay - Class in org.jfree.chart.panel
An overlay for a ChartPanel that draws crosshairs on a plot.
CrosshairOverlay() - Constructor for class org.jfree.chart.panel.CrosshairOverlay
Default constructor.
CrosshairState - Class in org.jfree.chart.plot
Maintains state information about crosshairs on a plot between successive calls to the renderer's draw method.
CrosshairState() - Constructor for class org.jfree.chart.plot.CrosshairState
Creates a new CrosshairState instance that calculates distance in Java2D space.
CrosshairState(boolean) - Constructor for class org.jfree.chart.plot.CrosshairState
Creates a new CrosshairState instance.
crossover(Chromosome, Chromosome) - Method in interface org.apache.commons.math3.genetics.CrossoverPolicy
Perform a crossover operation on the given chromosomes.
crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math3.genetics.CycleCrossover
Perform a crossover operation on the given chromosomes.
crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math3.genetics.NPointCrossover
Performs a N-point crossover.
crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math3.genetics.OnePointCrossover
Performs one point crossover.
crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math3.genetics.OrderedCrossover
Perform a crossover operation on the given chromosomes.
crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math3.genetics.UniformCrossover
Perform a crossover operation on the given chromosomes.
CrossoverPolicy - Interface in org.apache.commons.math3.genetics
Policy used to create a pair of new chromosomes by performing a crossover operation on a source pair of chromosomes.
crosspower(Object, Object) - Method in class org.lsmp.djep.vectorJep.function.ExteriorProduct
 
crossProduct(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the cross-product of the instance with another vector.
crossProduct(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the cross-product of the instance with another vector.
crossProduct(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the cross-product of two vectors.
crossProduct(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the cross-product of two vectors.
crossProduct(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the cross-product of two vectors.
crossProduct(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the cross-product of the instance with another vector.
crossProduct(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the cross-product of two vectors.
crossProduct(Vector2D, Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the cross-product of the instance and the given points.
CSelector - Class in jminhep.gui
Cluster selector
CSelector() - Constructor for class jminhep.gui.CSelector
 
CSV - Class in org.jfree.data.io
A utility class for reading CategoryDataset data from a CSV file.
CSV() - Constructor for class org.jfree.data.io.CSV
Creates a new CSV reader where the field delimiter is a comma, and the text delimiter is a double-quote.
CSV(char, char) - Constructor for class org.jfree.data.io.CSV
Creates a new reader with the specified field and text delimiters.
cube(DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
2-d OLAP cube operator; Fills all cells of the given vectors into the given histogram.
cube(DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
3-d OLAP cube operator; Fills all cells of the given vectors into the given histogram.
CUBIC_CURVE - Static variable in class org.jfree.chart.plot.PieLabelLinkStyle
CUBIC_CURVE.
cummulativeHist(Func1D, int) - Method in class org.jlab.groot.math.RandomFunc
 
cumProduct(double[]) - Static method in class jhplot.math.DoubleArray
Calculates cumulative product of the values in an array.
cumProduct(double[][]) - Static method in class jhplot.math.DoubleArray
Calculates the cumulative product of each column in a matrix.
cumSum(double[]) - Static method in class jhplot.math.DoubleArray
Calculates the cumulative sum of an array.
cumSum(double[][]) - Static method in class jhplot.math.DoubleArray
Calculates the cumulative sum of each column in a matrix.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Beta
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.Binomial
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Cauchy
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.ChiSquared
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.ContinuousDistribution
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.DiscreteDistribution
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Exponential
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.FDistribution
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Gamma
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.Geometric
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.Hypergeometric
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Laplace
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Logistic
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.LogNormal
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.NegativeBinomial
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Normal
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.Poisson
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Rayleigh
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.TDistribution
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Uniform
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Weibull
The CDF for this distribution.
cumulativeProbability(int, int) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
cumulativeProbability(double, double) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Deprecated.
As of 3.1 (to be removed in 4.0). Please use AbstractRealDistribution.probability(double,double) instead.
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.BetaDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(int) - Method in class org.apache.commons.math3.distribution.BinomialDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.CauchyDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(int) - Method in class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.FDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.GammaDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(int) - Method in class org.apache.commons.math3.distribution.GeometricDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.GumbelDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(int) - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(int) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(int, int) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.LevyDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.LogisticDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double, double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.NakagamiDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double, double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.ParetoDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double, double) - Method in class org.apache.commons.math3.distribution.ParetoDistribution
cumulativeProbability(int) - Method in class org.apache.commons.math3.distribution.PascalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(int) - Method in class org.apache.commons.math3.distribution.PoissonDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double, double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
Deprecated.
As of 3.1. In 4.0, this method will be renamed probability(double x0, double x1).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.TDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.TriangularDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(int) - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.WeibullDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(int) - Method in class org.apache.commons.math3.distribution.ZipfDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
curie - Static variable in class cern.clhep.Units
 
currentFile - Static variable in class jhepsim.SetEnv
 
currentToken - Variable in exception jplot3dp.MathParser.ParseException
This is the last token that has been consumed successfully.
currentToken - Variable in exception org.nfunk.jep.ParseException
This is the last token that has been consumed successfully.
cursorDown(double) - Method in class org.jfree.chart.axis.AxisState
Moves the cursor down by the specified number of Java 2D units.
cursorLeft(double) - Method in class org.jfree.chart.axis.AxisState
Moves the cursor left by the specified number of Java 2D units.
cursorRight(double) - Method in class org.jfree.chart.axis.AxisState
Moves the cursor right by the specified number of Java 2D units.
cursorUp(double) - Method in class org.jfree.chart.axis.AxisState
Moves the cursor up by the specified number of Java 2D units.
curve - Variable in class jplot3d.JSurface
 
curveColor - Variable in class jplot3dp.ModelView.ModelFunction
 
CurveFitter<T extends ParametricUnivariateFunction> - Class in org.apache.commons.math3.fitting
Deprecated.
As of 3.3. Please use AbstractCurveFitter and WeightedObservedPoints instead.
CurveFitter(MultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.fitting.CurveFitter
Deprecated.
Simple constructor.
CurveFitter<T extends ParametricUnivariateFunction> - Class in org.apache.commons.math3.optimization.fitting
Deprecated.
As of 3.1 (to be removed in 4.0).
CurveFitter(DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.CurveFitter
CurveFitter(MultivariateDifferentiableVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated.
Simple constructor.
CustomCategoryURLGenerator - Class in org.jfree.chart.urls
A custom URL generator.
CustomCategoryURLGenerator() - Constructor for class org.jfree.chart.urls.CustomCategoryURLGenerator
Default constructor.
CustomFunction - Class in org.jlab.groot.demo
 
CustomFunction(String, double, double) - Constructor for class org.jlab.groot.demo.CustomFunction
 
CustomFunctionDemo - Class in org.jlab.groot.demo
 
CustomFunctionDemo() - Constructor for class org.jlab.groot.demo.CustomFunctionDemo
 
CustomPieURLGenerator - Class in org.jfree.chart.urls
A custom URL generator for pie charts.
CustomPieURLGenerator() - Constructor for class org.jfree.chart.urls.CustomPieURLGenerator
Creates a new CustomPieURLGenerator instance, initially empty.
CustomXYToolTipGenerator - Class in org.jfree.chart.labels
A tool tip generator that stores custom tooltips.
CustomXYToolTipGenerator() - Constructor for class org.jfree.chart.labels.CustomXYToolTipGenerator
Default constructor.
CustomXYURLGenerator - Class in org.jfree.chart.urls
A custom URL generator.
CustomXYURLGenerator() - Constructor for class org.jfree.chart.urls.CustomXYURLGenerator
Default constructor.
CutPanel - Class in org.jlab.groot.ui
 
CutPanel(Tree) - Constructor for class org.jlab.groot.ui.CutPanel
 
CutPanel(Tree, TreeCut) - Constructor for class org.jlab.groot.ui.CutPanel
 
cx - Variable in class Jampack.Zmat
The upper column index
CycleCrossover<T> - Class in org.apache.commons.math3.genetics
Cycle Crossover [CX] builds offspring from ordered chromosomes by identifying cycles between two parent chromosomes.
CycleCrossover() - Constructor for class org.apache.commons.math3.genetics.CycleCrossover
Creates a new CycleCrossover policy.
CycleCrossover(boolean) - Constructor for class org.apache.commons.math3.genetics.CycleCrossover
Creates a new CycleCrossover policy using the given randomStart behavior.
CyclicNumberAxis - Class in org.jfree.chart.axis
This class extends NumberAxis and handles cycling.
CyclicNumberAxis(double) - Constructor for class org.jfree.chart.axis.CyclicNumberAxis
Creates a CycleNumberAxis with the given period.
CyclicNumberAxis(double, double) - Constructor for class org.jfree.chart.axis.CyclicNumberAxis
Creates a CycleNumberAxis with the given period and offset.
CyclicNumberAxis(double, String) - Constructor for class org.jfree.chart.axis.CyclicNumberAxis
Creates a named CycleNumberAxis with the given period.
CyclicNumberAxis(double, double, String) - Constructor for class org.jfree.chart.axis.CyclicNumberAxis
Creates a named CycleNumberAxis with the given period and offset.
CyclicXYItemRenderer - Class in org.jfree.chart.renderer.xy
The Cyclic XY item renderer is specially designed to handle cyclic axis.
CyclicXYItemRenderer() - Constructor for class org.jfree.chart.renderer.xy.CyclicXYItemRenderer
Default constructor.
CyclicXYItemRenderer(int) - Constructor for class org.jfree.chart.renderer.xy.CyclicXYItemRenderer
Creates a new renderer.
CyclicXYItemRenderer(int, XYToolTipGenerator) - Constructor for class org.jfree.chart.renderer.xy.CyclicXYItemRenderer
Creates a new renderer.
CyclicXYItemRenderer(int, XYToolTipGenerator, XYURLGenerator) - Constructor for class org.jfree.chart.renderer.xy.CyclicXYItemRenderer
Creates a new renderer.

D

D - Variable in class Jampack.Eig
The diagonal matrix of eigenvalues
D - Variable in class Jampack.Zspec
The matrix of eigenvalues
d - Variable in class jhplot.math.pca.covmatrixevd.EVD
 
d - Variable in class jhplot.math.pca.covmatrixevd.EVDResult
 
DA_FIELD_NUMBER - Static variable in class promc.io.PEventFile.HEvent
 
DA_FIELD_NUMBER - Static variable in class promc.io.PEventFile.HEvent.Entry
 
DARK_BLUE - Static variable in class org.jfree.chart.ChartColor
A dark blue color.
DARK_CYAN - Static variable in class org.jfree.chart.ChartColor
A dark cyan color.
DARK_GREEN - Static variable in class org.jfree.chart.ChartColor
A dark green color.
DARK_MAGENTA - Static variable in class org.jfree.chart.ChartColor
A dark magenta color.
DARK_RED - Static variable in class org.jfree.chart.ChartColor
A dark red color.
DARK_YELLOW - Static variable in class org.jfree.chart.ChartColor
A dark yellow color.
darker(Paint) - Static method in class org.jfree.chart.util.PaintAlpha
Create a new (if possible, darker) Paint of the same Type.
dashLengths - Static variable in class jplot.GraphSettings
 
dashPattern1 - Static variable in class org.jlab.groot.base.GStyle
 
dashPattern2 - Static variable in class org.jlab.groot.base.GStyle
 
dashPattern3 - Static variable in class org.jlab.groot.base.GStyle
 
dasum(DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Returns the sum of absolute values; |x[0]| + |x[1]| + ...
dasum(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dasum(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
Data() - Static method in class jminhep.clcontrol.Display
Display only data points
Data - Static variable in class jminhep.clcontrol.Global
 
DATA - Static variable in class jminhep.gui.SetEnv
 
DATA - Static variable in class jplot.GraphLabel
 
data(int) - Method in class org.apache.commons.io.input.MessageDigestCalculatingInputStream.MessageDigestMaintainingObserver
 
data(byte[], int, int) - Method in class org.apache.commons.io.input.MessageDigestCalculatingInputStream.MessageDigestMaintainingObserver
 
data(int) - Method in class org.apache.commons.io.input.ObservableInputStream.Observer
Called to indicate, that InputStream.read() has been invoked on the ObservableInputStream, and will return a value.
data(byte[], int, int) - Method in class org.apache.commons.io.input.ObservableInputStream.Observer
Called to indicate that InputStream.read(byte[]), or InputStream.read(byte[], int, int) have been called, and are about to invoke data.
DATA - Static variable in class org.jfree.chart.util.XYCoordinateType
The (x, y) coordinates represent a point in the data space.
data_available - Variable in class jplot3d.JSurface
 
DATA_AVAILABLE_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
data_window - Variable in class graph.Axis
Before the Axis can be positioned correctly and drawn the data window needs to be calculated and passed to the Axis.
DataArray - Class in jplot
This is a special-purpose array for use with the graphical plotting program JPlot.
DataArray() - Constructor for class jplot.DataArray
Default constructor, initializes the class with nothing.
DataArray(int, int) - Constructor for class jplot.DataArray
Initializes the class with a file- and column index.
DataArray(int, int, int) - Constructor for class jplot.DataArray
Initializes the class with a file- and column index and allocates memory for the data points.
DataArray(int, int, int, LinePars) - Constructor for class jplot.DataArray
Initializes the class with a file- and column index and allocates memory for the data points.
DataArray(int, LinePars) - Constructor for class jplot.DataArray
Initializes the class with a file- and column index and allocates memory for the data points.
DataArray2D - Class in jplot
This is a special-purpose array for use with the graphical plotting program JHPlot.
DataArray2D() - Constructor for class jplot.DataArray2D
Default constructor, initializes the class with nothing.
DataArray2D(int) - Constructor for class jplot.DataArray2D
Default constructor, initializes the class with nothing.
DataArray3D - Class in jplot
This is a special-purpose array for use with the graphical plotting program JHPlot.
DataArray3D() - Constructor for class jplot.DataArray3D
Default constructor, initializes the class with nothing.
dataChanged() - Method in class jplot.DataChangeListener
 
dataChanged() - Method in class jplot.LinePars
Informs whether the data has been modified or not.
DataChangeListener - Class in jplot
This specific interface is used by classes which write data to a specific file.
DataChangeListener() - Constructor for class jplot.DataChangeListener
 
DataFile - Class in jhplot.math.io
BSD License
DataFile(File) - Constructor for class jhplot.math.io.DataFile
 
DataFile - Class in jplot
This class contains all the info specific for one data file.
DataFitter - Class in org.jlab.groot.fitter
 
DataFitter() - Constructor for class org.jlab.groot.fitter.DataFitter
 
DataGroup - Class in org.jlab.groot.group
 
DataGroup() - Constructor for class org.jlab.groot.group.DataGroup
 
DataGroup(String) - Constructor for class org.jlab.groot.group.DataGroup
 
DataGroup(String, int, int) - Constructor for class org.jlab.groot.group.DataGroup
 
DataGroup(int, int) - Constructor for class org.jlab.groot.group.DataGroup
 
DataGroupDescriptor - Class in org.jlab.groot.group
 
DataGroupDescriptor(String, int, int) - Constructor for class org.jlab.groot.group.DataGroupDescriptor
 
DataHolder - Class in jminhep.cluster
Represents an abstraction for a data holder in many dimensional space.
DataHolder() - Constructor for class jminhep.cluster.DataHolder
Creates a new empty instance of data holder
DataHolder(int) - Constructor for class jminhep.cluster.DataHolder
Creates a new empty instance of data point
DataHolder(String) - Constructor for class jminhep.cluster.DataHolder
Creates a new empty instance of data point
DataHolder(DataPoint, DataPoint, int, int) - Constructor for class jminhep.cluster.DataHolder
Creates data holder with random number Input:
DataKeeper - Class in jhplot.stat
A convenient class to keep data with error for an internal representation.
DataKeeper(int) - Constructor for class jhplot.stat.DataKeeper
 
DataKeeper(P1D) - Constructor for class jhplot.stat.DataKeeper
Initialize from a P1D
DataKeeper(H1D) - Constructor for class jhplot.stat.DataKeeper
Initialize from a histogram
DataNotAvailableException - Exception in hep.lcio.exceptions
An exception thrown when attempting to modify a read-only object
DataNotAvailableException() - Constructor for exception hep.lcio.exceptions.DataNotAvailableException
 
DataPackageResources - Class in org.jfree.data.resources
A resource bundle that stores all the items that might need localisation.
DataPackageResources() - Constructor for class org.jfree.data.resources.DataPackageResources
 
DataPackageResources_de - Class in org.jfree.data.resources
A resource bundle that stores all the items that might need localisation.
DataPackageResources_de() - Constructor for class org.jfree.data.resources.DataPackageResources_de
 
DataPackageResources_es - Class in org.jfree.data.resources
A resource bundle that stores all the items that might need localisation.
DataPackageResources_es() - Constructor for class org.jfree.data.resources.DataPackageResources_es
 
DataPackageResources_fr - Class in org.jfree.data.resources
A resource bundle that stores all the items that might need localisation.
DataPackageResources_fr() - Constructor for class org.jfree.data.resources.DataPackageResources_fr
 
DataPackageResources_pl - Class in org.jfree.data.resources
A resource bundle that stores all the items that might need localisation.
DataPackageResources_pl() - Constructor for class org.jfree.data.resources.DataPackageResources_pl
 
DataPackageResources_ru - Class in org.jfree.data.resources
A resource bundle that stores all the items that might need localisation.
DataPackageResources_ru() - Constructor for class org.jfree.data.resources.DataPackageResources_ru
 
DataParser - Class in org.jlab.groot.data
 
DataParser(String) - Constructor for class org.jlab.groot.data.DataParser
 
DataPoint - Class in jminhep.cluster
Represents an abstraction for a data point in many-dimensional space
DataPoint(double[], int) - Constructor for class jminhep.cluster.DataPoint
Creates a new instance of a data point
DataPoint(double[]) - Constructor for class jminhep.cluster.DataPoint
Creates a new instance of a data point
dataPoints() - Method in class graph.DataSet
Return the number of data points in the DataSet
DataReader - Class in jhplot.math.pca
Reads data matrix from a CSV file
DataReader() - Constructor for class jhplot.math.pca.DataReader
 
datarect - Variable in class graph.Graph2D
The rectangle that the data will be plotted within.
DataSet - Class in graph
This class is designed to hold the data to be plotted.
DataSet() - Constructor for class graph.DataSet
Instantiate an empty data set.
DataSet(int) - Constructor for class graph.DataSet
Instantiate an empty data set.
DataSet(double[], int) - Constructor for class graph.DataSet
Instantiate a DataSet with the parsed data.
DataSet(double[], int, int) - Constructor for class graph.DataSet
Instantiate a DataSet with the parsed data.
Dataset - Interface in org.jfree.data.general
The base interface for data sets.
DATASET_UPDATED - Static variable in class org.jfree.chart.event.ChartChangeEventType
DATASET_UPDATED.
DatasetAttributes - Class in org.jlab.groot.base
 
DatasetAttributes(int) - Constructor for class org.jlab.groot.base.DatasetAttributes
 
DatasetAttributes() - Constructor for class org.jlab.groot.base.DatasetAttributes
 
DatasetAttributes.DatasetAttributesPane - Class in org.jlab.groot.base
 
DatasetAttributesPane(DatasetAttributes) - Constructor for class org.jlab.groot.base.DatasetAttributes.DatasetAttributesPane
 
datasetChanged(DatasetChangeEvent) - Method in class org.jfree.chart.plot.CategoryPlot
Receives notification of a change to the plot's dataset.
datasetChanged(DatasetChangeEvent) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Receives notification of a change to the plot's dataset.
datasetChanged(DatasetChangeEvent) - Method in class org.jfree.chart.plot.Plot
Receives notification of a change to the plot's dataset.
datasetChanged(DatasetChangeEvent) - Method in class org.jfree.chart.plot.PolarPlot
Receives notification of a change to the plot's m_Dataset.
datasetChanged(DatasetChangeEvent) - Method in class org.jfree.chart.plot.ThermometerPlot
Checks to see if a new value means the axis range needs adjusting.
datasetChanged(DatasetChangeEvent) - Method in class org.jfree.chart.plot.XYPlot
Receives notification of a change to the plot's dataset.
datasetChanged(DatasetChangeEvent) - Method in class org.jfree.data.category.CategoryToPieDataset
Sends a DatasetChangeEvent to all registered listeners, with this (not the underlying) dataset as the source.
datasetChanged(DatasetChangeEvent) - Method in class org.jfree.data.gantt.XYTaskDataset
Receives a change event from the underlying dataset and responds by firing a change event for this dataset.
datasetChanged(DatasetChangeEvent) - Method in interface org.jfree.data.general.DatasetChangeListener
Receives notification of an dataset change event.
datasetChanged(DatasetChangeEvent) - Method in class org.jfree.data.xy.IntervalXYDelegate
Handles events from the dataset by recalculating the interval if necessary.
datasetChanged(DatasetChangeEvent) - Method in class org.jfree.data.xy.XYBarDataset
Receives notification of an dataset change event.
datasetChanged(DatasetChangeEvent) - Method in class org.jfree.data.xy.XYDatasetTableModel
Receives notification that the underlying dataset has changed.
DatasetChangeEvent - Class in org.jfree.data.general
A change event that encapsulates information about a change to a dataset.
DatasetChangeEvent(Object, Dataset) - Constructor for class org.jfree.data.general.DatasetChangeEvent
Constructs a new event.
DatasetChangeListener - Interface in org.jfree.data.general
The interface that must be supported by classes that wish to receive notification of changes to a dataset.
DatasetDescriptor - Class in org.jlab.groot.tree
 
DatasetDescriptor(String, int) - Constructor for class org.jlab.groot.tree.DatasetDescriptor
 
DatasetDescriptor(String, int, double, double, String, ITree) - Constructor for class org.jlab.groot.tree.DatasetDescriptor
 
DatasetDescriptor(String, int, double, double, int, double, double, String, ITree) - Constructor for class org.jlab.groot.tree.DatasetDescriptor
 
DatasetDescriptor(String, String, ITree) - Constructor for class org.jlab.groot.tree.DatasetDescriptor
 
DatasetGroup - Class in org.jfree.data.general
A class that is used to group datasets (currently not used for any specific purpose).
DatasetGroup() - Constructor for class org.jfree.data.general.DatasetGroup
Constructs a new group.
DatasetGroup(String) - Constructor for class org.jfree.data.general.DatasetGroup
Creates a new group with the specified id.
datasetOperationDialog() - Method in class org.jlab.groot.studio.StudioUI
 
DatasetOperations - Class in org.jlab.groot.data
 
DatasetOperations(Map<String, IDataSet>) - Constructor for class org.jlab.groot.data.DatasetOperations
 
DatasetReader - Class in org.jfree.data.xml
A utility class for reading datasets from XML.
DatasetReader() - Constructor for class org.jfree.data.xml.DatasetReader
 
DatasetRenderingOrder - Class in org.jfree.chart.plot
Defines the tokens that indicate the rendering order for datasets in a CategoryPlot or an XYPlot.
DataSetSerializer - Class in org.jlab.groot.data
 
DataSetSerializer() - Constructor for class org.jlab.groot.data.DataSetSerializer
 
DatasetTags - Interface in org.jfree.data.xml
Constants for the tags that identify the elements in the XML files.
DatasetUtilities - Class in org.jfree.data.general
A collection of useful static methods relating to datasets.
DataSource - Class in jhplot.stat
This class serves as input for the Limit.ComputeLimit method.
DataSource() - Constructor for class jhplot.stat.DataSource
Simplest constructor.
DataSource(H1D, H1D, H1D) - Constructor for class jhplot.stat.DataSource
Adds one channel with signal, background and data given as input.
DataSource(P1D, P1D, P1D) - Constructor for class jhplot.stat.DataSource
Adds one channel with signal, background and data given as input.
DataSource(H1D, H1D, H1D, double, double, double, String) - Constructor for class jhplot.stat.DataSource
Another constructor, directly adds one channel with signal, background and data given as input.
DataUtilities - Class in org.jfree.data
Utility methods for use with some of the data classes (but not the datasets, see DatasetUtilities).
DataUtilities() - Constructor for class org.jfree.data.DataUtilities
 
DataVector - Class in org.jlab.groot.data
 
DataVector(int) - Constructor for class org.jlab.groot.data.DataVector
 
DataVector() - Constructor for class org.jlab.groot.data.DataVector
 
DataVector(double[]) - Constructor for class org.jlab.groot.data.DataVector
 
DataVector(List<Double>) - Constructor for class org.jlab.groot.data.DataVector
 
DATAX - Variable in class org.jlab.groot.data.DataParser
 
DATAXERR - Variable in class org.jlab.groot.data.DataParser
 
DATAY - Variable in class org.jlab.groot.data.DataParser
 
DATAYERR - Variable in class org.jlab.groot.data.DataParser
 
DateAxis - Class in org.jfree.chart.axis
The base class for axes that display dates.
DateAxis() - Constructor for class org.jfree.chart.axis.DateAxis
Creates a date axis with no label.
DateAxis(String) - Constructor for class org.jfree.chart.axis.DateAxis
Creates a date axis with the specified label.
DateAxis(String, TimeZone) - Constructor for class org.jfree.chart.axis.DateAxis
Deprecated.
From 1.0.11 onwards, use DateAxis.DateAxis(String, TimeZone, Locale) instead, to explicitly set the locale.
DateAxis(String, TimeZone, Locale) - Constructor for class org.jfree.chart.axis.DateAxis
Creates a date axis.
DateRange - Class in org.jfree.data.time
A range specified in terms of two java.util.Date objects.
DateRange() - Constructor for class org.jfree.data.time.DateRange
Default constructor.
DateRange(Date, Date) - Constructor for class org.jfree.data.time.DateRange
Constructs a new range.
DateRange(double, double) - Constructor for class org.jfree.data.time.DateRange
Constructs a new range using two values that will be interpreted as "milliseconds since midnight GMT, 1-Jan-1970".
DateRange(Range) - Constructor for class org.jfree.data.time.DateRange
Constructs a new range that is based on another Range.
DateTick - Class in org.jfree.chart.axis
A tick used by the DateAxis class.
DateTick(Date, String, TextAnchor, TextAnchor, double) - Constructor for class org.jfree.chart.axis.DateTick
Creates a new date tick.
DateTick(TickType, Date, String, TextAnchor, TextAnchor, double) - Constructor for class org.jfree.chart.axis.DateTick
Creates a new date tick.
DateTickMarkPosition - Class in org.jfree.chart.axis
Used to indicate the required position of tick marks on a date axis relative to the underlying time period.
DateTickUnit - Class in org.jfree.chart.axis
A tick unit for use by subclasses of DateAxis.
DateTickUnit(DateTickUnitType, int) - Constructor for class org.jfree.chart.axis.DateTickUnit
Creates a new date tick unit.
DateTickUnit(DateTickUnitType, int, DateFormat) - Constructor for class org.jfree.chart.axis.DateTickUnit
Creates a new date tick unit.
DateTickUnit(DateTickUnitType, int, DateTickUnitType, int, DateFormat) - Constructor for class org.jfree.chart.axis.DateTickUnit
Creates a new unit.
DateTickUnit(int, int, DateFormat) - Constructor for class org.jfree.chart.axis.DateTickUnit
DateTickUnit(int, int) - Constructor for class org.jfree.chart.axis.DateTickUnit
Deprecated.
DateTickUnit(int, int, int, int, DateFormat) - Constructor for class org.jfree.chart.axis.DateTickUnit
DateTickUnitType - Class in org.jfree.chart.axis
An enumeration of the unit types for a DateTickUnit instance.
DateTitle - Class in org.jfree.chart.title
A chart title that displays the date.
DateTitle() - Constructor for class org.jfree.chart.title.DateTitle
Creates a new chart title that displays the current date in the default (LONG) format for the locale, positioned to the bottom right of the chart.
DateTitle(int) - Constructor for class org.jfree.chart.title.DateTitle
Creates a new chart title that displays the current date with the specified style (for the default locale).
DateTitle(int, Locale, Font, Paint) - Constructor for class org.jfree.chart.title.DateTitle
Creates a new chart title that displays the current date.
DateTitle(int, Locale, Font, Paint, RectangleEdge, HorizontalAlignment, VerticalAlignment, RectangleInsets) - Constructor for class org.jfree.chart.title.DateTitle
Creates a new chart title that displays the current date.
dateToJava2D(Date, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.DateAxis
Translates a date to Java2D coordinates, based on the range displayed by this axis for the specified data area.
dateToString(Date) - Method in class org.jfree.chart.axis.DateTickUnit
Formats a date using the tick unit's formatter.
DAUGHTER1_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
DAUGHTER1_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
DAUGHTER1_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
DAUGHTER2_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
DAUGHTER2_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
DAUGHTER2_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
daxpy(double, DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Combined vector scaling; y = y + alpha*x.
daxpy(double, DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Combined matrix scaling; B = B + alpha*A.
daxpy(double, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
daxpy(double, DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
daxpy(double, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
daxpy(double, DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
DAY - Static variable in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of version 1.0.13, use DateTickUnitType instead.
DAY - Static variable in class org.jfree.chart.axis.DateTickUnitType
Day.
Day - Class in org.jfree.data.time
Represents a single day in the range 1-Jan-1900 to 31-Dec-9999.
Day() - Constructor for class org.jfree.data.time.Day
Creates a new instance, derived from the system date/time (and assuming the default timezone).
Day(int, int, int) - Constructor for class org.jfree.data.time.Day
Constructs a new one day time period.
Day(SerialDate) - Constructor for class org.jfree.data.time.Day
Constructs a new one day time period.
Day(Date) - Constructor for class org.jfree.data.time.Day
Constructs a new instance, based on a particular date/time and the default time zone.
Day(Date, TimeZone) - Constructor for class org.jfree.data.time.Day
Deprecated.
As of 1.0.13, use the constructor that specifies the locale also.
Day(Date, TimeZone, Locale) - Constructor for class org.jfree.data.time.Day
Constructs a new instance, based on a particular date/time and time zone.
DAY_SEGMENT_SIZE - Static variable in class org.jfree.chart.axis.SegmentedTimeline
Defines a day segment size in ms.
DbByteArrayOutputStream - Class in jhplot.io.db
Extends ByteArrayOutputStream to provide a way of writing the buffer to a DataOutput without re-allocating it.
DbByteArrayOutputStream() - Constructor for class jhplot.io.db.DbByteArrayOutputStream
 
DbByteArrayOutputStream(int) - Constructor for class jhplot.io.db.DbByteArrayOutputStream
 
DBSCANClusterer<T extends Clusterable> - Class in org.apache.commons.math3.ml.clustering
DBSCAN (density-based spatial clustering of applications with noise) algorithm.
DBSCANClusterer(double, int) - Constructor for class org.apache.commons.math3.ml.clustering.DBSCANClusterer
Creates a new instance of a DBSCANClusterer.
DBSCANClusterer(double, int, DistanceMeasure) - Constructor for class org.apache.commons.math3.ml.clustering.DBSCANClusterer
Creates a new instance of a DBSCANClusterer.
DBSCANClusterer<T extends Clusterable<T>> - Class in org.apache.commons.math3.stat.clustering
Deprecated.
As of 3.2 (to be removed in 4.0), use DBSCANClusterer instead
DBSCANClusterer(double, int) - Constructor for class org.apache.commons.math3.stat.clustering.DBSCANClusterer
Deprecated.
Creates a new instance of a DBSCANClusterer.
dcopy(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Vector assignment (copying); y = x.
dcopy(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Matrix assignment (copying); B = A.
dcopy(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dcopy(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dcopy(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dcopy(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
DctNormalization - Enum in org.apache.commons.math3.transform
This enumeration defines the various types of normalizations that can be applied to discrete cosine transforms (DCT).
ddot(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
ddot(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
ddot(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
debug - Variable in class graph.ParseFunction
Debug variable.
DEBUG - Static variable in class hep.lcio.util.ObjectComparator
 
debug - Static variable in class jplot.JPlot
 
debugStream - Variable in class jplot3dp.MathParser.MathParserTokenManager
 
debugStream - Variable in class org.nfunk.jep.ParserTokenManager
 
dec - Static variable in class cern.jet.math.IntFunctions
Function that returns a--.
dec(long) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Decrements the internal attributes of this segment by a number of segments.
dec() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Decrements the internal attributes of this segment by one segment.
decay(LorentzVector, double, double, double, double) - Static method in class j4np.physics.DecayKinematics
 
decay(LorentzVector, double[], double, double, DecayKinematics.Frame) - Static method in class j4np.physics.DecayKinematics
 
DecayKinematics - Class in j4np.physics
 
DecayKinematics() - Constructor for class j4np.physics.DecayKinematics
 
DecayKinematics.Frame - Enum in j4np.physics
 
DECIMAL - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The alignment string aligning the cells of a column to the decimal point.
Decimal64 - Class in org.apache.commons.math3.util
This class wraps a double value in an object.
Decimal64(double) - Constructor for class org.apache.commons.math3.util.Decimal64
Creates a new instance of this class.
Decimal64Field - Class in org.apache.commons.math3.util
The field of double precision floating-point numbers.
DECIMAL_LITERAL - Static variable in interface org.nfunk.jep.ParserConstants
 
decode(String) - Static method in class jplot.Translate
Decode a string containing references.
decode(List<T>) - Method in interface org.apache.commons.math3.genetics.PermutationChromosome
Permutes the sequence of objects of type T according to the permutation this chromosome represents.
decode(List<T>) - Method in class org.apache.commons.math3.genetics.RandomKey
Permutes the sequence of objects of type T according to the permutation this chromosome represents.
decompose(DoubleMatrix2D[][], DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
Splits a block matrix into its constituent blocks; Copies blocks of a matrix into the given parts.
decompose(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Decomposes matrix A into L and U (in-place).
decompose(DoubleMatrix2D, int) - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Decomposes the banded and square matrix A into L and U (in-place).
decompose(ObjectMatrix2D[][], ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
Splits a block matrix into its constituent blocks; Copies blocks of a matrix into the given parts.
DecompositionSolver - Interface in org.apache.commons.math3.linear
Interface handling decomposition algorithms that can solve A × X = B.
decrementExact(int) - Static method in class org.apache.commons.math3.util.FastMath
Decrement a number, detecting overflows.
decrementExact(long) - Static method in class org.apache.commons.math3.util.FastMath
Decrement a number, detecting overflows.
deepCopy(Node, XJep) - Method in class org.lsmp.djep.xjep.DeepCopyVisitor
Creates a deepCopy of a Node
deepCopy(Node) - Method in class org.lsmp.djep.xjep.XJep
Returns a deep copy of an expression tree.
DeepCopyVisitor - Class in org.lsmp.djep.xjep
A Visitor which returns an exact copy of the tree.
DeepCopyVisitor() - Constructor for class org.lsmp.djep.xjep.DeepCopyVisitor
 
DEFAULT - Static variable in class cern.colt.matrix.linalg.Algebra
A default Algebra object; has Property.DEFAULT attached for tolerance.
DEFAULT - Static variable in class cern.colt.matrix.linalg.Property
The default Property object; currently has tolerance()==1.0E-9.
DEFAULT - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
DEFAULT - Static variable in interface org.nfunk.jep.ParserConstants
 
DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Default absolute accuracy.
DEFAULT_ABSOLUTE_POSITIVITY_THRESHOLD - Static variable in class org.apache.commons.math3.linear.CholeskyDecomposition
Default threshold below which diagonal elements are considered null and matrix not positive definite.
DEFAULT_ACCURACY - Static variable in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Default value for accuracy.
DEFAULT_ADVANCE_LINE_PAINT - Static variable in class org.jfree.chart.axis.CyclicNumberAxis
The default axis line paint.
DEFAULT_ADVANCE_LINE_STROKE - Static variable in class org.jfree.chart.axis.CyclicNumberAxis
The default axis line stroke.
DEFAULT_ANCHOR_DATE - Static variable in class org.jfree.chart.axis.DateAxis
The default anchor date.
DEFAULT_ANGLE_OFFSET - Static variable in class org.jfree.chart.plot.PolarPlot
The default angle offset.
DEFAULT_ANGLE_TICK_UNIT_SIZE - Static variable in class org.jfree.chart.plot.PolarPlot
The default angle tick unit size.
DEFAULT_ARROW_LENGTH - Static variable in class org.jfree.chart.annotations.CategoryPointerAnnotation
The default arrow length (in Java2D units).
DEFAULT_ARROW_LENGTH - Static variable in class org.jfree.chart.annotations.XYPointerAnnotation
The default arrow length (in Java2D units).
DEFAULT_ARROW_WIDTH - Static variable in class org.jfree.chart.annotations.CategoryPointerAnnotation
The default arrow width (in Java2D units).
DEFAULT_ARROW_WIDTH - Static variable in class org.jfree.chart.annotations.XYPointerAnnotation
The default arrow width (in Java2D units).
DEFAULT_AUTO_RANGE - Static variable in class org.jfree.chart.axis.ValueAxis
The default auto-range value.
DEFAULT_AUTO_RANGE_INCLUDES_ZERO - Static variable in class org.jfree.chart.axis.NumberAxis
The default value for the autoRangeIncludesZero flag.
DEFAULT_AUTO_RANGE_MINIMUM_SIZE - Static variable in class org.jfree.chart.axis.ValueAxis
The default minimum auto range.
DEFAULT_AUTO_RANGE_MINIMUM_SIZE_IN_MILLISECONDS - Static variable in class org.jfree.chart.axis.DateAxis
The default minimum auto range size.
DEFAULT_AUTO_RANGE_STICKY_ZERO - Static variable in class org.jfree.chart.axis.NumberAxis
The default value for the autoRangeStickyZero flag.
DEFAULT_AUTO_TICK_UNIT_SELECTION - Static variable in class org.jfree.chart.axis.ValueAxis
The default auto-tick-unit-selection value.
DEFAULT_AXIS_LABEL_FONT - Static variable in class org.jfree.chart.axis.Axis
The default axis label font.
DEFAULT_AXIS_LABEL_GAP - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The default axis label gap (currently 10%).
DEFAULT_AXIS_LABEL_INSETS - Static variable in class org.jfree.chart.axis.Axis
The default axis label insets.
DEFAULT_AXIS_LABEL_PAINT - Static variable in class org.jfree.chart.axis.Axis
The default axis label paint.
DEFAULT_AXIS_LINE_PAINT - Static variable in class org.jfree.chart.axis.Axis
The default axis line paint.
DEFAULT_AXIS_LINE_STROKE - Static variable in class org.jfree.chart.axis.Axis
The default axis line stroke.
DEFAULT_AXIS_MARGIN - Static variable in class org.jfree.chart.axis.CategoryAxis
The default margin for the axis (used for both lower and upper margins).
DEFAULT_AXIS_VISIBLE - Static variable in class org.jfree.chart.axis.Axis
The default axis visibility.
DEFAULT_BACKGROUND_ALPHA - Static variable in class org.jfree.chart.plot.Plot
The default background alpha transparency.
DEFAULT_BACKGROUND_IMAGE - Static variable in class org.jfree.chart.JFreeChart
The default background image.
DEFAULT_BACKGROUND_IMAGE_ALIGNMENT - Static variable in class org.jfree.chart.JFreeChart
The default background image alignment.
DEFAULT_BACKGROUND_IMAGE_ALPHA - Static variable in class org.jfree.chart.JFreeChart
The default background image alpha.
DEFAULT_BACKGROUND_PAINT - Static variable in class org.jfree.chart.JFreeChart
The default background color.
DEFAULT_BACKGROUND_PAINT - Static variable in class org.jfree.chart.plot.Plot
The default background color.
DEFAULT_BANDWIDTH - Static variable in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Default value of the bandwidth parameter.
DEFAULT_BASE_RADIUS - Static variable in class org.jfree.chart.annotations.CategoryPointerAnnotation
The default base radius (in Java2D units).
DEFAULT_BASE_RADIUS - Static variable in class org.jfree.chart.annotations.XYPointerAnnotation
The default base radius (in Java2D units).
DEFAULT_BIN_COUNT - Static variable in class org.apache.commons.math3.random.EmpiricalDistribution
Default bin count
DEFAULT_BORDER_SIZE - Static variable in class org.jfree.chart.plot.MeterPlot
The default border size.
DEFAULT_BRIGHTNESS_EXPONENT - Static variable in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
Deprecated.
Default exponent used the weights calculation.
DEFAULT_BUFFER_SIZE - Static variable in class org.apache.commons.io.IOUtils
The default buffer size (8192) to use in copy methods.
DEFAULT_BUFFER_USED - Static variable in class org.jfree.chart.ChartPanel
Default setting for buffer usage.
DEFAULT_CATEGORY_MARGIN - Static variable in class org.jfree.chart.axis.CategoryAxis
The default margin between categories (a percentage of the overall axis length).
DEFAULT_CHECKFEASABLECOUNT - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
Default value for CMAESOptimizer.checkFeasableCount: 0.
DEFAULT_CIRCLE_SIZE - Static variable in class org.jfree.chart.plot.MeterPlot
The default circle size.
DEFAULT_COLORBAR_THICKNESS - Static variable in class org.jfree.chart.axis.ColorBar
Deprecated.
The default color bar thickness.
DEFAULT_COLORBAR_THICKNESS_PERCENT - Static variable in class org.jfree.chart.axis.ColorBar
Deprecated.
The default color bar thickness percentage.
DEFAULT_COLUMN_SEPARATOR - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The default string separating any two columns from another; currently " ".
DEFAULT_COMPARATOR - Static variable in class org.apache.commons.io.comparator.DefaultFileComparator
Singleton default comparator instance
DEFAULT_CROSSHAIR_PAINT - Static variable in class org.jfree.chart.plot.CategoryPlot
The default crosshair paint.
DEFAULT_CROSSHAIR_PAINT - Static variable in class org.jfree.chart.plot.WaferMapPlot
The default crosshair paint.
DEFAULT_CROSSHAIR_PAINT - Static variable in class org.jfree.chart.plot.XYPlot
The default crosshair paint.
DEFAULT_CROSSHAIR_STROKE - Static variable in class org.jfree.chart.plot.CategoryPlot
The default crosshair stroke.
DEFAULT_CROSSHAIR_STROKE - Static variable in class org.jfree.chart.plot.WaferMapPlot
The default crosshair stroke.
DEFAULT_CROSSHAIR_STROKE - Static variable in class org.jfree.chart.plot.XYPlot
The default crosshair stroke.
DEFAULT_CROSSHAIR_VISIBLE - Static variable in class org.jfree.chart.plot.CategoryPlot
The default crosshair visibility.
DEFAULT_CROSSHAIR_VISIBLE - Static variable in class org.jfree.chart.plot.WaferMapPlot
The default crosshair visibility.
DEFAULT_CROSSHAIR_VISIBLE - Static variable in class org.jfree.chart.plot.XYPlot
The default crosshair visibility.
DEFAULT_DATE_RANGE - Static variable in class org.jfree.chart.axis.DateAxis
The default axis range.
DEFAULT_DATE_TICK_UNIT - Static variable in class org.jfree.chart.axis.DateAxis
Deprecated.
As pointed out in bug #977, the SimpleDateFormat in this object uses Calendar which is not thread safe...so you should avoid reusing this instance and create a new instance as required.
DEFAULT_DIAGONALONLY - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
Default value for CMAESOptimizer.diagonalOnly: 0.
DEFAULT_DIVIDER_PAINT - Static variable in class org.jfree.chart.axis.PeriodAxisLabelInfo
The default divider paint.
DEFAULT_DIVIDER_STROKE - Static variable in class org.jfree.chart.axis.PeriodAxisLabelInfo
The default divider stroke.
DEFAULT_DOMAIN_GRIDLINES_VISIBLE - Static variable in class org.jfree.chart.plot.CategoryPlot
The default visibility of the grid lines plotted against the domain axis.
DEFAULT_EPSILON - Static variable in class org.apache.commons.math3.distribution.PoissonDistribution
Default convergence criterion.
DEFAULT_EXTEND - Static variable in class org.apache.commons.math3.analysis.interpolation.UnivariatePeriodicInterpolator
Default number of extension points of the samples array.
DEFAULT_FILL_PAINT_SEQUENCE - Static variable in class org.jfree.chart.plot.DefaultDrawingSupplier
The default fill paint sequence.
DEFAULT_FONT - Static variable in class org.jfree.chart.annotations.TextAnnotation
The default font.
DEFAULT_FONT - Static variable in class org.jfree.chart.annotations.XYTextAnnotation
The default font.
DEFAULT_FONT - Static variable in class org.jfree.chart.axis.PeriodAxisLabelInfo
The default font.
DEFAULT_FONT - Static variable in class org.jfree.chart.title.TextTitle
The default font.
DEFAULT_FOREGROUND_ALPHA - Static variable in class org.jfree.chart.plot.Plot
The default foreground alpha transparency.
DEFAULT_FORMAT - Static variable in class org.apache.commons.math3.linear.MatrixUtils
The default format for RealMatrix objects.
DEFAULT_FORMAT_STRING - Static variable in class org.jfree.chart.labels.BubbleXYItemLabelGenerator
The default item label format.
DEFAULT_GRID_BAND_ALTERNATE_PAINT - Static variable in class org.jfree.chart.axis.SymbolAxis
The default paint for alternate grid bands.
DEFAULT_GRID_BAND_PAINT - Static variable in class org.jfree.chart.axis.SymbolAxis
The default grid band paint.
DEFAULT_GRIDLINE_PAINT - Static variable in class org.jfree.chart.plot.CategoryPlot
The default grid line paint.
DEFAULT_GRIDLINE_PAINT - Static variable in class org.jfree.chart.plot.FastScatterPlot
The default grid line paint.
DEFAULT_GRIDLINE_PAINT - Static variable in class org.jfree.chart.plot.PolarPlot
The default grid line paint.
DEFAULT_GRIDLINE_PAINT - Static variable in class org.jfree.chart.plot.WaferMapPlot
The default grid line paint.
DEFAULT_GRIDLINE_PAINT - Static variable in class org.jfree.chart.plot.XYPlot
The default grid line paint.
DEFAULT_GRIDLINE_STROKE - Static variable in class org.jfree.chart.plot.CategoryPlot
The default grid line stroke.
DEFAULT_GRIDLINE_STROKE - Static variable in class org.jfree.chart.plot.FastScatterPlot
The default grid line stroke.
DEFAULT_GRIDLINE_STROKE - Static variable in class org.jfree.chart.plot.PolarPlot
The default grid line stroke.
DEFAULT_GRIDLINE_STROKE - Static variable in class org.jfree.chart.plot.WaferMapPlot
The default grid line stroke.
DEFAULT_GRIDLINE_STROKE - Static variable in class org.jfree.chart.plot.XYPlot
The default grid line stroke.
DEFAULT_HEAD - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The default head radius percent (currently 1%).
DEFAULT_HEIGHT - Static variable in class org.jfree.chart.ChartPanel
The default panel height.
DEFAULT_HORIZONTAL_ALIGNMENT - Static variable in class org.jfree.chart.title.Title
The default horizontal alignment.
DEFAULT_INITIAL_RADIUS - Static variable in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
DEFAULT_INITIAL_RADIUS - Static variable in class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
Deprecated.
DEFAULT_INSETS - Static variable in class org.jfree.chart.axis.PeriodAxisLabelInfo
The default insets.
DEFAULT_INSETS - Static variable in class org.jfree.chart.plot.Plot
The default insets.
DEFAULT_INTERIOR_GAP - Static variable in class org.jfree.chart.plot.PiePlot
The default interior gap.
DEFAULT_INTERIOR_GAP - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The default interior gap.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.BetaDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.CauchyDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Default inverse cumulative probability accuracy
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.ExponentialDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.FDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.GammaDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.LogNormalDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.NakagamiDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.NormalDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.ParetoDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.TDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.UniformRealDistribution
Deprecated.
as of 3.2 not used anymore, will be removed in 4.0
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.WeibullDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERTED - Static variable in class org.jfree.chart.axis.ValueAxis
The default inverted flag setting.
DEFAULT_ISACTIVECMA - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
Default value for CMAESOptimizer.isActiveCMA: true.
DEFAULT_ITEM_FONT - Static variable in class org.jfree.chart.title.LegendTitle
The default item font.
DEFAULT_ITEM_LABEL_FORMAT - Static variable in class org.jfree.chart.labels.IntervalXYItemLabelGenerator
The default item label format.
DEFAULT_ITEM_LABEL_FORMAT - Static variable in class org.jfree.chart.labels.StandardXYItemLabelGenerator
The default item label format.
DEFAULT_ITEM_MARGIN - Static variable in class org.jfree.chart.renderer.category.BarRenderer
The default item margin percentage.
DEFAULT_ITEM_MARGIN - Static variable in class org.jfree.chart.renderer.category.LevelRenderer
The default item margin percentage.
DEFAULT_ITEM_PAINT - Static variable in class org.jfree.chart.title.LegendTitle
The default item paint.
DEFAULT_ITEM_PARAMETER - Static variable in class org.jfree.chart.urls.StandardXYURLGenerator
The default item parameter.
DEFAULT_LABEL_BACKGROUND_PAINT - Static variable in class org.jfree.chart.plot.PiePlot
The default section label background paint.
DEFAULT_LABEL_BACKGROUND_PAINT - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The default series label background paint.
DEFAULT_LABEL_FONT - Static variable in class org.jfree.chart.plot.CompassPlot
The default label font.
DEFAULT_LABEL_FONT - Static variable in class org.jfree.chart.plot.MeterPlot
The default label font.
DEFAULT_LABEL_FONT - Static variable in class org.jfree.chart.plot.PiePlot
The default section label font.
DEFAULT_LABEL_FONT - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The default series label font.
DEFAULT_LABEL_FORMAT - Static variable in class org.jfree.chart.labels.MultipleXYSeriesLabelGenerator
The default item label format.
DEFAULT_LABEL_FORMAT - Static variable in class org.jfree.chart.labels.StandardCategorySeriesLabelGenerator
The default item label format.
DEFAULT_LABEL_FORMAT - Static variable in class org.jfree.chart.labels.StandardXYSeriesLabelGenerator
The default item label format.
DEFAULT_LABEL_FORMAT_STRING - Static variable in class org.jfree.chart.labels.IntervalCategoryItemLabelGenerator
The default format string.
DEFAULT_LABEL_FORMAT_STRING - Static variable in class org.jfree.chart.labels.StandardCategoryItemLabelGenerator
The default format string.
DEFAULT_LABEL_OFFSET - Static variable in class org.jfree.chart.annotations.CategoryPointerAnnotation
The default label offset (in Java2D units).
DEFAULT_LABEL_OFFSET - Static variable in class org.jfree.chart.annotations.XYPointerAnnotation
The default label offset (in Java2D units).
DEFAULT_LABEL_OUTLINE_PAINT - Static variable in class org.jfree.chart.plot.PiePlot
The default section label outline paint.
DEFAULT_LABEL_OUTLINE_PAINT - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The default series label outline paint.
DEFAULT_LABEL_OUTLINE_STROKE - Static variable in class org.jfree.chart.plot.PiePlot
The default section label outline stroke.
DEFAULT_LABEL_OUTLINE_STROKE - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The default series label outline stroke.
DEFAULT_LABEL_PAINT - Static variable in class org.jfree.chart.axis.PeriodAxisLabelInfo
The default label paint.
DEFAULT_LABEL_PAINT - Static variable in class org.jfree.chart.plot.PiePlot
The default section label paint.
DEFAULT_LABEL_PAINT - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The default series label paint.
DEFAULT_LABEL_SHADOW_PAINT - Static variable in class org.jfree.chart.plot.PiePlot
The default section label shadow paint.
DEFAULT_LABEL_SHADOW_PAINT - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The default series label shadow paint.
DEFAULT_LEGEND_ITEM_BOX - Static variable in class org.jfree.chart.plot.Plot
A default box shape for legend items.
DEFAULT_LEGEND_ITEM_CIRCLE - Static variable in class org.jfree.chart.plot.Plot
A default circle shape for legend items.
DEFAULT_LOWER_BOUND - Static variable in class org.jfree.chart.axis.ValueAxis
Deprecated.
From 1.0.5 onwards, the axis defines a defaultRange attribute (see ValueAxis.getDefaultAutoRange()).
DEFAULT_LOWER_MARGIN - Static variable in class org.jfree.chart.axis.ValueAxis
The default value for the lower margin (0.05 = 5%).
DEFAULT_MAX_ITERATIONS - Static variable in class org.apache.commons.math3.distribution.PoissonDistribution
Default maximum number of iterations for cumulative probability calculations.
DEFAULT_MAX_ITERATIONS - Static variable in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated.
Default maximal number of iterations allowed.
DEFAULT_MAX_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Default maximal iteration count.
DEFAULT_MAX_VALUE - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The default maximum value plotted - forces the plot to evaluate the maximum from the data passed in
DEFAULT_MAXIMUM_DRAW_HEIGHT - Static variable in class org.jfree.chart.ChartPanel
The default limit above which chart scaling kicks in.
DEFAULT_MAXIMUM_DRAW_WIDTH - Static variable in class org.jfree.chart.ChartPanel
The default limit above which chart scaling kicks in.
DEFAULT_MAXITERATIONS - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
Default value for CMAESOptimizer.maxIterations: 30000.
DEFAULT_METER_ANGLE - Static variable in class org.jfree.chart.plot.MeterPlot
The default meter angle.
DEFAULT_MICROSPHERE_ELEMENTS - Static variable in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
Deprecated.
Default number of surface elements that composes the microsphere.
DEFAULT_MIN_COLUMN_WIDTH - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The default minimum number of characters a column may have; currently 1.
DEFAULT_MIN_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Default minimal iteration count.
DEFAULT_MINIMUM_ARC_ANGLE_TO_DRAW - Static variable in class org.jfree.chart.plot.PiePlot
The default minimum arc angle to draw.
DEFAULT_MINIMUM_DRAW_HEIGHT - Static variable in class org.jfree.chart.ChartPanel
The default limit below which chart scaling kicks in.
DEFAULT_MINIMUM_DRAW_WIDTH - Static variable in class org.jfree.chart.ChartPanel
The default limit below which chart scaling kicks in.
DEFAULT_NAN_STRATEGY - Static variable in class org.apache.commons.math3.stat.ranking.NaturalRanking
default NaN strategy
DEFAULT_OUTERGAP - Static variable in class org.jfree.chart.axis.ColorBar
Deprecated.
The default outer gap.
DEFAULT_OUTLINE_PAINT - Static variable in class org.jfree.chart.plot.Plot
The default outline color.
DEFAULT_OUTLINE_PAINT - Static variable in class org.jfree.chart.renderer.AbstractRenderer
The default outline paint.
DEFAULT_OUTLINE_PAINT_SEQUENCE - Static variable in class org.jfree.chart.plot.DefaultDrawingSupplier
The default outline paint sequence.
DEFAULT_OUTLINE_STROKE - Static variable in class org.jfree.chart.plot.Plot
The default outline stroke.
DEFAULT_OUTLINE_STROKE - Static variable in class org.jfree.chart.renderer.AbstractRenderer
The default outline stroke.
DEFAULT_OUTLINE_STROKE_SEQUENCE - Static variable in class org.jfree.chart.plot.DefaultDrawingSupplier
The default outline stroke sequence.
DEFAULT_PADDING - Static variable in class org.jfree.chart.title.Title
Default title padding.
DEFAULT_PAINT - Static variable in class org.jfree.chart.annotations.TextAnnotation
The default paint.
DEFAULT_PAINT - Static variable in class org.jfree.chart.annotations.XYTextAnnotation
The default paint.
DEFAULT_PAINT - Static variable in class org.jfree.chart.block.LabelBlock
The default color.
DEFAULT_PAINT - Static variable in class org.jfree.chart.renderer.AbstractRenderer
The default paint.
DEFAULT_PAINT_SEQUENCE - Static variable in class org.jfree.chart.plot.DefaultDrawingSupplier
The default fill paint sequence.
DEFAULT_POSITION - Static variable in class org.jfree.chart.title.Title
The default title position.
DEFAULT_PREFIX - Static variable in class org.apache.commons.math3.geometry.VectorFormat
The default prefix: "{".
DEFAULT_PREFIX - Static variable in class org.jfree.chart.urls.StandardXYURLGenerator
The default prefix.
DEFAULT_RANDOMGENERATOR - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
Default value for CMAESOptimizer.random.
DEFAULT_RANGE - Static variable in class org.jfree.chart.axis.ValueAxis
The default axis range.
DEFAULT_RANGE_GRIDLINES_VISIBLE - Static variable in class org.jfree.chart.plot.CategoryPlot
The default visibility of the grid lines plotted against the range axis.
DEFAULT_RELATIVE_ACCURACY - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Default relative accuracy.
DEFAULT_RELATIVE_SYMMETRY_THRESHOLD - Static variable in class org.apache.commons.math3.linear.CholeskyDecomposition
Default threshold above which off-diagonal elements are considered too different and matrix not symmetric.
DEFAULT_REVERSE - Static variable in class org.apache.commons.io.comparator.DefaultFileComparator
Singleton reverse default comparator instance
DEFAULT_ROBUSTNESS_ITERS - Static variable in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Default value of the number of robustness iterations.
DEFAULT_ROTATION_ANCHOR - Static variable in class org.jfree.chart.annotations.TextAnnotation
The default rotation anchor.
DEFAULT_ROTATION_ANCHOR - Static variable in class org.jfree.chart.annotations.XYTextAnnotation
The default rotation anchor.
DEFAULT_ROTATION_ANGLE - Static variable in class org.jfree.chart.annotations.TextAnnotation
The default rotation angle.
DEFAULT_ROTATION_ANGLE - Static variable in class org.jfree.chart.annotations.XYTextAnnotation
The default rotation angle.
DEFAULT_ROW_SEPARATOR - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The default string separating any two rows from another; currently "\n".
DEFAULT_SCALE_FACTOR - Static variable in class org.jfree.data.xy.NormalizedMatrixSeries
The default scale factor.
DEFAULT_SECTION_LABEL_FORMAT - Static variable in class org.jfree.chart.labels.StandardPieSectionLabelGenerator
The default section label format.
DEFAULT_SECTION_LABEL_FORMAT - Static variable in class org.jfree.chart.labels.StandardPieToolTipGenerator
Deprecated.
DEFAULT_SEED - Static variable in class cern.jet.random.engine.DRand
 
DEFAULT_SEED - Static variable in class cern.jet.random.engine.MersenneTwister
 
DEFAULT_SEPARATOR - Static variable in class org.apache.commons.math3.geometry.VectorFormat
The default separator: ", ".
DEFAULT_SERIES_PARAMETER - Static variable in class org.jfree.chart.urls.StandardXYURLGenerator
The default series parameter.
DEFAULT_SHAPE - Static variable in class org.jfree.chart.renderer.AbstractRenderer
The default shape.
DEFAULT_SHAPE_SEQUENCE - Static variable in class org.jfree.chart.plot.DefaultDrawingSupplier
The default shape sequence.
DEFAULT_SLICE_SEPARATOR - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The default string separating any two slices from another; currently "\n\n".
DEFAULT_START_ANGLE - Static variable in class org.jfree.chart.plot.PiePlot
The default starting angle for the pie chart.
DEFAULT_START_ANGLE - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The default starting angle for the radar chart axes.
DEFAULT_STOPFITNESS - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
Default value for CMAESOptimizer.stopFitness: 0.0.
DEFAULT_STOPPING_RADIUS - Static variable in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
Default value for BOBYQAOptimizer.stoppingTrustRegionRadius: 1.0E-8 .
DEFAULT_STOPPING_RADIUS - Static variable in class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
Deprecated.
Default value for BOBYQAOptimizer.stoppingTrustRegionRadius: 1.0E-8 .
DEFAULT_STROKE - Static variable in class org.jfree.chart.renderer.AbstractRenderer
The default stroke.
DEFAULT_STROKE_SEQUENCE - Static variable in class org.jfree.chart.plot.DefaultDrawingSupplier
The default stroke sequence.
DEFAULT_SUFFIX - Static variable in class org.apache.commons.math3.geometry.VectorFormat
The default suffix: "}".
DEFAULT_TEXT_ANCHOR - Static variable in class org.jfree.chart.annotations.TextAnnotation
The default text anchor.
DEFAULT_TEXT_ANCHOR - Static variable in class org.jfree.chart.annotations.XYTextAnnotation
The default text anchor.
DEFAULT_TEXT_PAINT - Static variable in class org.jfree.chart.title.TextTitle
The default text color.
DEFAULT_TICK_LABEL_FONT - Static variable in class org.jfree.chart.axis.Axis
The default tick label font.
DEFAULT_TICK_LABEL_INSETS - Static variable in class org.jfree.chart.axis.Axis
The default tick label insets.
DEFAULT_TICK_LABEL_PAINT - Static variable in class org.jfree.chart.axis.Axis
The default tick label paint.
DEFAULT_TICK_LABELS_VISIBLE - Static variable in class org.jfree.chart.axis.Axis
The default tick labels visibility.
DEFAULT_TICK_MARK_INSIDE_LENGTH - Static variable in class org.jfree.chart.axis.Axis
The default tick mark inside length.
DEFAULT_TICK_MARK_OUTSIDE_LENGTH - Static variable in class org.jfree.chart.axis.Axis
The default tick mark outside length.
DEFAULT_TICK_MARK_PAINT - Static variable in class org.jfree.chart.axis.Axis
The default tick paint.
DEFAULT_TICK_MARK_STROKE - Static variable in class org.jfree.chart.axis.Axis
The default tick stroke.
DEFAULT_TICK_MARKS_VISIBLE - Static variable in class org.jfree.chart.axis.Axis
The default tick marks visible.
DEFAULT_TICK_UNIT - Static variable in class org.jfree.chart.axis.NumberAxis
The default tick unit.
DEFAULT_TIES_STRATEGY - Static variable in class org.apache.commons.math3.stat.ranking.NaturalRanking
default ties strategy
DEFAULT_TIME_ZONE - Static variable in class org.jfree.chart.axis.SegmentedTimeline
Deprecated.
As of 1.0.7. When the default time zone is required, just call TimeZone.getDefault().
DEFAULT_TIME_ZONE - Static variable in class org.jfree.data.time.RegularTimePeriod
Deprecated.
As of 1.0.11, we discourage the use of this field - use TimeZone.getDefault() instead.
DEFAULT_TIP_RADIUS - Static variable in class org.jfree.chart.annotations.CategoryPointerAnnotation
The default tip radius (in Java2D units).
DEFAULT_TIP_RADIUS - Static variable in class org.jfree.chart.annotations.XYPointerAnnotation
The default tip radius (in Java2D units).
DEFAULT_TITLE_FONT - Static variable in class org.jfree.chart.JFreeChart
The default font for titles.
DEFAULT_TOOL_TIP_FORMAT - Static variable in class org.jfree.chart.labels.BoxAndWhiskerToolTipGenerator
The default tooltip format string.
DEFAULT_TOOL_TIP_FORMAT - Static variable in class org.jfree.chart.labels.BoxAndWhiskerXYToolTipGenerator
The default tooltip format string.
DEFAULT_TOOL_TIP_FORMAT - Static variable in class org.jfree.chart.labels.StandardXYToolTipGenerator
The default tooltip format.
DEFAULT_TOOL_TIP_FORMAT - Static variable in class org.jfree.chart.labels.StandardXYZToolTipGenerator
The default tooltip format.
DEFAULT_TOOL_TIP_FORMAT_STRING - Static variable in class org.jfree.chart.labels.IntervalCategoryToolTipGenerator
The default format string.
DEFAULT_TOOL_TIP_FORMAT_STRING - Static variable in class org.jfree.chart.labels.StandardCategoryToolTipGenerator
The default format string.
DEFAULT_TOOLTIP_FORMAT - Static variable in class org.jfree.chart.labels.StandardPieToolTipGenerator
The default tooltip format.
DEFAULT_UPPER_BOUND - Static variable in class org.jfree.chart.axis.ValueAxis
Deprecated.
From 1.0.5 onwards, the axis defines a defaultRange attribute (see ValueAxis.getDefaultAutoRange()).
DEFAULT_UPPER_MARGIN - Static variable in class org.jfree.chart.axis.ValueAxis
The default value for the upper margin (0.05 = 5%).
DEFAULT_VALUE_LABEL_FONT - Static variable in class org.jfree.chart.plot.CategoryPlot
The default value label font.
DEFAULT_VALUE_LABEL_FONT - Static variable in class org.jfree.chart.renderer.AbstractRenderer
The default value label font.
DEFAULT_VALUE_LABEL_PAINT - Static variable in class org.jfree.chart.renderer.AbstractRenderer
The default value label paint.
DEFAULT_VERTICAL_ALIGNMENT - Static variable in class org.jfree.chart.title.Title
The default vertical alignment.
DEFAULT_VERTICAL_TICK_LABELS - Static variable in class org.jfree.chart.axis.NumberAxis
The default setting for the vertical tick labels flag.
DEFAULT_WALL_PAINT - Static variable in class org.jfree.chart.renderer.category.BarRenderer3D
The default wall paint.
DEFAULT_WALL_PAINT - Static variable in class org.jfree.chart.renderer.category.LineRenderer3D
The default wall paint.
DEFAULT_WALL_PAINT - Static variable in class org.jfree.chart.renderer.xy.XYLine3DRenderer
The default wall paint.
DEFAULT_WIDTH - Static variable in class org.jfree.chart.ChartPanel
The default panel width.
DEFAULT_X_OFFSET - Static variable in class org.jfree.chart.renderer.category.BarRenderer3D
The default x-offset for the 3D effect.
DEFAULT_X_OFFSET - Static variable in class org.jfree.chart.renderer.category.LineRenderer3D
The default x-offset for the 3D effect.
DEFAULT_X_OFFSET - Static variable in class org.jfree.chart.renderer.xy.XYLine3DRenderer
The default x-offset for the 3D effect.
DEFAULT_Y_OFFSET - Static variable in class org.jfree.chart.renderer.category.BarRenderer3D
The default y-offset for the 3D effect.
DEFAULT_Y_OFFSET - Static variable in class org.jfree.chart.renderer.category.LineRenderer3D
The default y-offset for the 3D effect.
DEFAULT_Y_OFFSET - Static variable in class org.jfree.chart.renderer.xy.XYLine3DRenderer
The default y-offset for the 3D effect.
DEFAULT_ZERO_TOLERANCE - Static variable in class org.apache.commons.math3.linear.OpenMapRealVector
Default Tolerance for having a value considered zero.
DEFAULT_ZOOM_TRIGGER_DISTANCE - Static variable in class org.jfree.chart.ChartPanel
The minimum size required to perform a zoom on a rectangle
DefaultBoxAndWhiskerCategoryDataset - Class in org.jfree.data.statistics
A convenience class that provides a default implementation of the BoxAndWhiskerCategoryDataset interface.
DefaultBoxAndWhiskerCategoryDataset() - Constructor for class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Creates a new dataset.
DefaultBoxAndWhiskerXYDataset - Class in org.jfree.data.statistics
A simple implementation of the BoxAndWhiskerXYDataset interface.
DefaultBoxAndWhiskerXYDataset(Comparable) - Constructor for class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Constructs a new box and whisker dataset.
DefaultCategoryDataset - Class in org.jfree.data.category
A default implementation of the CategoryDataset interface.
DefaultCategoryDataset() - Constructor for class org.jfree.data.category.DefaultCategoryDataset
Creates a new (empty) dataset.
DefaultCategoryItemRenderer - Class in org.jfree.chart.renderer.category
A default renderer for the CategoryPlot class.
DefaultCategoryItemRenderer() - Constructor for class org.jfree.chart.renderer.category.DefaultCategoryItemRenderer
 
DefaultChartEditorFactory - Class in org.jfree.chart.editor
A default implementation of the ChartEditorFactory interface.
DefaultChartEditorFactory() - Constructor for class org.jfree.chart.editor.DefaultChartEditorFactory
Creates a new instance.
DefaultContourDataset - Class in org.jfree.data.contour
Deprecated.
This class is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
DefaultContourDataset() - Constructor for class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Creates a new dataset, initially empty.
DefaultContourDataset(Comparable, Object[], Object[], Object[]) - Constructor for class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Constructs a new dataset with the given data.
DefaultDrawingSupplier - Class in org.jfree.chart.plot
A default implementation of the DrawingSupplier interface.
DefaultDrawingSupplier() - Constructor for class org.jfree.chart.plot.DefaultDrawingSupplier
Creates a new supplier, with default sequences for fill paint, outline paint, stroke and shapes.
DefaultDrawingSupplier(Paint[], Paint[], Stroke[], Stroke[], Shape[]) - Constructor for class org.jfree.chart.plot.DefaultDrawingSupplier
Creates a new supplier.
DefaultDrawingSupplier(Paint[], Paint[], Paint[], Stroke[], Stroke[], Shape[]) - Constructor for class org.jfree.chart.plot.DefaultDrawingSupplier
Creates a new supplier.
DefaultFieldMatrixChangingVisitor<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Default implementation of the FieldMatrixChangingVisitor interface.
DefaultFieldMatrixChangingVisitor(T) - Constructor for class org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor
Build a new instance.
DefaultFieldMatrixPreservingVisitor<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Default implementation of the FieldMatrixPreservingVisitor interface.
DefaultFieldMatrixPreservingVisitor(T) - Constructor for class org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor
Build a new instance.
DefaultFileComparator - Class in org.apache.commons.io.comparator
Compare two files using the default File.compareTo(File) method.
DefaultFileComparator() - Constructor for class org.apache.commons.io.comparator.DefaultFileComparator
 
DefaultHeatMapDataset - Class in org.jfree.data.general
A default implementation of the HeatMapDataset interface.
DefaultHeatMapDataset(int, int, double, double, double, double) - Constructor for class org.jfree.data.general.DefaultHeatMapDataset
Creates a new dataset where all the z-values are initially 0.
DefaultHighLowDataset - Class in org.jfree.data.xy
A simple implementation of the OHLCDataset interface.
DefaultHighLowDataset(Comparable, Date[], double[], double[], double[], double[], double[]) - Constructor for class org.jfree.data.xy.DefaultHighLowDataset
Constructs a new high/low/open/close dataset.
DefaultIntervalCategoryDataset - Class in org.jfree.data.category
A convenience class that provides a default implementation of the IntervalCategoryDataset interface.
DefaultIntervalCategoryDataset(double[][], double[][]) - Constructor for class org.jfree.data.category.DefaultIntervalCategoryDataset
Creates a new dataset using the specified data values and automatically generated series and category keys.
DefaultIntervalCategoryDataset(Number[][], Number[][]) - Constructor for class org.jfree.data.category.DefaultIntervalCategoryDataset
Constructs a dataset and populates it with data from the array.
DefaultIntervalCategoryDataset(String[], Number[][], Number[][]) - Constructor for class org.jfree.data.category.DefaultIntervalCategoryDataset
Constructs a DefaultIntervalCategoryDataset, populates it with data from the arrays, and uses the supplied names for the series.
DefaultIntervalCategoryDataset(Comparable[], Comparable[], Number[][], Number[][]) - Constructor for class org.jfree.data.category.DefaultIntervalCategoryDataset
Constructs a DefaultIntervalCategoryDataset, populates it with data from the arrays, and uses the supplied names for the series and the supplied objects for the categories.
DefaultIntervalXYDataset - Class in org.jfree.data.xy
A dataset that defines a range (interval) for both the x-values and the y-values.
DefaultIntervalXYDataset() - Constructor for class org.jfree.data.xy.DefaultIntervalXYDataset
Creates a new DefaultIntervalXYDataset instance, initially containing no data.
DefaultIterativeLinearSolverEvent - Class in org.apache.commons.math3.linear
A default concrete implementation of the abstract class IterativeLinearSolverEvent.
DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, RealVector, double) - Constructor for class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Creates a new instance of this class.
DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, double) - Constructor for class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Creates a new instance of this class.
DefaultKeyedValue - Class in org.jfree.data
A (key, value) pair.
DefaultKeyedValue(Comparable, Number) - Constructor for class org.jfree.data.DefaultKeyedValue
Creates a new (key, value) item.
DefaultKeyedValueDataset - Class in org.jfree.data.general
A default implementation of the KeyedValueDataset interface.
DefaultKeyedValueDataset() - Constructor for class org.jfree.data.general.DefaultKeyedValueDataset
Constructs a new dataset, initially empty.
DefaultKeyedValueDataset(Comparable, Number) - Constructor for class org.jfree.data.general.DefaultKeyedValueDataset
Creates a new dataset with the specified initial value.
DefaultKeyedValueDataset(KeyedValue) - Constructor for class org.jfree.data.general.DefaultKeyedValueDataset
Creates a new dataset that uses the data from a KeyedValue instance.
DefaultKeyedValues - Class in org.jfree.data
An ordered list of (key, value) items.
DefaultKeyedValues() - Constructor for class org.jfree.data.DefaultKeyedValues
Creates a new collection (initially empty).
DefaultKeyedValues2D - Class in org.jfree.data
A data structure that stores zero, one or many values, where each value is associated with two keys (a 'row' key and a 'column' key).
DefaultKeyedValues2D() - Constructor for class org.jfree.data.DefaultKeyedValues2D
Creates a new instance (initially empty).
DefaultKeyedValues2D(boolean) - Constructor for class org.jfree.data.DefaultKeyedValues2D
Creates a new instance (initially empty).
DefaultKeyedValues2DDataset - Class in org.jfree.data.general
A default implementation of the KeyedValues2DDataset interface.
DefaultKeyedValues2DDataset() - Constructor for class org.jfree.data.general.DefaultKeyedValues2DDataset
 
DefaultKeyedValuesDataset - Class in org.jfree.data.general
A default implementation of the KeyedValuesDataset interface.
DefaultKeyedValuesDataset() - Constructor for class org.jfree.data.general.DefaultKeyedValuesDataset
 
DefaultLogAxisEditor - Class in org.jfree.chart.editor
A panel for editing properties of a LogAxis.
DefaultLogAxisEditor(LogAxis) - Constructor for class org.jfree.chart.editor.DefaultLogAxisEditor
Standard constructor: builds a property panel for the specified axis.
DefaultMeasurementModel - Class in org.apache.commons.math3.filter
Default implementation of a MeasurementModel for the use with a KalmanFilter.
DefaultMeasurementModel(double[][], double[][]) - Constructor for class org.apache.commons.math3.filter.DefaultMeasurementModel
Create a new MeasurementModel, taking double arrays as input parameters for the respective measurement matrix and noise.
DefaultMeasurementModel(RealMatrix, RealMatrix) - Constructor for class org.apache.commons.math3.filter.DefaultMeasurementModel
Create a new MeasurementModel, taking RealMatrix objects as input parameters for the respective measurement matrix and noise.
DefaultMultiValueCategoryDataset - Class in org.jfree.data.statistics
A category dataset that defines multiple values for each item.
DefaultMultiValueCategoryDataset() - Constructor for class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Creates a new dataset.
DefaultOHLCDataset - Class in org.jfree.data.xy
A simple implementation of the OHLCDataset interface.
DefaultOHLCDataset(Comparable, OHLCDataItem[]) - Constructor for class org.jfree.data.xy.DefaultOHLCDataset
Creates a new dataset.
DefaultParticlePropertyProvider - Class in hep.physics.particle.properties
Default table of particle properties used by ParticlePropertyProvider.
DefaultPieDataset - Class in org.jfree.data.general
A default implementation of the PieDataset interface.
DefaultPieDataset() - Constructor for class org.jfree.data.general.DefaultPieDataset
Constructs a new dataset, initially empty.
DefaultPieDataset(KeyedValues) - Constructor for class org.jfree.data.general.DefaultPieDataset
Creates a new dataset by copying data from a KeyedValues instance.
DefaultPolarItemRenderer - Class in org.jfree.chart.renderer
A renderer that can be used with the PolarPlot class.
DefaultPolarItemRenderer() - Constructor for class org.jfree.chart.renderer.DefaultPolarItemRenderer
Creates a new instance of DefaultPolarItemRenderer
DefaultPolarPlotEditor - Class in org.jfree.chart.editor
A panel for editing the properties of a PolarPlot.
DefaultPolarPlotEditor(PolarPlot) - Constructor for class org.jfree.chart.editor.DefaultPolarPlotEditor
Standard constructor - constructs a panel for editing the properties of the specified plot.
DefaultProcessModel - Class in org.apache.commons.math3.filter
Default implementation of a ProcessModel for the use with a KalmanFilter.
DefaultProcessModel(double[][], double[][], double[][], double[], double[][]) - Constructor for class org.apache.commons.math3.filter.DefaultProcessModel
Create a new ProcessModel, taking double arrays as input parameters.
DefaultProcessModel(double[][], double[][], double[][]) - Constructor for class org.apache.commons.math3.filter.DefaultProcessModel
Create a new ProcessModel, taking double arrays as input parameters.
DefaultProcessModel(RealMatrix, RealMatrix, RealMatrix, RealVector, RealMatrix) - Constructor for class org.apache.commons.math3.filter.DefaultProcessModel
Create a new ProcessModel, taking double arrays as input parameters.
DefaultRealMatrixChangingVisitor - Class in org.apache.commons.math3.linear
Default implementation of the RealMatrixChangingVisitor interface.
DefaultRealMatrixChangingVisitor() - Constructor for class org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor
 
DefaultRealMatrixPreservingVisitor - Class in org.apache.commons.math3.linear
Default implementation of the RealMatrixPreservingVisitor interface.
DefaultRealMatrixPreservingVisitor() - Constructor for class org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor
 
DefaultShadowGenerator - Class in org.jfree.chart.util
A default implementation of the ShadowGenerator interface, based on code in a blog post by Romain Guy.
DefaultShadowGenerator() - Constructor for class org.jfree.chart.util.DefaultShadowGenerator
Creates a new instance with default attributes.
DefaultShadowGenerator(int, Color, float, int, double) - Constructor for class org.jfree.chart.util.DefaultShadowGenerator
Creates a new instance with the specified attributes.
DefaultStatisticalCategoryDataset - Class in org.jfree.data.statistics
A convenience class that provides a default implementation of the StatisticalCategoryDataset interface.
DefaultStatisticalCategoryDataset() - Constructor for class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Creates a new dataset.
DefaultTableXYDataset - Class in org.jfree.data.xy
An XYDataset where every series shares the same x-values (required for generating stacked area charts).
DefaultTableXYDataset() - Constructor for class org.jfree.data.xy.DefaultTableXYDataset
Creates a new empty dataset.
DefaultTableXYDataset(boolean) - Constructor for class org.jfree.data.xy.DefaultTableXYDataset
Creates a new empty dataset.
DefaultTransformer - Class in org.apache.commons.math3.util
A Default NumberTransformer for java.lang.Numbers and Numeric Strings.
DefaultTransformer() - Constructor for class org.apache.commons.math3.util.DefaultTransformer
 
defaultValue(Value) - Method in class root.TLeafFolderColumn
 
DefaultValueDataset - Class in org.jfree.data.general
A dataset that stores a single value (that is possibly null).
DefaultValueDataset() - Constructor for class org.jfree.data.general.DefaultValueDataset
Constructs a new dataset, initially empty.
DefaultValueDataset(double) - Constructor for class org.jfree.data.general.DefaultValueDataset
Creates a new dataset with the specified value.
DefaultValueDataset(Number) - Constructor for class org.jfree.data.general.DefaultValueDataset
Creates a new dataset with the specified value.
DefaultWindDataset - Class in org.jfree.data.xy
A default implementation of the WindDataset interface.
DefaultWindDataset() - Constructor for class org.jfree.data.xy.DefaultWindDataset
Constructs a new, empty, dataset.
DefaultWindDataset(Object[][][]) - Constructor for class org.jfree.data.xy.DefaultWindDataset
Constructs a dataset based on the specified data array.
DefaultWindDataset(String[], Object[][][]) - Constructor for class org.jfree.data.xy.DefaultWindDataset
Constructs a dataset based on the specified data array.
DefaultWindDataset(List, Object[][][]) - Constructor for class org.jfree.data.xy.DefaultWindDataset
Constructs a dataset based on the specified data array.
DefaultXYDataset - Class in org.jfree.data.xy
A default implementation of the XYDataset interface that stores data values in arrays of double primitives.
DefaultXYDataset() - Constructor for class org.jfree.data.xy.DefaultXYDataset
Creates a new DefaultXYDataset instance, initially containing no data.
DefaultXYItemRenderer - Class in org.jfree.chart.renderer.xy
A default renderer for the XYPlot class.
DefaultXYItemRenderer() - Constructor for class org.jfree.chart.renderer.xy.DefaultXYItemRenderer
 
DefaultXYZDataset - Class in org.jfree.data.xy
A default implementation of the XYZDataset interface that stores data values in arrays of double primitives.
DefaultXYZDataset() - Constructor for class org.jfree.data.xy.DefaultXYZDataset
Creates a new DefaultXYZDataset instance, initially containing no data.
DeferredFileOutputStream - Class in org.apache.commons.io.output
An output stream which will retain data in memory until a specified threshold is reached, and only then commit it to disk.
DeferredFileOutputStream(int, File) - Constructor for class org.apache.commons.io.output.DeferredFileOutputStream
Constructs an instance of this class which will trigger an event at the specified threshold, and save data to a file beyond that point.
DeferredFileOutputStream(int, int, File) - Constructor for class org.apache.commons.io.output.DeferredFileOutputStream
Constructs an instance of this class which will trigger an event at the specified threshold, and save data to a file beyond that point.
DeferredFileOutputStream(int, String, String, File) - Constructor for class org.apache.commons.io.output.DeferredFileOutputStream
Constructs an instance of this class which will trigger an event at the specified threshold, and save data to a temporary file beyond that point.
DeferredFileOutputStream(int, int, String, String, File) - Constructor for class org.apache.commons.io.output.DeferredFileOutputStream
Constructs an instance of this class which will trigger an event at the specified threshold, and save data to a temporary file beyond that point.
Define - Class in org.lsmp.djep.xjep.function
Allows functions to be defined in equations.
Define(XJep) - Constructor for class org.lsmp.djep.xjep.function.Define
 
DEFINITION_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.F1D
 
DEFINITION_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.F2D
 
DEFINITION_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.FND
 
DEFINITION_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.FPR
 
deg - Static variable in class cern.clhep.Units
 
degree - Static variable in class cern.clhep.Units
 
degree() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Returns the degree of the polynomial.
degree() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns the degree of the polynomial.
degree() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Returns the degree of the polynomial.
DelegateFileFilter - Class in org.apache.commons.io.filefilter
This class turns a Java FileFilter or FilenameFilter into an IO FileFilter.
DelegateFileFilter(FilenameFilter) - Constructor for class org.apache.commons.io.filefilter.DelegateFileFilter
Constructs a delegate file filter around an existing FilenameFilter.
DelegateFileFilter(FileFilter) - Constructor for class org.apache.commons.io.filefilter.DelegateFileFilter
Constructs a delegate file filter around an existing FileFilter.
delete(boolean) - Method in class cern.colt.list.AbstractBooleanList
Deletes the first element from the receiver that is identical to the specified element.
delete(byte) - Method in class cern.colt.list.AbstractByteList
Deletes the first element from the receiver that is identical to the specified element.
delete(char) - Method in class cern.colt.list.AbstractCharList
Deletes the first element from the receiver that is identical to the specified element.
delete(double) - Method in class cern.colt.list.AbstractDoubleList
Deletes the first element from the receiver that is identical to the specified element.
delete(float) - Method in class cern.colt.list.AbstractFloatList
Deletes the first element from the receiver that is identical to the specified element.
delete(int) - Method in class cern.colt.list.AbstractIntList
Deletes the first element from the receiver that is identical to the specified element.
delete(long) - Method in class cern.colt.list.AbstractLongList
Deletes the first element from the receiver that is identical to the specified element.
delete(short) - Method in class cern.colt.list.AbstractShortList
Deletes the first element from the receiver that is identical to the specified element.
delete(Object, boolean) - Method in class cern.colt.list.ObjectArrayList
Deletes the first element from the receiver that matches the specified element.
delete(int, int) - Method in class graph.DataSet
Delete data from the data set (start and end are inclusive).
delete(double[], int...) - Static method in class jhplot.math.DoubleArray
Delete a list of elements from an array.
delete(int[], int...) - Static method in class jhplot.math.IntegerArray
 
delete() - Method in class jminhep.algorithms.FuzzyCMeansAlg
Clear
delete() - Method in class jminhep.algorithms.KMeansAlg
Clear
delete(Path) - Static method in class org.apache.commons.io.file.PathUtils
Deletes a file or directory.
delete(Path, DeleteOption...) - Static method in class org.apache.commons.io.file.PathUtils
Deletes a file or directory.
delete(File) - Method in class org.apache.commons.io.FileDeleteStrategy
Deletes the file object, which may be a file or a directory.
delete(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Deprecated.
Delete an element from the tree.
delete() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
Deprecated.
Delete the node from the tree.
delete(int, int) - Method in class org.jfree.data.time.TimePeriodValues
Deletes data from start until end index (end inclusive) and sends a SeriesChangeEvent to all registered listeners.
delete(RegularTimePeriod) - Method in class org.jfree.data.time.TimeSeries
Deletes the data item for the given time period and sends a SeriesChangeEvent to all registered listeners.
delete(int, int) - Method in class org.jfree.data.time.TimeSeries
Deletes data from start until end index (end inclusive).
delete(int, int, boolean) - Method in class org.jfree.data.time.TimeSeries
Deletes data from start until end index (end inclusive).
delete(int, int) - Method in class org.jfree.data.xy.XYSeries
Deletes a range of items from the series and sends a SeriesChangeEvent to all registered listeners.
deleteColumns(double[][], int...) - Static method in class jhplot.math.DoubleArray
Deletes a list of columns from a matrix.
deleteColumns(int[][], int...) - Static method in class jhplot.math.IntegerArray
 
deleteColumnsRange(double[][], int, int) - Static method in class jhplot.math.DoubleArray
Deletes a range of columns from a matrix.
deleteColumnsRange(int[][], int, int) - Static method in class jhplot.math.IntegerArray
 
deleteContours() - Method in class graph.Contour
Delete all the Contours
deleteData() - Method in class graph.DataSet
Delete all the data from the data set.
deleteDir(File) - Static method in class jhepsim.Util
Deletes all files and subdirectories under dir.
deleteDir(File) - Static method in class jhplot.utils.Util
Deletes all files and subdirectories under dir.
deleteDir(File) - Static method in class jminhep.utils.Util
Deletes all files and subdirectories under dir.
deleteDirectory(Path) - Static method in class org.apache.commons.io.file.PathUtils
Deletes a directory including sub-directories.
deleteDirectory(Path, DeleteOption...) - Static method in class org.apache.commons.io.file.PathUtils
Deletes a directory including sub-directories.
deleteDirectory(File) - Static method in class org.apache.commons.io.FileUtils
Deletes a directory recursively.
deleteFile(Path) - Static method in class org.apache.commons.io.file.PathUtils
Deletes the given file.
deleteFile(Path, DeleteOption...) - Static method in class org.apache.commons.io.file.PathUtils
Deletes the given file.
deleteLink(Neuron, Neuron) - Method in class org.apache.commons.math3.ml.neuralnet.Network
Deletes the link between neurons a and b.
DeleteMarker(int) - Method in class graph.Markers
Delete the marker with the given index.
deleteNeuron(Neuron) - Method in class org.apache.commons.math3.ml.neuralnet.Network
Deletes a neuron.
deleteObserver(Observer) - Method in class org.nfunk.jep.SymbolTable
 
deleteObservers() - Method in class org.nfunk.jep.SymbolTable
 
DeleteOption - Interface in org.apache.commons.io.file
An object that configures how to delete a file.
deleteQuietly(File) - Method in class org.apache.commons.io.FileDeleteStrategy
Deletes the file object, which may be a file or a directory.
deleteQuietly(File) - Static method in class org.apache.commons.io.FileUtils
Deletes a file, never throwing an exception.
deleteRange(double[], int, int) - Static method in class jhplot.math.DoubleArray
Delete a range of elements from an array.
deleteRange(int[], int, int) - Static method in class jhplot.math.IntegerArray
 
deleteRecord(String) - Method in class jhplot.io.db.BaseRecordsFile
Deletes a record.
deleteRows(double[][], int...) - Static method in class jhplot.math.DoubleArray
Deletes a list of rows from a matrix.
deleteRows(int[][], int...) - Static method in class jhplot.math.IntegerArray
 
deleteRowsRange(double[][], int, int) - Static method in class jhplot.math.DoubleArray
Deletes a range of rows from a matrix.
deleteRowsRange(int[][], int, int) - Static method in class jhplot.math.IntegerArray
 
DeletingPathVisitor - Class in org.apache.commons.io.file
Deletes files and directories as a visit proceeds.
DeletingPathVisitor(Counters.PathCounters, DeleteOption[], String...) - Constructor for class org.apache.commons.io.file.DeletingPathVisitor
Constructs a new visitor that deletes files except for the files and directories explicitly given.
DeletingPathVisitor(Counters.PathCounters, String...) - Constructor for class org.apache.commons.io.file.DeletingPathVisitor
Constructs a new visitor that deletes files except for the files and directories explicitly given.
DELTAETA_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.BLJets
 
DELTAETA_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.GenJets
 
DELTAETA_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Jets
 
DELTAPHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.BLJets
 
DELTAPHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.GenJets
 
DELTAPHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Jets
 
demo1() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo1() - Static method in class cern.colt.matrix.doublealgo.Statistic
Demonstrates usage of this class.
demo1() - Method in class cern.colt.matrix.DoubleFactory2D
Demonstrates usage of this class.
demo1() - Static method in class cern.colt.matrix.impl.AbstractFormatter
Demonstrates how to use this class.
demo1() - Static method in class cern.jet.math.Functions
Demonstrates usage of this class.
demo1() - Static method in class cern.jet.random.Benchmark
Prints the first size random numbers generated by the distribution.
demo2() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo2(int, int, boolean) - Static method in class cern.colt.matrix.doublealgo.Statistic
Demonstrates usage of this class.
demo2() - Method in class cern.colt.matrix.DoubleFactory2D
Demonstrates usage of this class.
demo2() - Static method in class cern.colt.matrix.impl.AbstractFormatter
Demonstrates how to use this class.
demo2(int) - Static method in class cern.jet.math.Functions
Benchmarks and demonstrates usage of trivial and complex functions.
demo3(int, double) - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo3(Statistic.VectorVectorFunction) - Static method in class cern.colt.matrix.doublealgo.Statistic
Demonstrates usage of this class.
demo3(int, Object) - Static method in class cern.colt.matrix.impl.AbstractFormatter
Demonstrates how to use this class.
demo4() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo5() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo6() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo7() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
DemuxInputStream - Class in org.apache.commons.io.input
Data written to this stream is forwarded to a stream that has been associated with this thread.
DemuxInputStream() - Constructor for class org.apache.commons.io.input.DemuxInputStream
 
DemuxOutputStream - Class in org.apache.commons.io.output
Forwards data to a stream that has been associated with this thread.
DemuxOutputStream() - Constructor for class org.apache.commons.io.output.DemuxOutputStream
 
dense - Static variable in class cern.colt.matrix.DoubleFactory1D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.DoubleFactory2D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.DoubleFactory3D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.ObjectFactory1D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.ObjectFactory2D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.ObjectFactory3D
A factory producing dense matrices.
DenseDoubleMatrix1D - Class in cern.colt.matrix.impl
Dense 1-d matrix (aka vector) holding double elements.
DenseDoubleMatrix1D(double[]) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix1D
Constructs a matrix with a copy of the given values.
DenseDoubleMatrix1D(int) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix1D
Constructs a matrix with a given number of cells.
DenseDoubleMatrix2D - Class in cern.colt.matrix.impl
Dense 2-d matrix holding double elements.
DenseDoubleMatrix2D(double[][]) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix2D
Constructs a matrix with a copy of the given values.
DenseDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseDoubleMatrix3D - Class in cern.colt.matrix.impl
Dense 3-d matrix holding double elements.
DenseDoubleMatrix3D(double[][][]) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix3D
Constructs a matrix with a copy of the given values.
DenseDoubleMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix3D
Constructs a matrix with a given number of slices, rows and columns.
DenseObjectMatrix1D - Class in cern.colt.matrix.impl
Dense 1-d matrix (aka vector) holding Object elements.
DenseObjectMatrix1D(Object[]) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix1D
Constructs a matrix with a copy of the given values.
DenseObjectMatrix1D(int) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix1D
Constructs a matrix with a given number of cells.
DenseObjectMatrix2D - Class in cern.colt.matrix.impl
Dense 2-d matrix holding Object elements.
DenseObjectMatrix2D(Object[][]) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix2D
Constructs a matrix with a copy of the given values.
DenseObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseObjectMatrix3D - Class in cern.colt.matrix.impl
Dense 3-d matrix holding Object elements.
DenseObjectMatrix3D(Object[][][]) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix3D
Constructs a matrix with a copy of the given values.
DenseObjectMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix3D
Constructs a matrix with a given number of slices, rows and columns.
density(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Returns the matrix's fraction of non-zero cells; A.cardinality() / A.size().
density(double) - Method in class org.apache.commons.math3.distribution.BetaDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
density(double) - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.FDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.GammaDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.GumbelDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.LevyDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.LogisticDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double[]) - Method in class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double[]) - Method in class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double[]) - Method in interface org.apache.commons.math3.distribution.MultivariateRealDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.NakagamiDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.TDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
derivative() - Method in class jhplot.P1D
Calculate derivative for X-Y data points.
derivative() - Method in interface org.apache.commons.math3.analysis.DifferentiableUnivariateFunction
Deprecated.
Returns the derivative of the function
derivative() - Method in interface org.apache.commons.math3.analysis.DifferentiableUnivariateMatrixFunction
Deprecated.
Returns the derivative of the function
derivative() - Method in interface org.apache.commons.math3.analysis.DifferentiableUnivariateVectorFunction
Deprecated.
Returns the derivative of the function
derivative() - Method in class org.apache.commons.math3.analysis.function.Acos
Deprecated.
as of 3.1, replaced by Acos.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Acosh
Deprecated.
as of 3.1, replaced by Acosh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Asin
Deprecated.
as of 3.1, replaced by Asin.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Asinh
Deprecated.
as of 3.1, replaced by Asinh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Atan
Deprecated.
as of 3.1, replaced by Atan.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Atanh
Deprecated.
as of 3.1, replaced by Atanh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Cbrt
Deprecated.
as of 3.1, replaced by Cbrt.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Constant
Deprecated.
derivative() - Method in class org.apache.commons.math3.analysis.function.Cos
Deprecated.
as of 3.1, replaced by Cos.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Cosh
Deprecated.
as of 3.1, replaced by Cosh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Exp
Deprecated.
as of 3.1, replaced by Exp.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Expm1
Deprecated.
as of 3.1, replaced by Expm1.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Gaussian
Deprecated.
derivative() - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator
Deprecated.
derivative() - Method in class org.apache.commons.math3.analysis.function.Identity
Deprecated.
derivative() - Method in class org.apache.commons.math3.analysis.function.Inverse
Deprecated.
as of 3.1, replaced by Inverse.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Log
Deprecated.
as of 3.1, replaced by Log.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Log10
Deprecated.
as of 3.1, replaced by Log10.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Log1p
Deprecated.
as of 3.1, replaced by Log1p.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Logistic
Deprecated.
derivative() - Method in class org.apache.commons.math3.analysis.function.Logit
Deprecated.
as of 3.1, replaced by Logit.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Minus
Deprecated.
as of 3.1, replaced by Minus.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Power
Deprecated.
as of 3.1, replaced by Power.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Sigmoid
Deprecated.
as of 3.1, replaced by Sigmoid.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Sin
Deprecated.
as of 3.1, replaced by Sin.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Sinc
Deprecated.
as of 3.1, replaced by Sinc.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Sinh
Deprecated.
as of 3.1, replaced by Sinh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Sqrt
Deprecated.
as of 3.1, replaced by Sqrt.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Tan
Deprecated.
as of 3.1, replaced by Tan.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Tanh
Deprecated.
as of 3.1, replaced by Tanh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Returns the derivative as a UnivariateFunction.
derivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Get the derivative of the polynomial spline function.
derivatives(T, int) - Method in class org.apache.commons.math3.analysis.interpolation.FieldHermiteInterpolator
Interpolate value and first derivatives at a specified abscissa.
DerivativeStructure - Class in org.apache.commons.math3.analysis.differentiation
Class representing both the value and the differentials of a function.
DerivativeStructure(int, int) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Build an instance with all values and derivatives set to 0.
DerivativeStructure(int, int, double) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Build an instance representing a constant value.
DerivativeStructure(int, int, int, double) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Build an instance representing a variable.
DerivativeStructure(double, DerivativeStructure, double, DerivativeStructure) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Linear combination constructor.
DerivativeStructure(double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Linear combination constructor.
DerivativeStructure(double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Linear combination constructor.
DerivativeStructure(int, int, double...) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Build an instance from all its derivatives.
descending(int) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with cells having descending values.
descending(int, int) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with cells having descending values.
descending(int, int, int) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with cells having descending values.
DESCENDING - Static variable in class org.jfree.data.DomainOrder
Descending order.
Description - Static variable in class jminhep.clcontrol.Global
 
description() - Method in class root.RootStoreFactory
 
description() - Method in class root.XrootdStoreFactory
 
DESCRIPTION_FIELD_NUMBER - Static variable in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
DESCRIPTION_FIELD_NUMBER - Static variable in class promc.io.ProMCDescriptionFile.ProMCDescription
 
DESCRIPTION_FIELD_NUMBER - Static variable in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
DESCRIPTION_FIELD_NUMBER - Static variable in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
Descriptive - Class in cern.jet.stat
Basic descriptive statistics.
DescriptiveStatistics - Class in org.apache.commons.math3.stat.descriptive
Maintains a dataset of values of a single variable and computes descriptive statistics based on stored data.
DescriptiveStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Construct a DescriptiveStatistics instance with an infinite window
DescriptiveStatistics(int) - Constructor for class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Construct a DescriptiveStatistics instance with the specified window
DescriptiveStatistics(double[]) - Constructor for class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Construct a DescriptiveStatistics instance with an infinite window and the initial data values in double[] initialDoubleArray.
DescriptiveStatistics(DescriptiveStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Copy constructor.
DESCRIPTOR_GRXY_XY - Static variable in class org.jlab.groot.tree.DatasetDescriptor
 
DESCRIPTOR_GRXY_XY_EX_EY - Static variable in class org.jlab.groot.tree.DatasetDescriptor
 
DESCRIPTOR_GRXY_XY_EY - Static variable in class org.jlab.groot.tree.DatasetDescriptor
 
DESCRIPTOR_H1 - Static variable in class org.jlab.groot.tree.DatasetDescriptor
 
DESCRIPTOR_H2 - Static variable in class org.jlab.groot.tree.DatasetDescriptor
 
DescriptorPanel - Class in org.jlab.groot.ui
 
DescriptorPanel(Tree, TreeAnalyzer, DatasetDescriptor) - Constructor for class org.jlab.groot.ui.DescriptorPanel
 
DescriptorPanel(Tree, TreeAnalyzer, int) - Constructor for class org.jlab.groot.ui.DescriptorPanel
 
DescriptorPanel(Tree, TreeAnalyzer) - Constructor for class org.jlab.groot.ui.DescriptorPanel
 
deserializeAttributes(Map<Integer, HipoNode>) - Static method in class org.jlab.groot.data.DataSetSerializer
 
deserializeDataAttributes(HipoNode) - Static method in class org.jlab.groot.data.DataSetSerializer
 
deserializeDataGroupDescriptor(HipoEvent) - Static method in class org.jlab.groot.data.DataSetSerializer
 
deserializeDataSet(HipoEvent) - Static method in class org.jlab.groot.data.DataSetSerializer
 
deserializeF1D(HipoEvent) - Static method in class org.jlab.groot.data.DataSetSerializer
 
deserializeGraphErrors(HipoEvent) - Static method in class org.jlab.groot.data.DataSetSerializer
 
deserializeH1F(HipoEvent) - Static method in class org.jlab.groot.data.DataSetSerializer
 
deserializeH2F(HipoEvent) - Static method in class org.jlab.groot.data.DataSetSerializer
 
deserializeRealMatrix(Object, String, ObjectInputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Deserialize a RealMatrix field in a class.
deserializeRealVector(Object, String, ObjectInputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Deserialize a RealVector field in a class.
destroy() - Method in class jhplot.HChart
Remove the canvas frame
destroy() - Method in class jhplot.HPlot3DP
Destroy the canvas frame
destroy() - Method in class org.apache.commons.io.monitor.FileAlterationObserver
Final processing.
destroyImage() - Method in class jplot3d.JSurface
Destroys the internal image.
det(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the determinant of matrix A.
det() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns the determinant, det(A).
det() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns the determinant, det(A).
det() - Method in class hep.physics.matrix.BasicMatrix
 
det(Matrix) - Static method in class hep.physics.matrix.MatrixOp
 
det() - Method in class hep.physics.matrix.SymmetricMatrix
 
det() - Method in class hep.physics.vec.BasicHep3Matrix
Returns the determinent of the matrix.
det() - Method in interface hep.physics.vec.Hep3Matrix
Returns the determinent of the matrix
det() - Method in class hephysics.matrix.BasicMatrix
 
det(Matrix) - Static method in class hephysics.matrix.MatrixOp
 
det() - Method in class hephysics.matrix.SymmetricMatrix
 
det() - Method in class hephysics.vec.Hep3Matrix
Returns the determinent of the matrix.
det() - Method in class j4np.physics.TransMatrix
 
det() - Method in class Jama.LUDecomposition
Determinant
det() - Method in class Jama.Matrix
Matrix determinant
det() - Method in class jhplot.math.kalman.jama.LUDecomposition
Determinant
det() - Method in class jhplot.math.kalman.jama.Matrix
Matrix determinant
det(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
det() - Method in class jhplot.math.LUDecomposition
Determinant
det(Object[][]) - Method in class org.lsmp.djep.vectorJep.function.Determinant
Calculates the determinant of an array Uses the fact that | a b c | | d e f | = a | e f | - b | d f | + c | d e | | g h i | | h i | | g i | | g i |
detachAll() - Method in class graph.Axis
Detach All attached dataSets.
detachAxes() - Method in class graph.Graph2D
Detach All attached Axes.
detachAxis(Axis) - Method in class graph.Graph2D
Detach a previously attached Axis.
detachContours() - Method in class graph.Contour
Detach contours so that they will not be plotted.
detachDataSet(DataSet) - Method in class graph.Axis
Detach an attached DataSet
detachDataSet(DataSet) - Method in class graph.Graph2D
Detach the DataSet from the class.
detachDataSets() - Method in class graph.Graph2D
Detach All the DataSets from the class.
Determinant - Class in org.lsmp.djep.vectorJep.function
Calculate the Determinant of a matrix det([[1,2],[3,4]]) -> 1*4-2*3 = -2
Determinant() - Constructor for class org.lsmp.djep.vectorJep.function.Determinant
 
DeviationRenderer - Class in org.jfree.chart.renderer.xy
A specialised subclass of the XYLineAndShapeRenderer that requires an IntervalXYDataset and represents the y-interval by shading an area behind the y-values on the chart.
DeviationRenderer() - Constructor for class org.jfree.chart.renderer.xy.DeviationRenderer
Creates a new renderer that displays lines and shapes for the data items, as well as the shaded area for the y-interval.
DeviationRenderer(boolean, boolean) - Constructor for class org.jfree.chart.renderer.xy.DeviationRenderer
Creates a new renderer.
DeviationRenderer.State - Class in org.jfree.chart.renderer.xy
A state object that is passed to each call to drawItem.
Dfp - Class in org.apache.commons.math3.dfp
Decimal floating point library for Java
Dfp(Dfp) - Constructor for class org.apache.commons.math3.dfp.Dfp
Copy constructor.
DfpDec - Class in org.apache.commons.math3.dfp
Subclass of Dfp which hides the radix-10000 artifacts of the superclass.
DfpDec(Dfp) - Constructor for class org.apache.commons.math3.dfp.DfpDec
Copy constructor.
DfpField - Class in org.apache.commons.math3.dfp
Field for Decimal floating point instances.
DfpField(int) - Constructor for class org.apache.commons.math3.dfp.DfpField
Create a factory for the specified number of radix digits.
DfpField.RoundingMode - Enum in org.apache.commons.math3.dfp
Enumerate for rounding modes.
DfpMath - Class in org.apache.commons.math3.dfp
Mathematical routines for use with Dfp.
DftNormalization - Enum in org.apache.commons.math3.transform
This enumeration defines the various types of normalizations that can be applied to discrete Fourier transforms (DFT).
dgemm(boolean, boolean, double, DoubleMatrix2D, DoubleMatrix2D, double, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Generalized linear algebraic matrix-matrix multiply; C = alpha*A*B + beta*C.
dgemm(boolean, boolean, double, DoubleMatrix2D, DoubleMatrix2D, double, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dgemm(boolean, boolean, double, DoubleMatrix2D, DoubleMatrix2D, double, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dgemv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Generalized linear algebraic matrix-vector multiply; y = alpha*A*x + beta*y.
dgemv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dgemv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dger(double, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Performs a rank 1 update; A = A + alpha*x*y'.
dger(double, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dger(double, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
DiagnosticEventGenerator - Class in hep.physics.event.generator.diagnostic
Generates user specified particle type events with user specified ranges.
DiagnosticEventGenerator() - Constructor for class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Create a diagnostic event generator with default particle property provider and object factory.
DiagnosticEventGenerator(ParticlePropertyProvider) - Constructor for class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Create a diagnostic event generator with the default object factory.
DiagnosticEventGenerator(ParticlePropertyProvider, GeneratorFactory) - Constructor for class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Create a diagnostic event generator with user supplied particle property provider and object factory.
DiagnosticEventGenerator(ParticlePropertyProvider, GeneratorFactory, Random) - Constructor for class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Create a diagnostic event generator with user supplied particle property provider and object factory.
diagonal(DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a new vector consisting of the diagonal elements of A.
diagonal(ObjectMatrix1D) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a new vector consisting of the diagonal elements of A.
diagonal(int) - Method in class hep.physics.matrix.SymmetricMatrix
Returns the diagonal element for the given row/column
diagonal(int) - Method in class hephysics.matrix.SymmetricMatrix
Returns the diagonal element for the given row/column
diagonal(int, double) - Static method in class jhplot.math.DoubleArray
Returns an m x m matrix.
diagonal(double...) - Static method in class jhplot.math.DoubleArray
Returns an m x m matrix.
Diagonal - Class in org.lsmp.djep.vectorJep.function
Creates a diagonal matrix, with a given vector as diagonals elements.
Diagonal() - Constructor for class org.lsmp.djep.vectorJep.function.Diagonal
 
DiagonalMatrix - Class in org.apache.commons.math3.linear
Implementation of a diagonal matrix.
DiagonalMatrix(int) - Constructor for class org.apache.commons.math3.linear.DiagonalMatrix
Creates a matrix with the supplied dimension.
DiagonalMatrix(double[]) - Constructor for class org.apache.commons.math3.linear.DiagonalMatrix
Creates a matrix using the input array as the underlying data.
DiagonalMatrix(double[], boolean) - Constructor for class org.apache.commons.math3.linear.DiagonalMatrix
Creates a matrix using the input array as the underlying data.
DialBackground - Class in org.jfree.chart.plot.dial
A regular dial layer that can be used to draw the background for a dial.
DialBackground() - Constructor for class org.jfree.chart.plot.dial.DialBackground
Creates a new instance of DialBackground.
DialBackground(Paint) - Constructor for class org.jfree.chart.plot.dial.DialBackground
Creates a new instance of DialBackground.
DialCap - Class in org.jfree.chart.plot.dial
A regular dial layer that can be used to draw a cap over the center of the dial (the base of the dial pointer(s)).
DialCap() - Constructor for class org.jfree.chart.plot.dial.DialCap
Creates a new instance of StandardDialBackground.
DialFrame - Interface in org.jfree.chart.plot.dial
A dial frame is the face plate for a dial plot - it is always drawn last.
DialLayer - Interface in org.jfree.chart.plot.dial
A dial layer draws itself within a reference frame.
dialLayerChanged(DialLayerChangeEvent) - Method in interface org.jfree.chart.plot.dial.DialLayerChangeListener
A call-back method for receiving notification of a change to a DialLayer.
dialLayerChanged(DialLayerChangeEvent) - Method in class org.jfree.chart.plot.dial.DialPlot
Receives notification when a layer has changed, and responds by forwarding a PlotChangeEvent to all registered listeners.
DialLayerChangeEvent - Class in org.jfree.chart.plot.dial
An event that can be forwarded to any DialLayerChangeListener to signal a change to a DialLayer.
DialLayerChangeEvent(DialLayer) - Constructor for class org.jfree.chart.plot.dial.DialLayerChangeEvent
Creates a new instance.
DialLayerChangeListener - Interface in org.jfree.chart.plot.dial
The interface via which an object is notified of changes to a DialLayer.
DialPlot - Class in org.jfree.chart.plot.dial
A dial plot composed of user-definable layers.
DialPlot() - Constructor for class org.jfree.chart.plot.dial.DialPlot
Creates a new instance of DialPlot.
DialPlot(ValueDataset) - Constructor for class org.jfree.chart.plot.dial.DialPlot
Creates a new instance of DialPlot.
DialPointer - Class in org.jfree.chart.plot.dial
A base class for the pointer in a DialPlot.
DialPointer.Pin - Class in org.jfree.chart.plot.dial
A dial pointer that draws a thin line (like a pin).
DialPointer.Pointer - Class in org.jfree.chart.plot.dial
A dial pointer.
DialScale - Interface in org.jfree.chart.plot.dial
A dial scale is a specialised layer that has the ability to convert data values into angles.
DialShape - Class in org.jfree.chart.plot
Used to indicate the background shape for a MeterPlot.
DialTextAnnotation - Class in org.jfree.chart.plot.dial
A text annotation for a DialPlot.
DialTextAnnotation(String) - Constructor for class org.jfree.chart.plot.dial.DialTextAnnotation
Creates a new instance of DialTextAnnotation.
DialValueIndicator - Class in org.jfree.chart.plot.dial
A value indicator for a DialPlot.
DialValueIndicator() - Constructor for class org.jfree.chart.plot.dial.DialValueIndicator
Creates a new instance of DialValueIndicator.
DialValueIndicator(int) - Constructor for class org.jfree.chart.plot.dial.DialValueIndicator
Creates a new instance of DialValueIndicator.
diff(String) - Method in class jhplot.FND
differentiate the expression and simplify
Diff - Class in org.lsmp.djep.djep
The diff(f,x) operator.
Diff() - Constructor for class org.lsmp.djep.djep.Diff
 
difference(Region<S>, Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Compute the difference of two regions.
DifferentiableMultivariateFunction - Interface in org.apache.commons.math3.analysis
Deprecated.
DifferentiableMultivariateMultiStartOptimizer - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
DifferentiableMultivariateMultiStartOptimizer(DifferentiableMultivariateOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.DifferentiableMultivariateMultiStartOptimizer
Deprecated.
Create a multi-start optimizer from a single-start optimizer.
DifferentiableMultivariateOptimizer - Interface in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
DifferentiableMultivariateVectorFunction - Interface in org.apache.commons.math3.analysis
Deprecated.
DifferentiableMultivariateVectorMultiStartOptimizer - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
DifferentiableMultivariateVectorMultiStartOptimizer(DifferentiableMultivariateVectorOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.DifferentiableMultivariateVectorMultiStartOptimizer
Deprecated.
Create a multi-start optimizer from a single-start optimizer.
DifferentiableMultivariateVectorOptimizer - Interface in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
DifferentiableUnivariateFunction - Interface in org.apache.commons.math3.analysis
Deprecated.
as of 3.1 replaced by UnivariateDifferentiableFunction
DifferentiableUnivariateMatrixFunction - Interface in org.apache.commons.math3.analysis
Deprecated.
DifferentiableUnivariateSolver - Interface in org.apache.commons.math3.analysis.solvers
Deprecated.
as of 3.1, replaced by UnivariateDifferentiableSolver
DifferentiableUnivariateVectorFunction - Interface in org.apache.commons.math3.analysis
Deprecated.
differentiate(int, double, double) - Method in class jhplot.F1D
Numerical differentiation.
differentiate() - Method in class jhplot.F1D
Numerical differentiation of a function.
differentiate(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical differentiation.
differentiate(F1D, double[], double[]) - Static method in class jhplot.math.Numeric
Numerical differentiation in multiple dimensions.
differentiate(UnivariateFunction) - Method in class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Create an implementation of a differential from a regular function.
differentiate(UnivariateVectorFunction) - Method in class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Create an implementation of a differential from a regular vector function.
differentiate(UnivariateMatrixFunction) - Method in class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Create an implementation of a differential from a regular matrix function.
differentiate(UnivariateFunction) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateFunctionDifferentiator
Create an implementation of a differential from a regular function.
differentiate(UnivariateMatrixFunction) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateMatrixFunctionDifferentiator
Create an implementation of a differential from a regular matrix function.
differentiate(UnivariateVectorFunction) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateVectorFunctionDifferentiator
Create an implementation of a differential from a regular vector function.
differentiate(Node, String, DJep) - Method in class org.lsmp.djep.djep.DifferentiationVisitor
Differentiates an expression tree wrt a variable var.
differentiate(ASTFunNode, String, Node[], Node[], DJep) - Method in class org.lsmp.djep.djep.diffRules.AdditionDiffRule
 
differentiate(ASTFunNode, String, Node[], Node[], DJep) - Method in class org.lsmp.djep.djep.diffRules.ChainRuleDiffRules
Use the chain rule to differentiate.
differentiate(ASTFunNode, String, Node[], Node[], DJep) - Method in class org.lsmp.djep.djep.diffRules.DivideDiffRule
 
differentiate(ASTFunNode, String, Node[], Node[], DJep) - Method in class org.lsmp.djep.djep.diffRules.MultiplyDiffRule
 
differentiate(ASTFunNode, String, Node[], Node[], DJep) - Method in class org.lsmp.djep.djep.diffRules.PassThroughDiffRule
 
differentiate(ASTFunNode, String, Node[], Node[], DJep) - Method in class org.lsmp.djep.djep.diffRules.PowerDiffRule
 
differentiate(ASTFunNode, String, Node[], Node[], DJep) - Method in class org.lsmp.djep.djep.diffRules.SubtractDiffRule
 
differentiate(ASTFunNode, String, Node[], Node[], DJep) - Method in interface org.lsmp.djep.djep.DiffRulesI
Returns the top node of of the derivative of this function wrt to variable var.
differentiate(Node, String) - Method in class org.lsmp.djep.djep.DJep
Differentiate an equation with respect to a variable.
DifferentiationVisitor - Class in org.lsmp.djep.djep
A class for performing differentation of an expression.
DifferentiationVisitor(DJep) - Constructor for class org.lsmp.djep.djep.DifferentiationVisitor
Construction with a given set of tree utilities
DiffExample - Class in org.lsmp.djepExamples
Examples using differentation
DiffExample() - Constructor for class org.lsmp.djepExamples.DiffExample
 
DiffRulesI - Interface in org.lsmp.djep.djep
Holds a set of rules describing how to differentiate a function.
digamma(double) - Static method in class org.apache.commons.math3.special.Gamma
Computes the digamma function of x.
DIGEST_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Use empirical distribution.
DIGIT1 - Static variable in interface org.nfunk.jep.ParserConstants
 
DIGIT2 - Static variable in interface org.nfunk.jep.ParserConstants
 
Dim - Static variable in class jminhep.gui.SetEnv
 
DimData - Static variable in class jminhep.clcontrol.Global
 
dimen() - Method in class jhplot.VHolder
Return the dimension of the data
dimension() - Method in class jhplot.P1D
Returns the dimension of this P1D holder.
Dimension1D - Class in org.jlab.groot.math
 
Dimension1D() - Constructor for class org.jlab.groot.math.Dimension1D
 
Dimension1D(double, double) - Constructor for class org.jlab.groot.math.Dimension1D
 
Dimension2D - Class in org.jlab.groot.math
 
Dimension2D() - Constructor for class org.jlab.groot.math.Dimension2D
 
Dimension2D(double, double, double, double) - Constructor for class org.jlab.groot.math.Dimension2D
 
Dimension3D - Class in org.jlab.groot.math
 
Dimension3D() - Constructor for class org.jlab.groot.math.Dimension3D
 
DIMENSION_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PND
 
DIMENSION_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PNI
 
DimensionMismatchException - Exception in org.apache.commons.math3.exception
Exception to be thrown when two dimensions differ.
DimensionMismatchException(Localizable, int, int) - Constructor for exception org.apache.commons.math3.exception.DimensionMismatchException
Construct an exception from the mismatched dimensions.
DimensionMismatchException(int, int) - Constructor for exception org.apache.commons.math3.exception.DimensionMismatchException
Construct an exception from the mismatched dimensions.
dimensions() - Method in interface colt.hep.aida.IHistogram
Returns 1 for one-dimensional histograms, 2 for two-dimensional histograms, and so on.
Dimensions - Class in org.lsmp.djep.vectorJep
A class to represent a set of dimensions.
DIR_SEPARATOR - Static variable in class org.apache.commons.io.IOUtils
The system directory separator character.
DIR_SEPARATOR_UNIX - Static variable in class org.apache.commons.io.IOUtils
The Unix directory separator character.
DIR_SEPARATOR_WINDOWS - Static variable in class org.apache.commons.io.IOUtils
The Windows directory separator character.
dirac(double[], double[]) - Static method in class jhplot.math.Random
Generate a random number from a discrete random variable.
directAccess - Static variable in interface hep.lcio.io.LCReader
Configuration flags for the LCReader instance - to be used with LCFactory::createLCReader().
DirectionalGradientPaintTransformer - Class in org.jfree.chart.util
Transforms a GradientPaint to range over the width of a target shape.
DirectionalGradientPaintTransformer() - Constructor for class org.jfree.chart.util.DirectionalGradientPaintTransformer
Default constructor.
directions - Variable in class org.jfree.chart.axis.CompassFormat
The directions.
DIRECTORY - Static variable in class org.apache.commons.io.filefilter.DirectoryFileFilter
Singleton instance of directory filter.
Directory<T> - Class in org.jlab.groot.data
 
Directory() - Constructor for class org.jlab.groot.data.Directory
Default constructor creates a ROOT directory.
Directory(Directory, String) - Constructor for class org.jlab.groot.data.Directory
constructor for subdirectory
DIRECTORY_COMPARATOR - Static variable in class org.apache.commons.io.comparator.DirectoryFileComparator
Singleton default comparator instance
DIRECTORY_REVERSE - Static variable in class org.apache.commons.io.comparator.DirectoryFileComparator
Singleton reverse default comparator instance
directoryAndFileContentEquals(Path, Path) - Static method in class org.apache.commons.io.file.PathUtils
Compares the file sets of two Paths to determine if they are equal or not while considering file contents.
directoryAndFileContentEquals(Path, Path, LinkOption[], OpenOption[], FileVisitOption[]) - Static method in class org.apache.commons.io.file.PathUtils
Compares the file sets of two Paths to determine if they are equal or not while considering file contents.
directoryContains(String, String) - Static method in class org.apache.commons.io.FilenameUtils
Determines whether the parent directory contains the child element (a file or directory).
directoryContains(File, File) - Static method in class org.apache.commons.io.FileUtils
Determines whether the parent directory contains the child element (a file or directory).
directoryContentEquals(Path, Path) - Static method in class org.apache.commons.io.file.PathUtils
Compares the file sets of two Paths to determine if they are equal or not without considering file contents.
directoryContentEquals(Path, Path, int, LinkOption[], FileVisitOption[]) - Static method in class org.apache.commons.io.file.PathUtils
Compares the file sets of two Paths to determine if they are equal or not without considering file contents.
DirectoryFileComparator - Class in org.apache.commons.io.comparator
Compare two files using the File.isDirectory() method.
DirectoryFileComparator() - Constructor for class org.apache.commons.io.comparator.DirectoryFileComparator
 
DirectoryFileFilter - Class in org.apache.commons.io.filefilter
This filter accepts Files that are directories.
directoryFileFilter() - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that checks if the file is a directory.
DirectoryWalker<T> - Class in org.apache.commons.io
Abstract class that walks through a directory hierarchy and provides subclasses with convenient hooks to add specific behavior.
DirectoryWalker.CancelException - Exception in org.apache.commons.io
CancelException is thrown in DirectoryWalker to cancel the current processing.
disable_tracing() - Method in class jplot3dp.MathParser.MathParser
 
disable_tracing() - Method in class org.nfunk.jep.Parser
 
disableDoubleBuffering(Component) - Static method in class jhplot.gui.GHPanel
 
discardFrontElements(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Discards the i initial elements of the array.
discardMostRecentElements(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Discards the i last elements of the array.
DISCONTINUOUS - Static variable in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Constant for the type of rendering (discontinuous lines).
DISCONTINUOUS_LINES - Static variable in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Constant for the type of rendering (discontinuous lines).
DiscreteDistribution - Class in jhplot.math.num.pdf
Base discrete distribution.
DiscreteDistribution() - Constructor for class jhplot.math.num.pdf.DiscreteDistribution
 
DiscreteRandomVariable - Interface in jhplot.math.num.random
A random variable generator for a discrete distribution.
DiskGenerator - Class in org.apache.commons.math3.geometry.euclidean.twod
Class generating an enclosing ball from its support points.
DiskGenerator() - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.DiskGenerator
 
dismissGraph() - Method in class jplot.JPlot
kills the graph frame, stops showing anything.
DISP_DIVISIONS_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
DispatchHandlerFX - Class in org.jfree.chart.fx.interaction
Handles mouse move and click events on the ChartCanvas by dispatching ChartMouseEventFX events to listeners that are registered with the ChartCanvas (listeners can also be registered with a ChartViewer control).
DispatchHandlerFX(String) - Constructor for class org.jfree.chart.fx.interaction.DispatchHandlerFX
Creates a new instance.
dispatchMouseClickedEvent(Point2D, MouseEvent) - Method in class org.jfree.chart.fx.ChartCanvas
 
dispatchMouseMovedEvent(Point2D, MouseEvent) - Method in class org.jfree.chart.fx.ChartCanvas
 
display() - Method in class cern.colt.Timer
Prints the elapsed time on System.out
Display - Class in jminhep.clcontrol
All methods to display the data
Display() - Constructor for class jminhep.clcontrol.Display
 
DISPLAY_GRIDS_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
DISPLAY_X_Y_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
DISPLAY_Z_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
DisplayChart - Class in org.jfree.chart.servlet
Servlet used for streaming charts to the client browser from the temporary directory.
DisplayChart() - Constructor for class org.jfree.chart.servlet.DisplayChart
Default constructor.
dispose() - Method in class jplot.SimpleEditor
Disposes the frame.
dispose() - Method in class org.jfree.chart.fx.FXGraphics2D
This method does nothing.
disposeMe() - Method in class jhplot.gui.GHMargin
Dispose this canvas
distance(DoubleMatrix2D, Statistic.VectorVectorFunction) - Static method in class cern.colt.matrix.doublealgo.Statistic
Constructs and returns the distance matrix of the given matrix.
distance(SpacePoint, SpacePoint) - Static method in class hep.physics.vec.SpacePoint
Return the distance between two space points.
distance(SpacePoint, SpacePoint) - Static method in class hephysics.vec.SpacePoint
Return the distance between two space points.
distance(DataPoint, DataPoint) - Static method in class jminhep.cluster.DataPoint
Returns the distance between two data points
distance(int, int, int, int, int, int) - Static method in class jplot.Geometry
Return distance bwetween the line defined by (x0,y0) and (x1,y1) and the point (x,y).
distance(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Deprecated.
as of 3.3, replaced with Vector1D.distance(Point)
distance(Point<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the distance between the instance and another point.
distance(Vector1D, Vector1D) - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the distance between two vectors according to the L2 norm.
distance(FieldRotation<T>, FieldRotation<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Compute the distance between two rotations.
distance(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L2 norm.
distance(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L2 norm.
distance(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L2 norm.
distance(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L2 norm.
distance(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L2 norm.
distance(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Compute the distance between the instance and a point.
distance(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Compute the shortest distance between the instance and another line.
distance(Rotation, Rotation) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Compute the distance between two rotations.
distance(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between the instance and another vector according to the L2 norm.
distance(Point<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between the instance and another point.
distance(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between two vectors according to the L2 norm.
distance(Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Compute the distance between the instance and a point.
distance(Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Segment
Calculates the shortest distance from a point to this line segment.
distance(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the distance between the instance and another vector according to the L2 norm.
distance(Point<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the distance between the instance and another point.
distance(Vector2D, Vector2D) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the distance between two vectors according to the L2 norm.
distance(Point<S>) - Method in interface org.apache.commons.math3.geometry.Point
Compute the distance between the instance and another point.
distance(Point<Sphere1D>) - Method in class org.apache.commons.math3.geometry.spherical.oned.S1Point
Compute the distance between the instance and another point.
distance(S1Point, S1Point) - Static method in class org.apache.commons.math3.geometry.spherical.oned.S1Point
Compute the distance (angular separation) between two points.
distance(Point<Sphere2D>) - Method in class org.apache.commons.math3.geometry.spherical.twod.S2Point
Compute the distance between the instance and another point.
distance(S2Point, S2Point) - Static method in class org.apache.commons.math3.geometry.spherical.twod.S2Point
Compute the distance (angular separation) between two points.
distance(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Compute the distance between the instance and another vector according to the L2 norm.
distance(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L2 (Euclidean) distance between two points.
distance(int[], int[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L2 (Euclidean) distance between two points.
distance1(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the distance between the instance and another vector according to the L1 norm.
distance1(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L1 norm.
distance1(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L1 norm.
distance1(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L1 norm.
distance1(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L1 norm.
distance1(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L1 norm.
distance1(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between the instance and another vector according to the L1 norm.
distance1(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between two vectors according to the L1 norm.
distance1(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the distance between the instance and another vector according to the L1 norm.
distance1(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Compute the distance between the instance and another vector according to the L1 norm.
distance1(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L1 (sum of abs) distance between two points.
distance1(int[], int[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L1 (sum of abs) distance between two points.
distanceFrom(T) - Method in interface org.apache.commons.math3.stat.clustering.Clusterable
Deprecated.
Returns the distance from the given point.
distanceFrom(EuclideanDoublePoint) - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
Deprecated.
Returns the distance from the given point.
distanceFrom(EuclideanIntegerPoint) - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
Deprecated.
Returns the distance from the given point.
distanceInf(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the distance between the instance and another vector according to the L norm.
distanceInf(Vector1D, Vector1D) - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the distance between two vectors according to the L norm.
distanceInf(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L norm.
distanceInf(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L norm.
distanceInf(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L norm.
distanceInf(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L norm.
distanceInf(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L norm.
distanceInf(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between the instance and another vector according to the L norm.
distanceInf(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between two vectors according to the L norm.
distanceInf(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the distance between the instance and another vector according to the L norm.
distanceInf(Vector2D, Vector2D) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the distance between two vectors according to the L norm.
distanceInf(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Compute the distance between the instance and another vector according to the L norm.
distanceInf(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L (max of abs) distance between two points.
distanceInf(int[], int[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L (max of abs) distance between two points.
DistanceMeasure - Interface in org.apache.commons.math3.ml.distance
Interface for distance measures of n-dimensional vectors.
distanceSq(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the square of the distance between the instance and another vector.
distanceSq(Vector1D, Vector1D) - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the square of the distance between two vectors.
distanceSq(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the square of the distance between the instance and another vector.
distanceSq(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the square of the distance between the instance and another vector.
distanceSq(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the square of the distance between two vectors.
distanceSq(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the square of the distance between two vectors.
distanceSq(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the square of the distance between two vectors.
distanceSq(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the square of the distance between the instance and another vector.
distanceSq(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the square of the distance between two vectors.
distanceSq(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the square of the distance between the instance and another vector.
distanceSq(Vector2D, Vector2D) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the square of the distance between two vectors.
distanceSq(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Compute the square of the distance between the instance and another vector.
distanceSqrt(DataPoint, DataPoint) - Static method in class jminhep.cluster.DataPoint
Returns the squared distance between two data points
DistinctNumberList - Class in cern.colt.list
Resizable compressed list holding numbers; based on the fact that a number from a large list with few distinct values need not take more than log(distinctValues) bits; implemented with a MinMaxNumberList.
DistinctNumberList(long[], int) - Constructor for class cern.colt.list.DistinctNumberList
Constructs an empty list with the specified initial capacity and the specified distinct values allowed to be hold in this list.
distributeLabels(double, double) - Method in class org.jfree.chart.plot.AbstractPieLabelDistributor
Called by the PiePlot class.
distributeLabels(double, double) - Method in class org.jfree.chart.plot.PieLabelDistributor
Distributes the labels.
Distribution - Interface in jhplot.math.num.pdf
Base statistical distribution.
Distributions - Class in cern.jet.random
Contains methods for conveniently generating pseudo-random numbers from special distributions such as the Burr, Cauchy, Erlang, Geometric, Lambda, Laplace, Logistic, Weibull, etc.
distroy() - Method in class jhplot.HPlot
Remove the canvas frame
div(DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A / s <=> A[i] = A[i] / s.
div(DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A / B <=> A[i] = A[i] / B[i].
div(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A / s <=> A[row,col] = A[row,col] / s.
div(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A / B <=> A[row,col] = A[row,col] / B[row,col].
div - Static variable in class cern.jet.math.Functions
Function that returns a / b.
div(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a / b.
div - Static variable in class cern.jet.math.IntFunctions
Function that returns a / b.
div(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a / b.
div(double) - Static method in class cern.jet.math.Mult
a / constant.
Div(Z, Z) - Method in class Jampack.Z
Computes the quotient of two Z's.
Div(Z, double) - Method in class Jampack.Z
Computes the quotient of a Z and a double.
div(Complex) - Method in class jhplot.math.Complex
Division of Complex numbers (doesn't change this Complex number).
div(Object, Object) - Method in class org.lsmp.djep.groupJep.function.GDivide
 
div(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.BigReals
 
div(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.ExtendedFreeGroup
Currently just division by constants.
div(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Integers
 
div(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
div(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Reals
 
div(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Zn
 
div(Number, Number) - Method in interface org.lsmp.djep.groupJep.interfaces.HasDivI
get division of two numbers.
div(Polynomial) - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
div(Rational) - Method in class org.lsmp.djep.groupJep.values.Rational
 
DIV - Static variable in class org.lsmp.djep.rpe.RpEval
 
div(PNodeI) - Method in class org.lsmp.djep.sjep.AbstractPNode
 
div(PNodeI) - Method in class org.lsmp.djep.sjep.Monomial
 
div(PConstant) - Method in class org.lsmp.djep.sjep.MutiableMonomial
 
div(PNodeI) - Method in class org.lsmp.djep.sjep.PConstant
 
div(PNodeI) - Method in interface org.lsmp.djep.sjep.PNodeI
Divides this by the argument.
div(PNodeI) - Method in class org.lsmp.djep.sjep.Polynomial
 
div(Object, Object) - Method in class org.lsmp.djep.vectorJep.function.ElementDivide
Multiply arguments element by element.
div(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.ElementDivide
 
div(Object, Object) - Method in class org.lsmp.djep.vectorJep.function.MDivide
Divide two objects.
div(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.MDivide
Divide two objects.
div(Object, Object) - Method in class org.nfunk.jep.function.Divide
 
div(Number, Number) - Method in class org.nfunk.jep.function.Divide
 
div(Complex, Complex) - Method in class org.nfunk.jep.function.Divide
 
div(Number, Complex) - Method in class org.nfunk.jep.function.Divide
 
div(Complex, Number) - Method in class org.nfunk.jep.function.Divide
 
div(Vector, Number) - Method in class org.nfunk.jep.function.Divide
 
div(Number, Vector) - Method in class org.nfunk.jep.function.Divide
 
div(Vector, Complex) - Method in class org.nfunk.jep.function.Divide
 
div(Complex, Vector) - Method in class org.nfunk.jep.function.Divide
 
DIV - Static variable in interface org.nfunk.jep.ParserConstants
 
div(Complex) - Method in class org.nfunk.jep.type.Complex
Returns the result of dividing this complex number by the parameter.
divide(double) - Method in class jhplot.math.Complex
Returns this complex divided by the specified factor.
divide(double[], double[]) - Static method in class jhplot.math.LinearAlgebra
Element-wise ratio of two arrays.
divide(double[], double) - Static method in class jhplot.math.LinearAlgebra
Divide each element of an array by a scalar.
divide(double[][], double) - Static method in class jhplot.math.LinearAlgebra
Divide each element of a matrix by a scalar
divide(double[][], double[]...) - Static method in class jhplot.math.LinearAlgebra
 
divide(ValueErr, double) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a ValueErr number.
divide(ValueErr, ValueErr, double) - Method in class jhplot.math.ValueErr
Division of two ValueErr numbers a/b with correlation
divide(ValueErr) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a ValueErr number without correlation
divide(ValueErr, ValueErr) - Method in class jhplot.math.ValueErr
Division of two ValueErr numbers a/b without correlation
divide(double) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a double
divide(double, ValueErr) - Method in class jhplot.math.ValueErr
Division of a double, a, by a ValueErr number, b
divide(double, double) - Method in class jhplot.math.ValueErr
Divide a double number by a double and return quotient as ValueErr
DIVIDE - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
divide(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'÷' operator.
divide(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute this ÷ a.
divide(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Perform division of two derivative structures.
divide(SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute this ÷ a.
divide(double) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
'÷' operator.
Divide - Class in org.apache.commons.math3.analysis.function
Divide the first operand by the second.
Divide() - Constructor for class org.apache.commons.math3.analysis.function.Divide
 
divide(Complex) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this / divisor).
divide(double) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this / divisor), with divisor interpreted as a real number.
divide(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Divide this by divisor.
divide(int) - Method in class org.apache.commons.math3.dfp.Dfp
Divide by a single digit less than radix.
divide(double) - Method in class org.apache.commons.math3.dfp.Dfp
'÷' operator.
divide(T) - Method in interface org.apache.commons.math3.FieldElement
Compute this ÷ a.
divide(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
Divide the value of this fraction by the passed BigInteger, ie this * 1 / bg, returning the result in reduced form.
divide(int) - Method in class org.apache.commons.math3.fraction.BigFraction
Divide the value of this fraction by the passed int, ie this * 1 / i, returning the result in reduced form.
divide(long) - Method in class org.apache.commons.math3.fraction.BigFraction
Divide the value of this fraction by the passed long, ie this * 1 / l, returning the result in reduced form.
divide(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
Divide the value of this fraction by another, returning the result in reduced form.
divide(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
Divide the value of this fraction by another.
divide(int) - Method in class org.apache.commons.math3.fraction.Fraction
Divide the fraction by an integer.
divide(double) - Method in interface org.apache.commons.math3.RealFieldElement
'÷' operator.
divide(BigReal) - Method in class org.apache.commons.math3.util.BigReal
Compute this ÷ a.
divide(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute this ÷ a.
divide(double) - Method in class org.apache.commons.math3.util.Decimal64
'÷' operator.
divide(double) - Method in class org.jlab.groot.data.DataVector
Divides the content of the vector by given number.
divide(double) - Method in class org.jlab.groot.data.H1F
 
divide(H1F, H1F) - Static method in class org.jlab.groot.data.H1F
Static method for H1D to divide two histograms, the resulting histogram is created, and arguments are untouched.
divide(H1F) - Method in class org.jlab.groot.data.H1F
Divides the current histogram object by the parameter 1-D histogram.
divide(H2F, H2F) - Static method in class org.jlab.groot.data.H2F
 
divide(H2F) - Method in class org.jlab.groot.data.H2F
 
divide(int, int) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
divide(StatNumber) - Method in class org.jlab.groot.math.StatNumber
Divides the current object by the parameter StatNumber
divide(int, int) - Method in class org.jlab.groot.ui.TCanvas
 
Divide - Class in org.nfunk.jep.function
 
Divide() - Constructor for class org.nfunk.jep.function.Divide
 
DividedDifferenceInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Implements the Divided Difference Algorithm for interpolation of real univariate functions.
DividedDifferenceInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.DividedDifferenceInterpolator
 
DivideDiffRule - Class in org.lsmp.djep.djep.diffRules
Differentiates a division with respect to var.
DivideDiffRule(String) - Constructor for class org.lsmp.djep.djep.diffRules.DivideDiffRule
 
divideEqual(ValueErr) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a ValueErr number and replace it by the quotient without correlation
divideEqual(ValueErr, double) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a ValueErr number and replace this by the quotient
divideEqual(double) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a double and replace this by the quotient
divideGrid(SparseVectorGrid, SparseVectorGrid, int, int, boolean) - Static method in class org.jlab.groot.matrix.GridOperations
 
divideLU(double[][], double[]...) - Static method in class jhplot.math.LinearAlgebra
 
dividePxPyPzE(double) - Method in class hephysics.particle.LParticle
Divide all components (Px,Py,Px,E) by a factor C.
divideQR(double[][], double[]...) - Static method in class jhplot.math.LinearAlgebra
 
DIVU_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.FPR
 
DIVV_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.FPR
 
DJep - Class in org.lsmp.djep.djep
Adds differentation facilities to JEP.
DJep() - Constructor for class org.lsmp.djep.djep.DJep
Standard constructor.
DJepApplet - Class in org.lsmp.djepExamples
This class implements a simple command line utility for evaluating mathematical expressions.
DJepApplet() - Constructor for class org.lsmp.djepExamples.DJepApplet
 
DJepConsole - Class in org.lsmp.djepExamples
 
DJepConsole() - Constructor for class org.lsmp.djepExamples.DJepConsole
 
DJepTest - Class in org.lsmp.djepJUnit
 
DJepTest(String) - Constructor for class org.lsmp.djepJUnit.DJepTest
 
dnrm2(DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Return the 2-norm; sqrt(x[0]^2 + x[1]^2 + ...).
dnrm2(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dnrm2(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
doAll(String[], String) - Static method in class org.lsmp.djepExamples.MRpSpeed
 
doAll(String[]) - Static method in class org.lsmp.djepExamples.RpExample
 
doAll(String[], String) - Static method in class org.lsmp.djepExamples.RpSpeed
 
doBoth(String, String) - Static method in class org.lsmp.djepExamples.MatrixSpeed
 
doc() - Method in class hephysics.jet.ParticleF
Show online documentation.
doc() - Method in class hephysics.particle.HEParticle
Show online documentation.
doc() - Method in class hephysics.particle.LParticle
Show online documentation.
doc() - Method in class jhplot.F1D
Show online documentation.
doc() - Method in class jhplot.F2D
Show online documentation.
doc() - Method in class jhplot.F3D
Show online documentation.
doc() - Method in class jhplot.FND
Show online documentation.
doc() - Method in class jhplot.H1D
Show online documentation.
doc() - Method in class jhplot.H2D
Show online documentation.
doc() - Method in class jhplot.H3D
Show online documentation.
doc() - Method in class jhplot.HChart
Show online documentation.
doc() - Method in class jhplot.HCluster
Show online documentation.
doc() - Method in class jhplot.HFit
Show online documentation.
doc() - Method in class jhplot.HFitter
Show online documentation.
doc() - Method in class jhplot.HLabel
Show online documentation.
doc() - Method in class jhplot.HLabelEq
Show online documentation.
doc() - Method in class jhplot.HMLabel
Show online documentation.
doc() - Method in class jhplot.HPlot
Show online documentation.
doc() - Method in class jhplot.HPlot3D
Show online documentation.
doc() - Method in class jhplot.HPlot3DP
Show online documentation.
doc() - Method in class jhplot.HPlotJas
Show online documentation.
doc() - Method in class jhplot.HProf1D
Show online documentation.
doc() - Method in class jhplot.HProf2D
Show online documentation.
doc() - Method in class jhplot.HTable
Show online documentation.
doc() - Method in class jhplot.IO
Show online documentation.
doc() - Method in class jhplot.io.EFile
Show online documentation.
doc() - Method in class jhplot.io.FileAida
Show online documentation.
doc() - Method in class jhplot.io.FileRoot
Show online documentation.
doc() - Method in class jhplot.io.HBook
Show online documentation.
doc() - Method in class jhplot.io.HFile
Show online documentation.
doc() - Method in class jhplot.io.HFileDIF
Show online documentation.
doc() - Method in class jhplot.io.HFileMap
Show online documentation.
doc() - Method in class jhplot.io.HFileXML
Show online documentation.
doc() - Method in class jhplot.io.PFile
Show online documentation.
doc() - Method in class jhplot.io.Serialized
Show online documentation.
doc() - Method in class jhplot.JHPlot
Show online documentation.
doc() - Method in class jhplot.P0D
Show online documentation.
doc() - Method in class jhplot.P0I
Show online documentation.
doc() - Method in class jhplot.P1D
Show online documentation.
doc() - Method in class jhplot.P2D
Show online documentation.
doc() - Method in class jhplot.P3D
Show online documentation.
doc() - Method in class jhplot.PND
Show online documentation.
doc() - Method in class jhplot.PNI
Show online documentation.
doc() - Method in class jhplot.shapes.Arrow
Show online documentation.
doc() - Method in class jhplot.shapes.Circle
Show online documentation.
doc() - Method in class jhplot.shapes.Ellipse
Show online documentation.
doc() - Method in class jhplot.shapes.Line
Show online documentation.
doc() - Method in class jhplot.shapes.Picture
Show online documentation.
doc() - Method in class jhplot.shapes.Rectan
Show online documentation.
doc() - Method in class jhplot.shapes.Text
Show online documentation.
doc() - Method in class jhplot.SHPlot
Show online documentation.
doc() - Method in class jhplot.SHPlot3D
Show online documentation.
doc() - Method in class jhplot.stat.BunchingParameters
Show online documentation.
doc() - Method in class jhplot.stat.CLimits
Show online documentation.
doc() - Method in class jhplot.stat.ConfidenceLevel
Show online documentation.
doc() - Method in class jhplot.stat.EEcentricity
Show online documentation.
doc() - Method in class jhplot.stat.FactorialMoments
Show online documentation.
doc() - Method in class jhplot.stat.LinReg
Show online documentation.
doc() - Method in class jhplot.stat.LinRegWeighted
Show online documentation.
doc() - Method in class jhplot.stat.Moments
Show online documentation.
doc() - Method in class jhplot.stat.MomentsFac
Show online documentation.
doc() - Method in class jhplot.stat.MomentsNorm
Show online documentation.
doc() - Method in class jhplot.stat.PCA
Show online documentation.
doc() - Method in class jhplot.stat.Statistics
Show online documentation.
doc() - Method in class jhplot.stat.StatShape
Show online documentation.
doc() - Method in class jhplot.VHolder
Show online documentation.
doCopy() - Method in class org.jfree.chart.ChartPanel
Copies the current chart to the system clipboard.
DOCUMENTATION - Static variable in interface hep.physics.particle.Particle
 
doEditChartProperties() - Method in class org.jfree.chart.ChartPanel
Displays a dialog that allows the user to edit the properties for the current chart.
doExportPNG(File) - Method in class jplot3d.JSurface
mouseDown event handler.
doFit(IFunction, String) - Method in class fitter.Fitter
Do fit
DomainInfo - Interface in org.jfree.data
An interface (optional) that can be implemented by a dataset to assist in determining the minimum and maximum values.
DomainOrder - Class in org.jfree.data
Used to indicate sorting order if any (ascending, descending or none).
doMouseClicked(MouseEvent) - Method in class org.jlab.groot.ui.TBrowser
 
Done() - Method in class jplot3dp.MathParser.SimpleCharStream
 
Done() - Method in class org.nfunk.jep.JavaCharStream
 
doneAnalysis - Static variable in class jminhep.clcontrol.Global
 
DoNothingVisitor - Class in org.lsmp.djep.xjep
A Visitor which visits each node of a expression tree.
DoNothingVisitor() - Constructor for class org.lsmp.djep.xjep.DoNothingVisitor
 
doOptimize() - Method in class org.apache.commons.math3.optim.linear.SimplexSolver
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.GaussNewtonOptimizer
Deprecated.
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
Deprecated.
Perform the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.linear.SimplexSolver
Deprecated.
Perform the bulk of optimization algorithm.
DormandPrince54FieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 5(4) Dormand-Prince integrator for Ordinary Differential Equations.
DormandPrince54FieldIntegrator(Field<T>, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince54FieldIntegrator
Simple constructor.
DormandPrince54FieldIntegrator(Field<T>, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince54FieldIntegrator
Simple constructor.
DormandPrince54Integrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 5(4) Dormand-Prince integrator for Ordinary Differential Equations.
DormandPrince54Integrator(double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince54Integrator
Simple constructor.
DormandPrince54Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince54Integrator
Simple constructor.
DormandPrince853FieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 8(5,3) Dormand-Prince integrator for Ordinary Differential Equations.
DormandPrince853FieldIntegrator(Field<T>, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince853FieldIntegrator
Simple constructor.
DormandPrince853FieldIntegrator(Field<T>, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince853FieldIntegrator
Simple constructor.
DormandPrince853Integrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 8(5,3) Dormand-Prince integrator for Ordinary Differential Equations.
DormandPrince853Integrator(double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince853Integrator
Simple constructor.
DormandPrince853Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince853Integrator
Simple constructor.
doSaveAs() - Method in class org.jfree.chart.ChartPanel
Opens a file chooser and gives the user an opportunity to save the chart in PNG format.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Method for implementing actual optimization algorithms in derived classes.
doStuff(String) - Static method in class org.lsmp.djepExamples.MatrixExample
 
doStuff(String) - Static method in class org.lsmp.djepExamples.MRpExample
 
doStuff(String) - Static method in class org.lsmp.djepExamples.RpExample
 
doStuff(String) - Static method in class org.lsmp.djepExamples.VectorExample
 
doStuff(String) - Static method in class org.lsmp.djepExamples.VectorPrint
 
dot(Hep3Vector, Hep3Vector) - Static method in class hep.physics.vec.VecOp
 
dot(HepLorentzVector, HepLorentzVector) - Static method in class hep.physics.vec.VecOp
 
dot(Hep3Vector, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Dot product of 2 vectors
dot(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Dot operation
dot(HepLorentzVector, HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Dot product
dot(Hep3Vector, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
dot(Vector3) - Method in class j4np.physics.Vector3
 
DOT - Static variable in class org.lsmp.djep.rpe.RpEval
 
dot(Object, Object) - Method in class org.lsmp.djep.vectorJep.function.MDot
returns param1 .
dot(MVector, MVector) - Method in class org.lsmp.djep.vectorJep.function.MDot
returns lhs .
Dot - Class in org.nfunk.jep.function
 
Dot() - Constructor for class org.nfunk.jep.function.Dot
 
dot(Object, Object) - Method in class org.nfunk.jep.function.Dot
 
dot(Vector, Vector) - Method in class org.nfunk.jep.function.Dot
 
DOT - Static variable in interface org.nfunk.jep.ParserConstants
 
dotProduct(Quaternion, Quaternion) - Static method in class org.apache.commons.math3.complex.Quaternion
Computes the dot-product of two quaternions.
dotProduct(Quaternion) - Method in class org.apache.commons.math3.complex.Quaternion
Computes the dot-product of the instance by a quaternion.
dotProduct(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the dot-product of the instance and another vector.
dotProduct(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the dot-product of the instance and another vector.
dotProduct(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the dot-product of the instance and another vector.
dotProduct(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the dot-product of two vectors.
dotProduct(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the dot-product of two vectors.
dotProduct(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the dot-product of two vectors.
dotProduct(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the dot-product of the instance and another vector.
dotProduct(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the dot-product of two vectors.
dotProduct(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the dot-product of the instance and another vector.
dotProduct(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Compute the dot-product of the instance and another vector.
dotProduct(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the dot product.
dotProduct(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the dot product.
dotProduct(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Compute the dot product of this vector with v.
dotProduct(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Compute the dot product.
dotProduct(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated.
as of 3.1 (to be removed in 4.0). The computation is performed by the parent class. The method must be kept to maintain backwards compatibility.
dotProduct(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Compute the dot product of this vector with v.
dotProduct(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Compute the dot product.
dotrap(int, String, Dfp, Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Raises a trap.
Double27Function - Interface in cern.colt.function
Interface that represents a function object: a function that takes 27 arguments and returns a single value.
Double5Function - Interface in cern.colt.function
Interface that represents a function object: a function that takes 5 arguments and returns a single value.
Double9Function - Interface in cern.colt.function
Interface that represents a function object: a function that takes 9 arguments and returns a single value.
DOUBLE_MIN_NORMAL - Static variable in class net.jafama.NumbersUtils
Double.MIN_NORMAL since Java 6.
DoubleArray - Class in jhplot.math
A class for dealing with double arrays and matrices.
DoubleArray() - Constructor for class jhplot.math.DoubleArray
 
DoubleArray - Class in jhplot.math.num
An expandable double array.
DoubleArray() - Constructor for class jhplot.math.num.DoubleArray
 
DoubleArray - Interface in org.apache.commons.math3.util
Provides a standard interface for double arrays.
DoubleArrayList - Class in cern.colt.list
Resizable list holding double elements; implemented with arrays.
DoubleArrayList() - Constructor for class cern.colt.list.DoubleArrayList
Constructs an empty list.
DoubleArrayList(double[]) - Constructor for class cern.colt.list.DoubleArrayList
Constructs a list containing the specified elements.
DoubleArrayList(int) - Constructor for class cern.colt.list.DoubleArrayList
Constructs an empty list with the specified initial capacity.
DoubleBuffer - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target DoubleBufferConsumer to which data is automatically flushed upon buffer overflow.
DoubleBuffer(DoubleBufferConsumer, int) - Constructor for class cern.colt.buffer.DoubleBuffer
Constructs and returns a new buffer with the given target.
DoubleBuffer2D - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target DoubleBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
DoubleBuffer2D(DoubleBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.DoubleBuffer2D
Constructs and returns a new buffer with the given target.
DoubleBuffer2DConsumer - Interface in cern.colt.buffer
Target of a streaming DoubleBuffer2D into which data is flushed upon buffer overflow.
DoubleBuffer3D - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target DoubleBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
DoubleBuffer3D(DoubleBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.DoubleBuffer3D
Constructs and returns a new buffer with the given target.
DoubleBuffer3DConsumer - Interface in cern.colt.buffer
Target of a streaming DoubleBuffer3D into which data is flushed upon buffer overflow.
DoubleBufferConsumer - Interface in cern.colt.buffer
Target of a streaming DoubleBuffer into which data is flushed upon buffer overflow.
DoubleComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
DoubleDoubleFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes two arguments and returns a single value.
DoubleDoubleProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
DoubleFactory1D - Class in cern.colt.matrix
Factory for convenient construction of 1-d matrices holding double cells.
DoubleFactory2D - Class in cern.colt.matrix
Factory for convenient construction of 2-d matrices holding double cells.
DoubleFactory3D - Class in cern.colt.matrix
Factory for convenient construction of 3-d matrices holding double cells.
DoubleFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes a single argument and returns a single value.
DoubleIntProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
DoubleListAdapter - Class in cern.colt.list.adapter
Adapter that permits an AbstractDoubleList to be viewed and treated as a JDK 1.2 AbstractList.
DoubleListAdapter(AbstractDoubleList) - Constructor for class cern.colt.list.adapter.DoubleListAdapter
Constructs a list backed by the specified content list.
DoubleMatrix1D - Class in cern.colt.matrix
Abstract base class for 1-d matrices (aka vectors) holding double elements.
DoubleMatrix1DComparator - Interface in cern.colt.matrix.doublealgo
A comparison function which imposes a total ordering on some collection of elements.
DoubleMatrix1DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
DoubleMatrix2D - Class in cern.colt.matrix
Abstract base class for 2-d matrices holding double elements.
DoubleMatrix2DComparator - Interface in cern.colt.matrix.doublealgo
A comparison function which imposes a total ordering on some collection of elements.
DoubleMatrix2DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
DoubleMatrix3D - Class in cern.colt.matrix
Abstract base class for 3-d matrices holding double elements.
DoubleMatrix3DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
DoubleNumberFactory - Class in org.nfunk.jep.type
Default class for creating number objects.
DoubleNumberFactory() - Constructor for class org.nfunk.jep.type.DoubleNumberFactory
 
DoublePoint - Class in org.apache.commons.math3.ml.clustering
A simple implementation of Clusterable for points with double coordinates.
DoublePoint(double[]) - Constructor for class org.apache.commons.math3.ml.clustering.DoublePoint
Build an instance wrapping an double array.
DoublePoint(int[]) - Constructor for class org.apache.commons.math3.ml.clustering.DoublePoint
Build an instance wrapping an integer array.
DoubleProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
DoubleQuantileFinder - Interface in cern.jet.stat.quantile
The interface shared by all quantile finders, no matter if they are exact or approximate.
DoubleSpinner - Class in org.jlab.groot.ui
 
DoubleSpinner() - Constructor for class org.jlab.groot.ui.DoubleSpinner
 
DoubletoEstring(double, int, int) - Static method in class Jampack.Print
Converts a double to w.d e format.
doubleValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a double.
doubleValue() - Method in class org.apache.commons.math3.fraction.Fraction
Gets the fraction as a double.
doubleValue() - Method in class org.apache.commons.math3.util.BigReal
Get the double value corresponding to the instance.
doubleValue() - Method in class org.apache.commons.math3.util.Decimal64
doubleValue() - Method in class org.lsmp.djep.groupJep.groups.Quaternions.Quaternion
 
doubleValue() - Method in class org.lsmp.djep.groupJep.values.Permutation
Just returns 0.
doubleValue() - Method in class org.lsmp.djep.groupJep.values.Polynomial
value of constant coeff.
doubleValue() - Method in class org.lsmp.djep.groupJep.values.Rational
 
doubleValue() - Method in class org.lsmp.djep.vectorJep.values.Scaler
value of constant coeff.
doubleValue(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
Returns the double value represented by node
doubleValue() - Method in class org.nfunk.jep.type.Complex
Returns real part.
DoubleWrapper - Class in net.jafama
 
DoubleWrapper() - Constructor for class net.jafama.DoubleWrapper
 
DOWN_45 - Static variable in class org.jfree.chart.axis.CategoryLabelPositions
DOWN_45 category label positions.
DOWN_90 - Static variable in class org.jfree.chart.axis.CategoryLabelPositions
DOWN_90 category label positions.
DOWNSIDE_VARIANCE - Static variable in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
The DOWNSIDE Direction is used to specify that the observations below the cutoff point will be used to calculate SemiVariance
downsize(Class) - Static method in class org.jfree.data.time.RegularTimePeriod
Returns a subclass of RegularTimePeriod that is smaller than the specified class.
DPrintVisitor - Class in org.lsmp.djep.djep
An extension of PrintVisitor which will print the equations of a variable if required.
DPrintVisitor() - Constructor for class org.lsmp.djep.djep.DPrintVisitor
 
DragListener() - Constructor for class jplot.GraphGeneral.DragListener
 
DRand - Class in cern.jet.random.engine
Quick medium quality uniform pseudo-random number generator.
DRand() - Constructor for class cern.jet.random.engine.DRand
Constructs and returns a random number generator with a default seed, which is a constant.
DRand(int) - Constructor for class cern.jet.random.engine.DRand
Constructs and returns a random number generator with the given seed.
DRand(Date) - Constructor for class cern.jet.random.engine.DRand
Constructs and returns a random number generator seeded with the given date.
draw(Graphics, int, double, int, int) - Method in class graph.Markers
draw the marker
draw(VectorGraphics, int, int) - Method in class graph.RTextLine
Parse the text then draw it.
draw(VectorGraphics, int, int, int) - Method in class graph.RTextLine
Parse the text then draw it.
draw(Component, VectorGraphics, int, int) - Method in class graph.RTextLine
Parse the text, rotate it then draw it to the screen.
draw(Graphics, int, int, int) - Method in class graph.TextLine
Parse the text then draw it.
draw(Graphics, int, int) - Method in class graph.TextLine
Parse the text then draw it without any rotation.
draw(double[], double[]) - Method in class jhplot.HChart
Draw X-Y data from arrays
draw(F1D) - Method in class jhplot.HChart
Draw a F1D function on the canvas.
draw(H1D) - Method in class jhplot.HChart
Draw a H1D histogram on the canvas.
draw(ArrayList<Double>, ArrayList<Double>) - Method in class jhplot.HChart
Draw X-Y data from arrays
draw(HLabel) - Method in class jhplot.HPlot
Draw a label.
draw(HKey) - Method in class jhplot.HPlot
Draw a key.
draw(HLabelEq) - Method in class jhplot.HPlot
Draw a LaTeX rquation on the Canvas.
draw(HShape) - Method in class jhplot.HPlot
Draw a shape primitive to the Canvas.
draw(HMLabel) - Method in class jhplot.HPlot
Draw a multiline label.
draw(H1D[]) - Method in class jhplot.HPlot
Draw array of histograms
draw(Cloud1D) - Method in class jhplot.HPlot
Plot cloud in 1D.
draw(DataPointSet) - Method in class jhplot.HPlot
Plot Aida datapointset.
draw(Cloud2D) - Method in class jhplot.HPlot
Plot cloud 2D
draw(Histogram1D) - Method in class jhplot.HPlot
Draw 1D histogram
draw(H1D) - Method in class jhplot.HPlot
Plot 1D histogram.
draw(F1D[]) - Method in class jhplot.HPlot
Draw array of F1D holders
draw(DataArray, int) - Method in class jhplot.HPlot
Draw input data represented by DataArray
draw(F1D) - Method in class jhplot.HPlot
Draw an one-dimensional function.
draw(FND) - Method in class jhplot.HPlot
Draw an one-dimensional function from FND
draw(F1D, boolean) - Method in class jhplot.HPlot
Draw an one-dimensional function.
draw(FND, boolean) - Method in class jhplot.HPlot
Draw an one-dimensional function from FND.
draw(P1D[]) - Method in class jhplot.HPlot
Draw array of P1D holders
draw(P1D) - Method in class jhplot.HPlot
Draw data in form of P1D
draw(H2D) - Method in class jhplot.HPlot3D
Draw H2D histogram.
draw(P2D) - Method in class jhplot.HPlot3D
Display P2D data holder with X,Y,Z values in 3D.
draw(P3D) - Method in class jhplot.HPlot3D
Display P3D data holder with X,Y,Z values in 3D as surface.
draw(H2D, H2D) - Method in class jhplot.HPlot3D
Plot two H2D histograms on the same plot.
draw(F2D) - Method in class jhplot.HPlot3D
Draw F2D function as a surface.
draw(F2D, F2D) - Method in class jhplot.HPlot3D
Draw two F2D functions on the same plot.
draw(H2D, F2D) - Method in class jhplot.HPlot3D
Draw H2D histogram and F2D function on the same plot.
draw(F2D, H2D) - Method in class jhplot.HPlot3D
Draw F2D and H2D on the same plot.
draw(FPR) - Method in class jhplot.HPlot3DP
Draw a parametric function.
draw(H1D) - Method in class jhplot.HPlotJas
Plot 1D histogram.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in class org.jfree.chart.annotations.AbstractXYAnnotation
Draws the annotation.
draw(Graphics2D, CategoryPlot, Rectangle2D, CategoryAxis, ValueAxis) - Method in interface org.jfree.chart.annotations.CategoryAnnotation
Draws the annotation.
draw(Graphics2D, CategoryPlot, Rectangle2D, CategoryAxis, ValueAxis) - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Draws the annotation.
draw(Graphics2D, CategoryPlot, Rectangle2D, CategoryAxis, ValueAxis) - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Draws the annotation.
draw(Graphics2D, CategoryPlot, Rectangle2D, CategoryAxis, ValueAxis) - Method in class org.jfree.chart.annotations.CategoryTextAnnotation
Draws the annotation.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in interface org.jfree.chart.annotations.XYAnnotation
Draws the annotation.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in class org.jfree.chart.annotations.XYBoxAnnotation
Draws the annotation.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Draws the annotation.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in class org.jfree.chart.annotations.XYDrawableAnnotation
Draws the annotation.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in class org.jfree.chart.annotations.XYImageAnnotation
Draws the annotation.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in class org.jfree.chart.annotations.XYLineAnnotation
Draws the annotation.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Draws the annotation.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in class org.jfree.chart.annotations.XYPolygonAnnotation
Draws the annotation.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in class org.jfree.chart.annotations.XYShapeAnnotation
Draws the annotation.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Draws the annotation.
draw(Graphics2D, XYPlot, Rectangle2D, ValueAxis, ValueAxis, int, PlotRenderingInfo) - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Draws the annotation.
draw(Graphics2D, double, Rectangle2D, Rectangle2D, RectangleEdge, PlotRenderingInfo) - Method in class org.jfree.chart.axis.Axis
Draws the axis on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, double, Rectangle2D, Rectangle2D, RectangleEdge, PlotRenderingInfo) - Method in class org.jfree.chart.axis.CategoryAxis
Draws the axis on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, double, Rectangle2D, Rectangle2D, RectangleEdge, PlotRenderingInfo) - Method in class org.jfree.chart.axis.CategoryAxis3D
Draws the axis on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, double, Rectangle2D, Rectangle2D, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, double, Rectangle2D, Rectangle2D, RectangleEdge, PlotRenderingInfo) - Method in class org.jfree.chart.axis.CyclicNumberAxis
Draws the axis.
draw(Graphics2D, double, Rectangle2D, Rectangle2D, RectangleEdge, PlotRenderingInfo) - Method in class org.jfree.chart.axis.DateAxis
Draws the axis on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, double, Rectangle2D, Rectangle2D, RectangleEdge, PlotRenderingInfo) - Method in class org.jfree.chart.axis.LogAxis
Draws the axis on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Rectangle2D, double, double) - Method in class org.jfree.chart.axis.MarkerAxisBand
Draws the band.
draw(Graphics2D, double, Rectangle2D, Rectangle2D, RectangleEdge, PlotRenderingInfo) - Method in class org.jfree.chart.axis.NumberAxis
Draws the axis on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, double, Rectangle2D, Rectangle2D, RectangleEdge, PlotRenderingInfo) - Method in class org.jfree.chart.axis.NumberAxis3D
Draws the axis on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, double, Rectangle2D, Rectangle2D, RectangleEdge, PlotRenderingInfo) - Method in class org.jfree.chart.axis.PeriodAxis
Draws the axis on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, double, Rectangle2D, Rectangle2D, RectangleEdge, PlotRenderingInfo) - Method in class org.jfree.chart.axis.SubCategoryAxis
Draws the axis on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, double, Rectangle2D, Rectangle2D, RectangleEdge, PlotRenderingInfo) - Method in class org.jfree.chart.axis.SymbolAxis
Draws the axis on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Object) - Method in interface org.jfree.chart.block.Block
Draws the block within the specified area.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.block.BlockBorder
Draws the border by filling in the reserved space.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.block.BlockContainer
Draws the container and all the blocks within it.
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.block.BlockContainer
Draws the block within the specified area.
draw(Graphics2D, Rectangle2D) - Method in interface org.jfree.chart.block.BlockFrame
Draws the border by filling in the reserved space (in black).
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.block.ColorBlock
Draws the block.
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.block.ColorBlock
Draws the block within the specified area.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.block.EmptyBlock
Draws the block.
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.block.EmptyBlock
Draws the block within the specified area.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.block.LabelBlock
Draws the block.
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.block.LabelBlock
Draws the block within the specified area.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.block.LineBorder
Draws the border by filling in the reserved space (in black).
draw(Graphics2D, Rectangle2D, ValueAxis, ValueAxis) - Method in class org.jfree.chart.ClipPath
Deprecated.
Draws the clip path.
draw() - Method in class org.jfree.chart.fx.ChartCanvas
Draws the content of the canvas and updates the renderingInfo attribute with the latest rendering information.
draw(Shape) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws the specified shape with the current paint and stroke.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.JFreeChart
Draws the chart on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, ChartRenderingInfo) - Method in class org.jfree.chart.JFreeChart
Draws the chart on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, ChartRenderingInfo) - Method in class org.jfree.chart.JFreeChart
Draws the chart on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.needle.MeterNeedle
Draws the needle.
draw(Graphics2D, Rectangle2D, double) - Method in class org.jfree.chart.needle.MeterNeedle
Draws the needle.
draw(Graphics2D, Rectangle2D, Point2D, double) - Method in class org.jfree.chart.needle.MeterNeedle
Draws the needle.
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.CategoryPlot
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Draws the plot within the specified area on a graphics device.
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Draws the plot within the specified area on a graphics device.
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.CompassPlot
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, DialPlot, Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Draws the frame.
draw(Graphics2D, DialPlot, Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.plot.dial.DialBackground
Draws the background to the specified graphics device.
draw(Graphics2D, DialPlot, Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.plot.dial.DialCap
Draws the background to the specified graphics device.
draw(Graphics2D, DialPlot, Rectangle2D, Rectangle2D) - Method in interface org.jfree.chart.plot.dial.DialLayer
Draws the content of this layer.
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.dial.DialPlot
Draws the plot.
draw(Graphics2D, DialPlot, Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.plot.dial.DialPointer.Pin
Draws the pointer.
draw(Graphics2D, DialPlot, Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.plot.dial.DialPointer.Pointer
Draws the pointer.
draw(Graphics2D, DialPlot, Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Draws the background to the specified graphics device.
draw(Graphics2D, DialPlot, Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Draws the background to the specified graphics device.
draw(Graphics2D, DialPlot, Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Draws the frame.
draw(Graphics2D, DialPlot, Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.plot.dial.StandardDialRange
Draws the range.
draw(Graphics2D, DialPlot, Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Draws the scale on the dial plot.
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.FastScatterPlot
Draws the fast scatter plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.MeterPlot
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.MultiplePiePlot
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.PiePlot
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.PiePlot3D
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.Plot
Draws the plot within the specified area.
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.PolarPlot
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.SpiderWebPlot
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.ThermometerPlot
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.WaferMapPlot
Draws the wafermap view.
draw(Graphics2D, Rectangle2D, Point2D, PlotState, PlotRenderingInfo) - Method in class org.jfree.chart.plot.XYPlot
Draws the plot within the specified area on a graphics device.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.title.CompositeTitle
Draws the title on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.title.CompositeTitle
Draws the block within the specified area.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.title.ImageTitle
Draws the title on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.title.ImageTitle
Draws the block within the specified area.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.title.LegendGraphic
Draws the graphic item within the specified area.
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.title.LegendGraphic
Draws the block within the specified area.
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.title.LegendItemBlockContainer
Draws the block within the specified area.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.title.LegendTitle
Draws the title on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.title.LegendTitle
Draws the block within the specified area.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.title.PaintScaleLegend
Draws the legend within the specified area.
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.title.PaintScaleLegend
Draws the legend within the specified area.
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.title.ShortTextTitle
Draws the title using the current font and paint.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.title.TextTitle
Draws the title on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, Rectangle2D, Object) - Method in class org.jfree.chart.title.TextTitle
Draws the block within the specified area.
draw(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.title.Title
Draws the title on a Java 2D graphics device (such as the screen or a printer).
draw(Graphics2D, int, int, int, int, double, double, Boolean) - Method in class org.jlab.groot.base.ColorPalette
 
draw(IDataSet) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
draws dataset on current active pad with no options
draw(IDataSet, String) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
draws data set on current active pad with given options
draw(DataGroup) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
draw(Graphics2D) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
draw(IDataSet, String) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
draw(Graphics2D, GraphicsAxisFrame) - Method in class org.jlab.groot.graphics.FunctionPlotter
 
draw(Graphics2D, GraphicsAxisFrame) - Method in class org.jlab.groot.graphics.GraphErrorsPlotter
 
draw(Graphics2D, GraphicsAxisFrame) - Method in class org.jlab.groot.graphics.Histogram2DPlotter
 
draw(Graphics2D, GraphicsAxisFrame) - Method in class org.jlab.groot.graphics.HistogramPlotter
 
draw(Graphics2D, GraphicsAxisFrame) - Method in interface org.jlab.groot.graphics.IDataSetPlotter
 
draw(Graphics2D, Dimension2D) - Method in class org.jlab.groot.ui.GraphicsAxisFrame
 
draw(IDataSet, String) - Method in class org.jlab.groot.ui.TCanvas
 
draw(IDataSet) - Method in class org.jlab.groot.ui.TCanvas
 
draw_data(Graphics, Rectangle) - Method in class graph.DataSet
Draw the straight line segments and/or the markers at the data points.
draw_data(Graphics, Rectangle) - Method in class graph.VectorSet
Draw the vectors at the data points.
DrawableLegendItem - Class in org.jfree.chart
Deprecated.
This class is not used by JFreeChart.
DrawableLegendItem(LegendItem) - Constructor for class org.jfree.chart.DrawableLegendItem
Deprecated.
Create a legend item.
drawAlignedString(String, Graphics2D, float, float, TextAnchor) - Static method in class org.jfree.chart.util.TextUtils
Draws a string such that the specified anchor point is aligned to the given (x, y) location, and returns a bounding rectangle for the text.
drawAll(Graphics) - Method in class jplot3d.LineAccumulator
Draws all accumulated lines.
drawAngularGridLines(Graphics2D, PolarPlot, List, Rectangle2D) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Draw the angular gridlines - the spokes.
drawAngularGridLines(Graphics2D, PolarPlot, List, Rectangle2D) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Draw the angular gridlines - the spokes.
drawAnnotations(Graphics2D, Rectangle2D, PlotRenderingInfo) - Method in class org.jfree.chart.plot.XYPlot
Draws the annotations for the plot.
drawAnnotations(Graphics2D, Rectangle2D, ValueAxis, ValueAxis, Layer, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Draws all the annotations for the specified layer.
drawAnnotations(Graphics2D, Rectangle2D, ValueAxis, ValueAxis, Layer, PlotRenderingInfo) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Draws all the annotations for the specified layer.
drawArc(int, int, int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws an arc contained within the rectangle (x, y, width, height), starting at startAngle and continuing through arcAngle degrees using the current paint and stroke.
drawArrow(Graphics, int, int, int, int) - Method in class jplot.GraphGeneral
Another way with closed ends
drawArrow2(VectorGraphics, int, int, int, int) - Method in class jplot.GraphGeneral
Draw arrow this allows you to draw an arrow with headlength (headsize), headwidth (headsize - difference), hedheight (factor (relative to headlength)),
drawAxis(VectorGraphics) - Method in class graph.Axis
Draw the axis using the passed Graphics context.
drawAxis(int, int, int, float, float, int, int, int, boolean, int, Graphics) - Static method in class jplot.Axis
high-level method for drawing a chart axis line plus labeled tic marks.
drawAxis(int) - Method in class jplot.GraphSettings
Returns whether an axis will be drawn or not.
drawAxis(Graphics2D, int, int) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
drawAxis(Graphics2D, int, int, int) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
drawAxis(Graphics2D, PadMargins) - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
drawAxisGrid(Graphics2D, int, int, int) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
drawAxisMirror(Graphics2D, int, int, int) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
drawBackground(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.plot.CategoryPlot
Draws the plot background (the background color and/or image).
drawBackground(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.plot.Plot
Draws the plot background (the background color and/or image).
drawBackground(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.plot.XYPlot
Draws the background for the plot.
drawBackground(Graphics2D, CategoryPlot, Rectangle2D) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Draws a background for the data area.
drawBackground(Graphics2D, CategoryPlot, Rectangle2D) - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Draws the background for the plot.
drawBackground(Graphics2D, CategoryPlot, Rectangle2D) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Draws a background for the data area.
drawBackground(Graphics2D, CategoryPlot, Rectangle2D) - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Draws the background for the plot.
drawBackgroundImage(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.plot.Plot
Draws the background image (if there is one) aligned within the specified area.
drawBoundingBox() - Method in class jplot3d.JSurface
Draws the bounding box of surface.
drawBoundingRect() - Method in class jplot3d.JSurface
Creates bounding box for images of contour plot or density plot
drawBox() - Method in class jhplot.HPlot3D
Set drawiing an empty frame.
drawBox() - Method in class jplot.GraphSettings
Returns whether or not to draw the bounding box arround the graph.
drawBoxGridsTicksLabels(VectorGraphics, boolean) - Method in class jplot3d.JSurface
Draws non-surface parts, i.e: bounding box, axis grids, axis ticks, axis labels, base plane.
drawColor(Graphics2D, double, double, double, double) - Method in class jplot.Contour
Draw contour
drawColorBar(Graphics2D, Font, int) - Method in class jplot.Contour
Draw the contour
drawColorBar(Graphics2D, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Draws the plot on a Java 2D graphics device (such as the screen or a printer).
drawContour() - Method in class jminhep.gui.Plotter
 
DrawContour - Class in jplot3d.draw
 
DrawContour() - Constructor for class jplot3d.draw.DrawContour
 
drawDashedLine(VectorGraphics, int, int, int, int, double, double) - Method in class jplot.GraphGeneral
draw dotted or dashed lines
DrawDensity - Class in jplot3d.draw
 
DrawDensity() - Constructor for class jplot3d.draw.DrawDensity
 
drawDomainGridline(Graphics2D, CategoryPlot, Rectangle2D, double) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Draws a grid line against the domain axis.
drawDomainGridline(Graphics2D, CategoryPlot, Rectangle2D, double) - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Draws a grid line against the domain axis.
drawDomainGridline(Graphics2D, CategoryPlot, Rectangle2D, double) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Draws a grid line against the domain axis.
drawDomainGridline(Graphics2D, CategoryPlot, Rectangle2D, double) - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Draws a grid line against the domain axis.
drawDomainGridLine(Graphics2D, XYPlot, ValueAxis, Rectangle2D, double) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Draws a grid line against the range axis.
drawDomainGridLine(Graphics2D, XYPlot, ValueAxis, Rectangle2D, double) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Draws a grid line against the domain axis.
drawDomainLine(Graphics2D, XYPlot, ValueAxis, Rectangle2D, double, Paint, Stroke) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Draws a line perpendicular to the domain axis.
drawDomainMarker(Graphics2D, ContourPlot, ValueAxis, Marker, Rectangle2D) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Draws a vertical line on the chart to represent a 'range marker'.
drawDomainMarker(Graphics2D, CategoryPlot, CategoryAxis, CategoryMarker, Rectangle2D) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Draws a marker for the domain axis.
drawDomainMarker(Graphics2D, CategoryPlot, CategoryAxis, CategoryMarker, Rectangle2D) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Draws a line (or some other marker) to indicate a particular category on the domain axis.
drawDomainMarker(Graphics2D, XYPlot, ValueAxis, Marker, Rectangle2D) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Draws a vertical line on the chart to represent a 'range marker'.
drawDomainMarker(Graphics2D, XYPlot, ValueAxis, Marker, Rectangle2D) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Draws the specified marker against the domain axis.
drawDomainTickBands(Graphics2D, Rectangle2D, List) - Method in class org.jfree.chart.plot.XYPlot
Draws the domain tick bands, if any.
DrawEmpty - Class in jplot3d.draw
 
DrawEmpty() - Constructor for class jplot3d.draw.DrawEmpty
 
drawFunc() - Method in class fitter.Fitter
Draw a function using current settings
drawGlyphVector(GlyphVector, float, float) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws the specified glyph vector at the location (x, y).
drawgrid - Variable in class graph.Axis
If true draw a grid positioned on major ticks over the graph
drawgrid - Variable in class graph.Graph2D
If set true (the default) a grid will be drawn over the data window.
drawGrid(int) - Method in class jplot.GraphSettings
Returns true if the grid should be drawn.
DrawH2D - Class in jplot3d.draw
Show H2D histogram
DrawH2D() - Constructor for class jplot3d.draw.DrawH2D
 
drawHorizontalItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Draws the visual representation of a single data item when the plot has a horizontal orientation.
drawHorizontalItem(Graphics2D, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Draws the visual representation of a single data item.
drawImage(Image, int, int, ImageObserver) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws an image at the location (x, y).
drawImage(Image, int, int, int, int, ImageObserver) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws an image at the location (x, y).
drawImage(Image, int, int, Color, ImageObserver) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws an image at the location (x, y).
drawImage(Image, int, int, int, int, Color, ImageObserver) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws an image to the rectangle (x, y, w, h) (scaling it if required), first filling the background with the specified color.
drawImage(Image, int, int, int, int, int, int, int, int, ImageObserver) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws part of an image (defined by the source rectangle (sx1, sy1, sx2, sy2)) into the destination rectangle (dx1, dy1, dx2, dy2).
drawImage(Image, int, int, int, int, int, int, int, int, Color, ImageObserver) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws part of an image (defined by the source rectangle (sx1, sy1, sx2, sy2)) into the destination rectangle (dx1, dy1, dx2, dy2).
drawImage(Image, AffineTransform, ImageObserver) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws an image with the specified transform.
drawImage(BufferedImage, BufferedImageOp, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws the image resulting from applying the BufferedImageOp to the specified image at the location (x, y).
DRAWING_FINISHED - Static variable in class org.jfree.chart.event.ChartProgressEvent
Indicates drawing has finished.
DRAWING_STARTED - Static variable in class org.jfree.chart.event.ChartProgressEvent
Indicates drawing has started.
DrawingPanel - Class in jhplot.utils
 
DrawingSupplier - Interface in org.jfree.chart.plot
A supplier of Paint, Stroke and Shape objects for use by plots and renderers.
drawInner() - Method in class jplot.GraphSettings
Enables the drawing of the inner triangles for a Piper diagram.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.AreaRenderer
Draw a single data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.BarRenderer
Draws the bar for a single (series, category) data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Draws a 3D bar to represent one data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Draw a single data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Draws a single data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.CategoryStepRenderer
Draw a single data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.GanttRenderer
Draws the bar for a single (series, category) data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.GroupedStackedBarRenderer
Draws a stacked bar for a specific item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.IntervalBarRenderer
Draws the bar for a single (series, category) data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.LayeredBarRenderer
Draws the bar for one item in the dataset.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.LevelRenderer
Draws the bar for a single (series, category) data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Draw a single data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Draw a single data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Draw a single data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Draw a single data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.StackedAreaRenderer
Draw a single data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.StackedBarRenderer
Draws a stacked bar for a specific item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.StackedBarRenderer3D
Draws the visual representation of one data item from the chart (in fact, this method does nothing until it reaches the last item for each category, at which point it draws all the items for that category).
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.StatisticalBarRenderer
Draws the bar with its standard deviation line range for a single (series, category) data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.StatisticalLineAndShapeRenderer
Draw a single data item.
drawItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int, int) - Method in class org.jfree.chart.renderer.category.WaterfallBarRenderer
Draws the bar for a single (series, category) data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.ClusteredXYBarRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.CyclicXYItemRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.DeviationRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.SamplingXYLineRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer2
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.StackedXYBarRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.VectorRenderer
Draws the block representing the specified item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.WindItemRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer2
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Draws the block representing the specified item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYBubbleRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYDotRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Draws the visual representation for one data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Called for each item to be plotted.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Draws the block representing the specified item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYStepRenderer
Draws the visual representation of a single data item.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.YIntervalRenderer
Draws the visual representation of a single data item.
drawLegend() - Method in class jplot.GraphSettings
Returns whether or not to draw the legend box in a graph corner.
drawLegend() - Method in class jplot.LinePars
Returns true if this linestyle should draw the name in the legend of the graph, false otherwise
drawLine() - Method in class jplot.LinePars
Returns whether or not drawing the lines
drawLine(int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws a line from (x1, y1) to (x2, y2) using the current paint and stroke.
drawMirrorAxis(int) - Method in class jplot.GraphSettings
Returns whether the mirror of an axis will be drawn or not.
drawMirrorTics(int) - Method in class jplot.GraphSettings
Returns whether or not we should draw tics on the mirror axis.
drawNext(IDataSet) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
draws data set on current pad and advances active pad by one.
DrawOptions - Class in jhplot
Main class which sets graphic attributes for all jHPlot classes (histograms and data holders).
DrawOptions() - Constructor for class jhplot.DrawOptions
Sets drawing options for all objects.
drawOutline(Graphics2D, Rectangle2D) - Method in class org.jfree.chart.plot.Plot
Draws the plot outline.
drawOutline(Graphics2D, CategoryPlot, Rectangle2D) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Draws an outline for the data area.
drawOutline(Graphics2D, CategoryPlot, Rectangle2D) - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Draws the outline for the plot.
drawOutline(Graphics2D, CategoryPlot, Rectangle2D) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Draws an outline for the data area.
drawOutline(Graphics2D, CategoryPlot, Rectangle2D) - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Draws the outline for the plot.
drawOval(int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws an oval framed by the rectangle (x, y, width, height) using the current paint and stroke.
DrawP2D - Class in jplot3d.draw
 
DrawP2D() - Constructor for class jplot3d.draw.DrawP2D
 
DrawP3D - Class in jplot3d.draw
 
DrawP3D() - Constructor for class jplot3d.draw.DrawP3D
 
drawPave(Graphics2D, int, int) - Method in class org.jlab.groot.ui.PaveText
 
DrawPlain - Class in jplot3d.draw
 
DrawPlain() - Constructor for class jplot3d.draw.DrawPlain
 
DrawPlain2 - Class in jplot3d.draw
 
DrawPlain2() - Constructor for class jplot3d.draw.DrawPlain2
 
drawPoints() - Method in class jminhep.gui.Plotter
draw all points for the DataHolder and raw iX and iY
drawPointType(int, Color, double, double, float) - Static method in class jhplot.utils.PointsShapes
Draws a point-type corresponding to a symbolic constant, yielding values from 0 to NO_SYMBOL (==13).
drawPointType(int, Graphics2D, double, double, float) - Static method in class jplot.GPoints
Draws a point-type corresponding to a symbolic constant, yielding values from 0 to NO_SYMBOL (==13).
drawPolygon(int[], int[], int) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws the specified polygon using the current paint and stroke.
drawPolyline(int[], int[], int) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws the specified multi-segment line using the current paint and stroke.
drawPolylineArrow(Graphics, int[], int[], int, int) - Method in class jplot.GraphGeneral
Draw arrow
drawRadialGridLines(Graphics2D, PolarPlot, ValueAxis, List, Rectangle2D) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Draw the radial gridlines - the rings.
drawRadialGridLines(Graphics2D, PolarPlot, ValueAxis, List, Rectangle2D) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Draw the radial gridlines - the rings.
drawRangeGridline(Graphics2D, CategoryPlot, ValueAxis, Rectangle2D, double) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Draws a grid line against the range axis.
drawRangeGridline(Graphics2D, CategoryPlot, ValueAxis, Rectangle2D, double) - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Draws a grid line against the range axis.
drawRangeGridline(Graphics2D, CategoryPlot, ValueAxis, Rectangle2D, double) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Draws a grid line against the range axis.
drawRangeGridline(Graphics2D, CategoryPlot, ValueAxis, Rectangle2D, double) - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Draws a grid line against the range axis.
drawRangeLine(Graphics2D, CategoryPlot, ValueAxis, Rectangle2D, double, Paint, Stroke) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Draws a line perpendicular to the range axis.
drawRangeLine(Graphics2D, CategoryPlot, ValueAxis, Rectangle2D, double, Paint, Stroke) - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Draws a line perpendicular to the range axis.
drawRangeLine(Graphics2D, XYPlot, ValueAxis, Rectangle2D, double, Paint, Stroke) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Draws a line perpendicular to the range axis.
drawRangeLine(Graphics2D, XYPlot, ValueAxis, Rectangle2D, double, Paint, Stroke) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Draws a line perpendicular to the range axis.
drawRangeMarker(Graphics2D, ContourPlot, ValueAxis, Marker, Rectangle2D) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Draws a horizontal line across the chart to represent a 'range marker'.
drawRangeMarker(Graphics2D, CategoryPlot, ValueAxis, Marker, Rectangle2D) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Draws a marker for the range axis.
drawRangeMarker(Graphics2D, CategoryPlot, ValueAxis, Marker, Rectangle2D) - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Draws a range marker.
drawRangeMarker(Graphics2D, CategoryPlot, ValueAxis, Marker, Rectangle2D) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Draws a line (or some other marker) to indicate a particular value on the range axis.
drawRangeMarker(Graphics2D, CategoryPlot, ValueAxis, Marker, Rectangle2D) - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Draws a range marker.
drawRangeMarker(Graphics2D, XYPlot, ValueAxis, Marker, Rectangle2D) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Draws a horizontal line across the chart to represent a 'range marker'.
drawRangeMarker(Graphics2D, XYPlot, ValueAxis, Marker, Rectangle2D) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Draws a horizontal line across the chart to represent a 'range marker'.
drawRangeTickBands(Graphics2D, Rectangle2D, List) - Method in class org.jfree.chart.plot.XYPlot
Draws the range tick bands, if any.
drawRenderableImage(RenderableImage, AffineTransform) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws the renderable image.
drawRenderedImage(RenderedImage, AffineTransform) - Method in class org.jfree.chart.fx.FXGraphics2D
 
drawRotatedString(AttributedString, Graphics2D, double, float, float) - Static method in class org.jfree.chart.util.AttrStringUtils
Draws the attributed string at (x, y), rotated by the specified angle about (x, y).
drawRotatedString(AttributedString, Graphics2D, float, float, double, float, float) - Static method in class org.jfree.chart.util.AttrStringUtils
Draws the attributed string at (textX, textY), rotated by the specified angle about (rotateX, rotateY).
drawRotatedString(AttributedString, Graphics2D, float, float, TextAnchor, double, float, float) - Static method in class org.jfree.chart.util.AttrStringUtils
Draws the string anchored to (x, y), rotated by the specified angle about (rotationX, rotationY).
drawRotatedString(AttributedString, Graphics2D, float, float, TextAnchor, double, TextAnchor) - Static method in class org.jfree.chart.util.AttrStringUtils
Draws a rotated string.
drawRoundRect(int, int, int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws a rectangle with rounded corners using the current paint and stroke.
drawSeries(Graphics2D, Rectangle2D, PlotRenderingInfo, PolarPlot, XYDataset, int) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Plots the data for a given series.
drawSeries(Graphics2D, Rectangle2D, PlotRenderingInfo, PolarPlot, XYDataset, int) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Plots the data for a given series.
drawShadow() - Method in class jplot.GraphSettings
Returns whether or not a shadow will be drawn at the panel border.
drawStatBox(H1D) - Method in class jhplot.HPlot
Draw a statistical box (mean, RMS, number of entries)
drawStatBox(H1D, int, int) - Method in class jhplot.HPlot
Draw a statistical box (mean, RMS, number of entries) at a specific position.
drawStatBox(H1D, double, double, String) - Method in class jhplot.HPlot
Draw a statistical box (mean, RMS, number of entries) at a specific position.
drawString(String, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws a string at (x, y).
drawString(String, float, float) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws a string at (x, y).
drawString(AttributedCharacterIterator, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws a string of attributed characters at (x, y).
drawString(AttributedCharacterIterator, float, float) - Method in class org.jfree.chart.fx.FXGraphics2D
Draws a string of attributed characters at (x, y).
drawString(Graphics2D, int, int, int, int, int) - Method in class org.jlab.groot.ui.LatexText
 
drawString(Graphics2D, int, int, int, int) - Method in class org.jlab.groot.ui.LatexText
 
DrawSurface - Class in jplot3d.draw
 
DrawSurface() - Constructor for class jplot3d.draw.DrawSurface
 
drawSymbol() - Method in class jplot.LinePars
Returns whether or not drawing the symbol
drawTds() - Method in class jplot.GraphSettings
Returns true if the tds circle should be drawn.
drawTextBox(String[]) - Method in class jhplot.HPlot
Draw a text box with some information
drawTickMarks(Graphics2D, double, Rectangle2D, RectangleEdge, AxisState) - Method in class org.jfree.chart.axis.CategoryAxis
Draws the tick marks.
drawTicLabels(int) - Method in class jplot.GraphSettings
Returns whether or not to draw tic labels.
drawTics(int) - Method in class jplot.GraphSettings
Returns whether or not to draw tics (little lines on the axes).
drawToGraphics2D(Graphics2D, int, int) - Method in class jhplot.HChart
 
drawVerticalItem(Graphics2D, CategoryItemRendererState, Rectangle2D, CategoryPlot, CategoryAxis, ValueAxis, CategoryDataset, int, int) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Draws the visual representation of a single data item when the plot has a vertical orientation.
drawVerticalItem(Graphics2D, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Draws the visual representation of a single data item.
drawVolume() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Deprecated.
As of 1.0.5, you should use the CandlestickRenderer.getDrawVolume() method.
DrawWireframe - Class in jplot3d.draw
 
DrawWireframe() - Constructor for class jplot3d.draw.DrawWireframe
 
drawzero - Variable in class graph.Axis
If true draw a line positioned on the Zero label tick mark.
drawzero - Variable in class graph.Graph2D
If set true (the default) a grid line will be drawn across the data window at the zeros of the innermost axes.
dropRowCol(Object[][], int, int) - Static method in class org.lsmp.djep.vectorJep.function.Determinant
returns a matrix excluding the specifyed row and column
drot(DoubleMatrix1D, DoubleMatrix1D, double, double) - Method in interface cern.colt.matrix.linalg.Blas
Applies a givens plane rotation to (x,y); x = c*x + s*y; y = c*y - s*x.
drot(DoubleMatrix1D, DoubleMatrix1D, double, double) - Method in class cern.colt.matrix.linalg.SeqBlas
 
drot(DoubleMatrix1D, DoubleMatrix1D, double, double) - Method in class cern.colt.matrix.linalg.SmpBlas
 
drotg(double, double, double[]) - Method in interface cern.colt.matrix.linalg.Blas
Constructs a Givens plane rotation for (a,b).
drotg(double, double, double[]) - Method in class cern.colt.matrix.linalg.SeqBlas
 
drotg(double, double, double[]) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dscal(double, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Vector scaling; x = alpha*x.
dscal(double, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Matrix scaling; A = alpha*A.
dscal(double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dscal(double, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dscal(double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dscal(double, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
DSCompiler - Class in org.apache.commons.math3.analysis.differentiation
Class holding "compiled" computation rules for derivative structures.
DstNormalization - Enum in org.apache.commons.math3.transform
This enumeration defines the various types of normalizations that can be applied to discrete sine transforms (DST).
dswap(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Swaps the elements of two vectors; y <==> x.
dswap(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Swaps the elements of two matrices; B <==> A.
dswap(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dswap(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dswap(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dswap(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
DSymbolTable - Class in org.lsmp.djep.djep
A SymbolTable which works with partial derivatives of variables.
DSymbolTable(VariableFactory) - Constructor for class org.lsmp.djep.djep.DSymbolTable
 
dsymv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Symmetric matrix-vector multiplication; y = alpha*A*x + beta*y.
dsymv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dsymv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dt() - Method in class hep.lcio.util.MergeFileParameters
Get the delta time in ns.
dtrmv(boolean, boolean, boolean, DoubleMatrix2D, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Triangular matrix-vector multiplication; x = A*x or x = A'*x.
dtrmv(boolean, boolean, boolean, DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dtrmv(boolean, boolean, boolean, DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dualPartition(double[], double[], int, int, double[], int, int, int[]) - Static method in class cern.colt.Partitioning
Same as Partitioning.dualPartition(int[],int[],int,int,int[],int,int,int[]) except that it synchronously partitions double[] rather than int[] arrays.
dualPartition(double[], double[], int, int, double) - Static method in class cern.colt.Partitioning
Same as Partitioning.dualPartition(int[],int[],int,int,int) except that it synchronously partitions double[] rather than int[] arrays.
dualPartition(int[], int[], int, int, int[], int, int, int[]) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that this method synchronously partitions two arrays at the same time; both arrays are partially sorted according to the elements of the primary array.
dualPartition(int[], int[], int, int, int) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int) except that this method synchronously partitions two arrays at the same time; both arrays are partially sorted according to the elements of the primary array.
DUALSHADE - Static variable in class jplot3d.ColorModel
 
DummyLocalizable - Class in org.apache.commons.math3.exception.util
Dummy implementation of the Localizable interface, without localization.
DummyLocalizable(String) - Constructor for class org.apache.commons.math3.exception.util.DummyLocalizable
Simple constructor.
DummyStepHandler - Class in org.apache.commons.math3.ode.sampling
This class is a step handler that does nothing.
dump(Element, SIOReader) - Method in class hep.lcio.util.SIODump
 
dump(byte[], long, OutputStream, int) - Static method in class org.apache.commons.io.HexDump
Dump an array of bytes to an OutputStream.
dump(String) - Method in class org.nfunk.jep.SimpleNode
 
dumpEvent(LCEvent) - Static method in class hep.lcio.example.LCTools
 
dumpParticleHierarchy(Particle) - Static method in class hep.physics.particle.ParticleUtilities
Dump the particle heirarchy within the event to System.out
dumpParticleHierarchy(Particle, PrintStream) - Static method in class hep.physics.particle.ParticleUtilities
Dump the particle heirarchy within the event
dumpParticleHierarchy(Particle, PrintWriter) - Static method in class hep.physics.particle.ParticleUtilities
 
durbinWatson(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Durbin-Watson computation.
DurhamJetFinder - Class in hep.physics.jet
 
DurhamJetFinder(double) - Constructor for class hep.physics.jet.DurhamJetFinder
 
DVariable - Class in org.lsmp.djep.djep
Holds all info about a variable.
DVariableFactory - Class in org.lsmp.djep.djep
A VariableFactory which can work with PartialDerivatives.
DVariableFactory() - Constructor for class org.lsmp.djep.djep.DVariableFactory
 
DWORD - Static variable in class org.jfree.chart.util.HexNumberFormat
Number of hexadecimal digits for a double word.
dx - Variable in class Jampack.Zdiagmat
The index of the last diagonal (public)
dx - Variable in class jplot.Contour
Size of step in X and Y, Z
dy - Variable in class jplot.Contour
Size of step in X and Y, Z
DynamicBin1D - Class in cern.hep.aida.bin
1-dimensional rebinnable bin holding double elements; Efficiently computes advanced statistics of data sequences.
DynamicBin1D() - Constructor for class cern.hep.aida.bin.DynamicBin1D
Constructs and returns an empty bin; implicitly calls setFixedOrder(false).
DynamicDriveToolTipTagFragmentGenerator - Class in org.jfree.chart.imagemap
Generates tooltips using the Dynamic Drive DHTML Tip Message library (http://www.dynamicdrive.com).
DynamicDriveToolTipTagFragmentGenerator() - Constructor for class org.jfree.chart.imagemap.DynamicDriveToolTipTagFragmentGenerator
Blank constructor.
DynamicDriveToolTipTagFragmentGenerator(String, int) - Constructor for class org.jfree.chart.imagemap.DynamicDriveToolTipTagFragmentGenerator
Creates a new generator with specific title and style settings.
DynamicTimeSeriesCollection - Class in org.jfree.data.time
A dynamic dataset.
DynamicTimeSeriesCollection(int, int) - Constructor for class org.jfree.data.time.DynamicTimeSeriesCollection
Constructs a dataset with capacity for N series, tied to default timezone.
DynamicTimeSeriesCollection(int, int, TimeZone) - Constructor for class org.jfree.data.time.DynamicTimeSeriesCollection
Constructs an empty dataset, tied to a specific timezone.
DynamicTimeSeriesCollection(int, int, RegularTimePeriod) - Constructor for class org.jfree.data.time.DynamicTimeSeriesCollection
Creates a new dataset.
DynamicTimeSeriesCollection(int, int, RegularTimePeriod, TimeZone) - Constructor for class org.jfree.data.time.DynamicTimeSeriesCollection
Creates a new dataset.
DynamicTree - Class in org.jlab.groot.tree
 
DynamicTree(String) - Constructor for class org.jlab.groot.tree.DynamicTree
 
dz - Variable in class jplot.Contour
Size of step in X and Y, Z

E

e(int, int) - Method in class hep.physics.matrix.BasicMatrix
 
e(int, int) - Method in interface hep.physics.matrix.Matrix
Returns the value of the given element
e(int, int) - Method in class hep.physics.matrix.SymmetricMatrix
Returns a specific element
e(int, int) - Method in class hep.physics.vec.BasicHep3Matrix
Returns the (row, column) element
e() - Method in class hephysics.jet.ParticleD
Get energy.
e(int, int) - Method in class hephysics.matrix.BasicMatrix
 
e(int, int) - Method in interface hephysics.matrix.Matrix
Returns the value of the given element
e(int, int) - Method in class hephysics.matrix.SymmetricMatrix
Returns a specific element
e(int, int) - Method in class hephysics.vec.Hep3Matrix
Returns the (row, column) element
e() - Method in class hephysics.vec.HepLorentzVector
Get energy
e() - Method in class j4np.physics.LorentzVector
 
E - Static variable in class org.apache.commons.math3.util.FastMath
Napier's constant e, base of the natural logarithm.
e_SI - Static variable in class cern.clhep.Units
 
e_squared - Static variable in class cern.clhep.PhysicalConstants
 
EarthMoversDistance - Class in org.apache.commons.math3.ml.distance
Calculates the Earh Mover's distance (also known as Wasserstein metric) between two distributions.
EarthMoversDistance() - Constructor for class org.apache.commons.math3.ml.distance.EarthMoversDistance
 
EAST_ABOVE - Static variable in class org.jfree.chart.plot.PolarAxisLocation
Axis above east.
EAST_BELOW - Static variable in class org.jfree.chart.plot.PolarAxisLocation
Axis below east.
ebeAdd(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates an array whose contents will be the element-by-element addition of the arguments.
ebeDivide(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Element-by-element division.
ebeDivide(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Element-by-element division.
ebeDivide(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Element-by-element division.
ebeDivide(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Element-by-element division.
ebeDivide(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Element-by-element division.
ebeDivide(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Element-by-element division.
ebeDivide(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Element-by-element division.
ebeDivide(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates an array whose contents will be the element-by-element division of the first argument by the second.
ebeMultiply(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Element-by-element multiplication.
ebeMultiply(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Element-by-element multiplication.
ebeMultiply(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Element-by-element multiplication.
ebeMultiply(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Element-by-element multiplication.
ebeMultiply(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Element-by-element multiplication.
ebeMultiply(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Element-by-element multiplication.
ebeMultiply(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Element-by-element multiplication.
ebeMultiply(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates an array whose contents will be the element-by-element multiplication of the arguments.
ebeSubtract(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates an array whose contents will be the element-by-element subtraction of the second argument from the first.
ECHARGE - Static variable in class graph.SpecialFunction
Elementary Charge.
ECM_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
ECM_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
ECM_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
ECM_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
Edge - Class in org.apache.commons.math3.geometry.spherical.twod
Spherical polygons boundary edge.
edges(IAxis) - Method in class cern.hep.aida.ref.Converter
Returns all edges of the given axis.
EDGES_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
edit(Tree) - Method in class org.jlab.groot.tree.AbstractDescriptor
 
edit(Tree) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
editDescriptor(DatasetDescriptor) - Method in class org.jlab.groot.studio.StudioUI
 
edm() - Method in class org.freehep.math.minuit.FunctionMinimum
returns the expected vertical distance to the minimum (EDM)
edm() - Method in class org.freehep.math.minuit.MnUserParameterState
Returns the expected vertival distance to the minimum (EDM)
EEcentricity - Class in jhplot.stat
A class for eccentricity calculations using a principle component analysis.
EEcentricity(double[], double[], double[]) - Constructor for class jhplot.stat.EEcentricity
Initialize 2D PCA analysis
EEcentricity(P1D) - Constructor for class jhplot.stat.EEcentricity
Perform PCA analysis using P1D object (in 2D).
Effect3D - Interface in org.jfree.chart
An interface that should be implemented by renderers that use a 3D effect.
EFile - Class in jhplot.io
Write data structures in sequential order into ntuples using Google's Prototype Buffer.
EFile(String, String) - Constructor for class jhplot.io.EFile
Open a file to write/read objects to/from a file in sequential order.
EFile(String) - Constructor for class jhplot.io.EFile
Open file for reading objects from a serialized file in sequential order.
eig() - Method in class Jama.Matrix
Eigenvalue Decomposition
Eig - Class in Jampack
Eig implements the eigenvalue-vector decomposition of of a square matrix.
Eig(Zmat) - Constructor for class Jampack.Eig
Creates an eigenvalue-vector decomposition of a square matrix A.
eigen(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
EigenDecomposition - Class in org.apache.commons.math3.linear
Calculates the eigen decomposition of a real matrix.
EigenDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.EigenDecomposition
Calculates the eigen decomposition of the given real matrix.
EigenDecomposition(RealMatrix, double) - Constructor for class org.apache.commons.math3.linear.EigenDecomposition
Deprecated.
in 3.1 (to be removed in 4.0) due to unused parameter
EigenDecomposition(double[], double[]) - Constructor for class org.apache.commons.math3.linear.EigenDecomposition
Calculates the eigen decomposition of the symmetric tridiagonal matrix.
EigenDecomposition(double[], double[], double) - Constructor for class org.apache.commons.math3.linear.EigenDecomposition
Deprecated.
in 3.1 (to be removed in 4.0) due to unused parameter
EigenvalueDecomposition - Class in cern.colt.matrix.linalg
Eigenvalues and eigenvectors of a real matrix A.
EigenvalueDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.linalg.EigenvalueDecomposition
Constructs and returns a new eigenvalue decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
EigenvalueDecomposition - Class in Jama
Eigenvalues and eigenvectors of a real matrix.
EigenvalueDecomposition(Matrix) - Constructor for class Jama.EigenvalueDecomposition
Check for symmetry, then construct the eigenvalue decomposition Structure to access D and V.
eigenvalues(MnUserCovariance) - Static method in class org.freehep.math.minuit.MnEigen
 
elapsedTime() - Method in class cern.colt.Timer
Same as seconds().
Ele - Class in org.lsmp.djep.vectorJep.function
ele(x,i) returns the i-th element of a vector x.
Ele() - Constructor for class org.lsmp.djep.vectorJep.function.Ele
 
Ele - Class in org.nfunk.jep.function
Function which allows array access using the a[3] notation on left and right hand side.
Ele() - Constructor for class org.nfunk.jep.function.Ele
 
electron_charge - Static variable in class cern.clhep.PhysicalConstants
 
electron_Compton_length - Static variable in class cern.clhep.PhysicalConstants
 
electron_mass_c2 - Static variable in class cern.clhep.PhysicalConstants
 
ELECTRONS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent
 
electronvolt - Static variable in class cern.clhep.Units
 
elementary() - Method in class jhplot.F1D
Convert this function rewrite in term of elementary functions (log, exp, frac, sqrt, implicit roots) This is useful before simplifying function.
elementary() - Method in class jhplot.F2D
Convert this function rewrite in term of elementary functions (log, exp, frac, sqrt, implicit roots) This is useful before simplifying function.
ElementComparative - Class in org.lsmp.djep.vectorJep.function
Multiplies any number of Vectors or Matrices element by element.
ElementComparative(int) - Constructor for class org.lsmp.djep.vectorJep.function.ElementComparative
 
ElementDivide - Class in org.lsmp.djep.vectorJep.function
Multiplies any number of Vectors or Matrices element by element.
ElementDivide() - Constructor for class org.lsmp.djep.vectorJep.function.ElementDivide
 
ElementMultiply - Class in org.lsmp.djep.vectorJep.function
Multiplies any number of Vectors or Matricies element by element.
ElementMultiply() - Constructor for class org.lsmp.djep.vectorJep.function.ElementMultiply
 
elements() - Method in class cern.colt.bitvector.BitVector
You normally need not use this method.
elements(long[], int) - Method in class cern.colt.bitvector.BitVector
You normally need not use this method.
elements() - Method in class cern.colt.list.AbstractBooleanList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(boolean[]) - Method in class cern.colt.list.AbstractBooleanList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractByteList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(byte[]) - Method in class cern.colt.list.AbstractByteList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractCharList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(char[]) - Method in class cern.colt.list.AbstractCharList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractDoubleList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(double[]) - Method in class cern.colt.list.AbstractDoubleList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractFloatList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(float[]) - Method in class cern.colt.list.AbstractFloatList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractIntList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(int[]) - Method in class cern.colt.list.AbstractIntList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractLongList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(long[]) - Method in class cern.colt.list.AbstractLongList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractShortList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(short[]) - Method in class cern.colt.list.AbstractShortList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.BooleanArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(boolean[]) - Method in class cern.colt.list.BooleanArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.ByteArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(byte[]) - Method in class cern.colt.list.ByteArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.CharArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(char[]) - Method in class cern.colt.list.CharArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.DoubleArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(double[]) - Method in class cern.colt.list.DoubleArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.FloatArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(float[]) - Method in class cern.colt.list.FloatArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.IntArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(int[]) - Method in class cern.colt.list.IntArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.LongArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(long[]) - Method in class cern.colt.list.LongArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.ObjectArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(Object[]) - Method in class cern.colt.list.ObjectArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.ShortArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(short[]) - Method in class cern.colt.list.ShortArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns a copy of the currently stored elements.
ElitisticListPopulation - Class in org.apache.commons.math3.genetics
Population of chromosomes which uses elitism (certain percentage of the best chromosomes is directly copied to the next generation).
ElitisticListPopulation(List<Chromosome>, int, double) - Constructor for class org.apache.commons.math3.genetics.ElitisticListPopulation
Creates a new ElitisticListPopulation instance.
ElitisticListPopulation(int, double) - Constructor for class org.apache.commons.math3.genetics.ElitisticListPopulation
Creates a new ElitisticListPopulation instance and initializes its inner chromosome list.
Ellipse - Class in jhplot.shapes
Draw an ellipse in the USER coordinate system
Ellipse(double, double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.Ellipse
Create an ellipse with given semimajor and semiminor axes, centered on (x, y).
Ellipse(double, double, double, double) - Constructor for class jhplot.shapes.Ellipse
Create an ellipse using the default stroke and the color
ELLIPSE - Static variable in class jhplot.shapes.HShape
 
elm_coupling - Static variable in class cern.clhep.PhysicalConstants
 
EMASS - Static variable in class graph.SpecialFunction
Electron Mass.
EmbeddedCanvas - Class in org.jlab.groot.graphics
 
EmbeddedCanvas() - Constructor for class org.jlab.groot.graphics.EmbeddedCanvas
 
EmbeddedCanvas(EmbeddedPad) - Constructor for class org.jlab.groot.graphics.EmbeddedCanvas
 
EmbeddedCanvasGroup - Class in org.jlab.groot.graphics
 
EmbeddedCanvasGroup() - Constructor for class org.jlab.groot.graphics.EmbeddedCanvasGroup
 
EmbeddedCanvasTabbed - Class in org.jlab.groot.graphics
 
EmbeddedCanvasTabbed() - Constructor for class org.jlab.groot.graphics.EmbeddedCanvasTabbed
 
EmbeddedCanvasTabbed(boolean) - Constructor for class org.jlab.groot.graphics.EmbeddedCanvasTabbed
 
EmbeddedCanvasTabbed(String...) - Constructor for class org.jlab.groot.graphics.EmbeddedCanvasTabbed
 
EmbeddedPad - Class in org.jlab.groot.graphics
 
EmbeddedPad() - Constructor for class org.jlab.groot.graphics.EmbeddedPad
 
EmbeddedPad(int, int, int, int) - Constructor for class org.jlab.groot.graphics.EmbeddedPad
 
EmbeddedPad.EmbeddedPadConfigurationPane - Class in org.jlab.groot.graphics
 
EmbeddedPadConfigurationPane(EmbeddedPad) - Constructor for class org.jlab.groot.graphics.EmbeddedPad.EmbeddedPadConfigurationPane
 
EmbeddedRungeKuttaFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements the common part of all embedded Runge-Kutta integrators for Ordinary Differential Equations.
EmbeddedRungeKuttaIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the common part of all embedded Runge-Kutta integrators for Ordinary Differential Equations.
EmbeddedToolbar - Class in org.jlab.groot.ui
 
EmbeddedToolbar() - Constructor for class org.jlab.groot.ui.EmbeddedToolbar
 
Embedding<S extends Space,T extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface defines mappers between a space and one of its sub-spaces.
Empirical - Class in cern.jet.random
Empirical distribution.
Empirical(double[], int, RandomEngine) - Constructor for class cern.jet.random.Empirical
Constructs an Empirical distribution.
EmpiricalDistribution - Class in org.apache.commons.math3.random
Represents an empirical probability distribution -- a probability distribution derived from observed data without making any assumptions about the functional form of the population distribution that the data come from.
EmpiricalDistribution() - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Creates a new EmpiricalDistribution with the default bin count.
EmpiricalDistribution(int) - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Creates a new EmpiricalDistribution with the specified bin count.
EmpiricalDistribution(int, RandomGenerator) - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Creates a new EmpiricalDistribution with the specified bin count using the provided RandomGenerator as the source of random data.
EmpiricalDistribution(RandomGenerator) - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Creates a new EmpiricalDistribution with default bin count using the provided RandomGenerator as the source of random data.
EmpiricalDistribution(int, RandomDataImpl) - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Deprecated.
EmpiricalDistribution(RandomDataImpl) - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Deprecated.
EmpiricalWalker - Class in cern.jet.random
Discrete Empirical distribution (pdf's can be specified).
EmpiricalWalker(double[], int, RandomEngine) - Constructor for class cern.jet.random.EmpiricalWalker
Constructs an Empirical distribution.
EMPTY - Static variable in class org.apache.commons.io.filefilter.EmptyFileFilter
Singleton instance of empty filter
EMPTY_DELETE_OPTION_ARRAY - Static variable in class org.apache.commons.io.file.PathUtils
Empty LinkOption array.
EMPTY_FILE_ARRAY - Static variable in class org.apache.commons.io.FileUtils
An empty array of type File.
EMPTY_FILE_VISIT_OPTION_ARRAY - Static variable in class org.apache.commons.io.file.PathUtils
Empty FileVisitOption array.
EMPTY_LINK_OPTION_ARRAY - Static variable in class org.apache.commons.io.file.PathUtils
Empty LinkOption array.
EMPTY_OPEN_OPTION_ARRAY - Static variable in class org.apache.commons.io.file.PathUtils
Empty OpenOption array.
EMPTY_STRING_ARRAY - Static variable in interface org.apache.commons.io.filefilter.IOFileFilter
An empty String array.
EmptyBlock - Class in org.jfree.chart.block
An empty block with a fixed size.
EmptyBlock(double, double) - Constructor for class org.jfree.chart.block.EmptyBlock
Creates a new block with the specified width and height.
EmptyFileFilter - Class in org.apache.commons.io.filefilter
This filter accepts files or directories that are empty.
enable_tracing() - Method in class jplot3dp.MathParser.MathParser
 
enable_tracing() - Method in class org.nfunk.jep.Parser
 
enableDoubleBuffering(Component) - Static method in class jhplot.gui.GHPanel
 
enclose(Iterable<P>) - Method in interface org.apache.commons.math3.geometry.enclosing.Encloser
Find a ball enclosing a list of points.
enclose(Iterable<P>) - Method in class org.apache.commons.math3.geometry.enclosing.WelzlEncloser
Find a ball enclosing a list of points.
Encloser<S extends Space,P extends Point<S>> - Interface in org.apache.commons.math3.geometry.enclosing
Interface for algorithms computing enclosing balls.
EnclosingBall<S extends Space,P extends Point<S>> - Class in org.apache.commons.math3.geometry.enclosing
This class represents a ball enclosing some points.
EnclosingBall(P, double, P...) - Constructor for class org.apache.commons.math3.geometry.enclosing.EnclosingBall
Simple constructor.
encode(int, int) - Static method in class hep.lcio.implementation.sio.SIOVersion
Returns the version encoded in one word.
encode(String) - Static method in class jplot.Translate
Encode a string to use references.
encode(BufferedImage, String) - Static method in class org.jfree.chart.encoders.EncoderUtil
Encode the image in a specific format.
encode(BufferedImage, String, boolean) - Static method in class org.jfree.chart.encoders.EncoderUtil
Encode the image in a specific format.
encode(BufferedImage, String, float) - Static method in class org.jfree.chart.encoders.EncoderUtil
Encode the image in a specific format.
encode(BufferedImage, String, float, boolean) - Static method in class org.jfree.chart.encoders.EncoderUtil
Encode the image in a specific format.
encode(BufferedImage) - Method in interface org.jfree.chart.encoders.ImageEncoder
Encodes an image in a particular format.
encode(BufferedImage, OutputStream) - Method in interface org.jfree.chart.encoders.ImageEncoder
Encodes an image in a particular format and writes it to an OutputStream.
encode(BufferedImage) - Method in class org.jfree.chart.encoders.KeypointPNGEncoderAdapter
Encodes an image in PNG format.
encode(BufferedImage, OutputStream) - Method in class org.jfree.chart.encoders.KeypointPNGEncoderAdapter
Encodes an image in PNG format and writes it to an OutputStream.
encode(BufferedImage) - Method in class org.jfree.chart.encoders.SunJPEGEncoderAdapter
Encodes an image in JPEG format.
encode(BufferedImage, OutputStream) - Method in class org.jfree.chart.encoders.SunJPEGEncoderAdapter
Encodes an image in JPEG format and writes it to an output stream.
encode(BufferedImage) - Method in class org.jfree.chart.encoders.SunPNGEncoderAdapter
Encodes an image in PNG format.
encode(BufferedImage, OutputStream) - Method in class org.jfree.chart.encoders.SunPNGEncoderAdapter
Encodes an image in PNG format and writes it to an OutputStream.
encode(String, String) - Static method in class org.jfree.chart.urls.URLUtilities
Calls java.net.URLEncoder.encode(String, String) via reflection, if we are running on JRE 1.4 or later, otherwise reverts to the deprecated URLEncoder.encode(String) method.
encodeAsPNG(BufferedImage) - Static method in class org.jfree.chart.ChartUtilities
Encodes a BufferedImage to PNG format.
encodeAsPNG(BufferedImage, boolean, int) - Static method in class org.jfree.chart.ChartUtilities
Encodes a BufferedImage to PNG format.
EncoderUtil - Class in org.jfree.chart.encoders
A collection of utility methods for encoding images and returning them as a byte[] or writing them directly to an OutputStream.
EncoderUtil() - Constructor for class org.jfree.chart.encoders.EncoderUtil
 
ENCODING_PATTERN - Static variable in class org.apache.commons.io.input.XmlStreamReader
Pattern capturing the encoding of the "xml" processing instruction.
end() - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor
End visiting a matrix.
end() - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor
End visiting a matrix.
end() - Method in class org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor
End visiting a matrix.
end() - Method in class org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math3.linear.FieldMatrixChangingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math3.linear.FieldMatrixPreservingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math3.linear.FieldVectorChangingVisitor
End visiting a vector.
end() - Method in interface org.apache.commons.math3.linear.FieldVectorPreservingVisitor
End visiting a vector.
end() - Method in interface org.apache.commons.math3.linear.RealMatrixChangingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math3.linear.RealMatrixPreservingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math3.linear.RealVectorChangingVisitor
End visiting a vector.
end() - Method in interface org.apache.commons.math3.linear.RealVectorPreservingVisitor
End visiting a vector.
END - Static variable in class org.jfree.chart.axis.CategoryAnchor
End of period.
END - Static variable in class org.jfree.chart.axis.DateTickMarkPosition
End of period.
END - Static variable in class org.jfree.data.time.DynamicTimeSeriesCollection
Useful constant for controlling the x-value returned for a time period.
END - Static variable in class org.jfree.data.time.TimePeriodAnchor
End of period.
END_OF_STREAM - Static variable in class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
The end of stream marker.
END_STATEMENT - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
endColumn - Variable in class jplot3dp.MathParser.Token
beginLine and beginColumn describe the position of the first character of this token; endLine and endColumn describe the position of the last character of this token.
endColumn - Variable in class org.nfunk.jep.Token
beginLine and beginColumn describe the position of the first character of this token; endLine and endColumn describe the position of the last character of this token.
endElement(String, String, String) - Method in class org.jfree.data.xml.CategoryDatasetHandler
The end of an element.
endElement(String, String, String) - Method in class org.jfree.data.xml.CategorySeriesHandler
The end of an element.
endElement(String, String, String) - Method in class org.jfree.data.xml.ItemHandler
The end of an element.
endElement(String, String, String) - Method in class org.jfree.data.xml.KeyHandler
The end of an element.
endElement(String, String, String) - Method in class org.jfree.data.xml.PieDatasetHandler
The end of an element.
endElement(String, String, String) - Method in class org.jfree.data.xml.ValueHandler
The end of an element.
EndianUtils - Class in org.apache.commons.io
Utility code for dealing with different endian systems.
EndianUtils() - Constructor for class org.apache.commons.io.EndianUtils
Instances should NOT be constructed in standard programming.
endLine - Variable in class jplot3dp.MathParser.Token
beginLine and beginColumn describe the position of the first character of this token; endLine and endColumn describe the position of the last character of this token.
endLine - Variable in class org.nfunk.jep.Token
beginLine and beginColumn describe the position of the first character of this token; endLine and endColumn describe the position of the last character of this token.
endOfBin(int) - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns the end of the range associated with the given bin.
endOfFileReached() - Method in class org.apache.commons.io.input.TailerListenerAdapter
Called each time the Tailer reaches the end of the file.
endSeriesPass(XYDataset, int, int, int, int, int) - Method in class org.jfree.chart.renderer.xy.XYItemRendererState
This method is called by the XYPlot when it ends a pass through the (visible) items in a series.
ENERGY_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
ENERGY_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
ENERGY_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent.Particles
 
ENERGY_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Photons
 
ensureAtLeast(AxisSpace) - Method in class org.jfree.chart.axis.AxisSpace
Ensures that this object reserves at least as much space as another.
ensureAtLeast(double, RectangleEdge) - Method in class org.jfree.chart.axis.AxisSpace
Ensures there is a minimum amount of space at the edge corresponding to the specified axis location.
ensureCapacity(byte[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(char[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(double[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(float[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(int[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(long[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(Object[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(short[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(boolean[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(int) - Method in class cern.colt.list.AbstractBooleanList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractByteList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractCharList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractDoubleList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractFloatList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractIntList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractLongList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractShortList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.BooleanArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.ByteArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.CharArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.DistinctNumberList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.DoubleArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.FloatArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.IntArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.LongArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.MinMaxNumberList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.ObjectArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.ShortArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.SimpleLongArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.AbstractMap
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.OpenDoubleIntHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.OpenIntDoubleHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.OpenIntIntHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.OpenIntObjectHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.OpenLongObjectHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.AbstractMatrix
Ensures that the receiver can hold at least the specified number of non-zero (non-null) cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureDirectory(File, File) - Static method in class jhepsim.Util
Ensures the existence of the directory specified by the parameter.
ensureDirectory(File, File) - Static method in class jhplot.utils.Util
Ensures the existence of the directory specified by the parameter.
ensureDirectory(File, File) - Static method in class jminhep.utils.Util
Ensures the existence of the directory specified by the parameter.
ensureFilePath(File, File) - Static method in class jhepsim.Util
Ensures the existence of the directory which may be part of the path specification of parameter file.
ensureFilePath(File, File) - Static method in class jhplot.utils.Util
Ensures the existence of the directory which may be part of the path specification of parameter file.
ensureFilePath(File, File) - Static method in class jminhep.utils.Util
Ensures the existence of the directory which may be part of the path specification of parameter file.
EntityBlockParams - Interface in org.jfree.chart.block
An interface that is used by the draw() method of some Block implementations to determine whether or not to generate entities for the items within the block.
EntityBlockResult - Interface in org.jfree.chart.block
Provides access to the EntityCollection generated when a block is drawn.
EntityCollection - Interface in org.jfree.chart.entity
This interface defines the methods used to access an ordered list of ChartEntity objects.
entries() - Method in interface colt.hep.aida.IHistogram
Number of in-range entries in the histogram.
entries() - Method in class jhplot.H1D
Number of in-range entries in the histogram
entries() - Method in class jhplot.H2D
Number of in-range entries in the histogram
entries() - Method in class jhplot.HProf1D
Number of in-range entries in the histogram
entries() - Method in class jhplot.HProf2D
Number of in-range entries in the histogram
ENTRIES_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
ENTRIES_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
entriesToString() - Method in class jhplot.io.EFile
Get a string representing file content.
entriesToString() - Method in class jhplot.io.PFile
Get a string representing file content.
Entropy - Class in jhplot.stat
Implements common discrete Shannon Entropy functions.
ENTRY_FIELD_NUMBER - Static variable in class promc.io.PEventFile.HEvent.Group
 
entrySetIterator() - Method in class org.apache.commons.math3.stat.Frequency
Return an Iterator over the set of keys and values that have been added.
EnumeratedDistribution<T> - Class in org.apache.commons.math3.distribution
A generic implementation of a discrete probability distribution (Wikipedia) over a finite sample space, based on an enumerated list of <value, probability> pairs.
EnumeratedDistribution(List<Pair<T, Double>>) - Constructor for class org.apache.commons.math3.distribution.EnumeratedDistribution
Create an enumerated distribution using the given probability mass function enumeration.
EnumeratedDistribution(RandomGenerator, List<Pair<T, Double>>) - Constructor for class org.apache.commons.math3.distribution.EnumeratedDistribution
Create an enumerated distribution using the given random number generator and probability mass function enumeration.
EnumeratedIntegerDistribution - Class in org.apache.commons.math3.distribution
Implementation of an integer-valued EnumeratedDistribution.
EnumeratedIntegerDistribution(int[], double[]) - Constructor for class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
Create a discrete distribution using the given probability mass function definition.
EnumeratedIntegerDistribution(RandomGenerator, int[], double[]) - Constructor for class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
Create a discrete distribution using the given random number generator and probability mass function definition.
EnumeratedIntegerDistribution(RandomGenerator, int[]) - Constructor for class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
Create a discrete integer-valued distribution from the input data.
EnumeratedIntegerDistribution(int[]) - Constructor for class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
Create a discrete integer-valued distribution from the input data.
EnumeratedRealDistribution - Class in org.apache.commons.math3.distribution
Implementation of a real-valued EnumeratedDistribution.
EnumeratedRealDistribution(double[], double[]) - Constructor for class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Create a discrete real-valued distribution using the given probability mass function enumeration.
EnumeratedRealDistribution(RandomGenerator, double[], double[]) - Constructor for class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Create a discrete real-valued distribution using the given random number generator and probability mass function enumeration.
EnumeratedRealDistribution(RandomGenerator, double[]) - Constructor for class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Create a discrete real-valued distribution from the input data.
EnumeratedRealDistribution(double[]) - Constructor for class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Create a discrete real-valued distribution from the input data.
enumerateKeys() - Method in class jhplot.io.db.BaseRecordsFile
Returns an Enumeration of the keys of all records in the database.
enumerateKeys() - Method in class jhplot.io.db.RecordsFile
Returns an enumeration of all the keys in the database.
EOF - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
EOF - Static variable in class org.apache.commons.io.IOUtils
Represents the end-of-file (or stream).
EOF - Static variable in interface org.nfunk.jep.ParserConstants
 
EOL - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
EOL - Static variable in class org.apache.commons.io.HexDump
The line-separator (initializes to "line.separator" system property.
EOS - Static variable in class graph.ScanString
flag the End of String
eplus - Static variable in class cern.clhep.Units
 
Eps - Static variable in class jminhep.clcontrol.Global
 
epsilon - Static variable in class jhplot.math.Slicing
 
EPSILON - Static variable in class org.apache.commons.math3.util.Precision
Largest double-precision floating-point number such that 1 + EPSILON is numerically equal to 1.
epsilon0 - Static variable in class cern.clhep.PhysicalConstants
 
Eq(Z) - Method in class Jampack.Z
Resets the real and imaginary parts of a Z to those of another Z.
Eq(double, double) - Method in class Jampack.Z
Resets the real and imaginary parts of a Z.
EQ - Static variable in class org.lsmp.djep.rpe.RpEval
 
EQ - Static variable in class org.nfunk.jep.function.Comparative
 
eq(Object, Object) - Method in class org.nfunk.jep.function.Comparative
 
EQ - Static variable in interface org.nfunk.jep.ParserConstants
 
EQUAL - Static variable in class hep.lcio.util.ObjectComparator
 
equal(float, float) - Static method in class net.jafama.NumbersUtils
 
equal(double, double) - Static method in class net.jafama.NumbersUtils
 
equal(double[][], double[][]) - Static method in class org.jfree.data.DataUtilities
Tests two arrays for equality.
EqualExpression() - Method in class org.nfunk.jep.Parser
 
equals(Object) - Method in class cern.colt.bitvector.BitMatrix
Compares this object against the specified object.
equals(Object) - Method in class cern.colt.bitvector.BitVector
Compares this object against the specified object.
equals(Object) - Method in interface cern.colt.function.ByteComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.CharComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.DoubleComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.FloatComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.IntComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.LongComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.ShortComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in class cern.colt.list.AbstractBooleanList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractByteList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractCharList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractDoubleList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractFloatList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractIntList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractLongList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractShortList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.BooleanArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.ByteArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.CharArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.DoubleArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.FloatArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.IntArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.LongArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.ObjectArrayList
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.list.ObjectArrayList
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.colt.list.ShortArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.map.AbstractDoubleIntMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.AbstractIntDoubleMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.AbstractIntIntMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.AbstractIntObjectMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.AbstractLongObjectMap
Compares the specified object with this map for equality.
equals(Object) - Method in interface cern.colt.matrix.doublealgo.DoubleMatrix1DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.matrix.doublealgo.DoubleMatrix2DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A[row,col] = A[row,col] == s ? 1 : 0; ignores tolerance.
equals(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A[row,col] = A[row,col] == B[row,col] ? 1 : 0; ignores tolerance.
equals(double) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.DoubleMatrix1D
Compares this object against the specified object.
equals(double) - Method in class cern.colt.matrix.DoubleMatrix2D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.DoubleMatrix2D
Compares this object against the specified object.
equals(double) - Method in class cern.colt.matrix.DoubleMatrix3D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.DoubleMatrix3D
Compares this object against the specified object.
equals(DoubleMatrix1D, double) - Method in class cern.colt.matrix.linalg.Property
Returns whether all cells of the given matrix A are equal to the given value.
equals(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Property
Returns whether both given matrices A and B are equal.
equals(DoubleMatrix2D, double) - Method in class cern.colt.matrix.linalg.Property
Returns whether all cells of the given matrix A are equal to the given value.
equals(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Returns whether both given matrices A and B are equal.
equals(DoubleMatrix3D, double) - Method in class cern.colt.matrix.linalg.Property
Returns whether all cells of the given matrix A are equal to the given value.
equals(DoubleMatrix3D, DoubleMatrix3D) - Method in class cern.colt.matrix.linalg.Property
Returns whether both given matrices A and B are equal.
equals(Object) - Method in interface cern.colt.matrix.objectalgo.ObjectMatrix1DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.matrix.objectalgo.ObjectMatrix2DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in class cern.colt.matrix.ObjectMatrix1D
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.matrix.ObjectMatrix1D
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.colt.matrix.ObjectMatrix2D
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.matrix.ObjectMatrix2D
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.colt.matrix.ObjectMatrix3D
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.matrix.ObjectMatrix3D
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.hep.aida.bin.AbstractBin
Returns whether two objects are equal; This default implementation returns true if the other object is a bin and has the same size, value, error and center.
equals(Object) - Method in class cern.hep.aida.bin.AbstractBin1D
Returns whether two bins are equal; They are equal if the other object is of the same class or a subclass of this class and both have the same size, minimum, maximum, sum and sumOfSquares.
equals(Object) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns whether two bins are equal.
equals - Static variable in class cern.jet.math.Functions
Function that returns a == b ? 1 : 0.
equals(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a == b ? 1 : 0.
equals - Static variable in class cern.jet.math.IntFunctions
Function that returns a == b ? 1 : 0.
equals(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a == b ? 1 : 0.
equals(Object) - Method in class fitter.BFunc
 
equals(Object) - Method in class hep.physics.vec.BasicHep3Vector
 
equals(Object) - Method in class hep.physics.vec.BasicHepLorentzVector
 
equals(SpacePoint, double) - Method in class hep.physics.vec.SpacePoint
Tests for equality within errors
equals(Hep3Vector, double) - Method in class hep.physics.vec.SpacePoint
Tests for equality within errors
equals(SpacePoint) - Method in class hep.physics.vec.SpacePoint
Tests for equality
equals(Object) - Method in class hephysics.vec.Hep3Vector
 
equals(Object) - Method in class hephysics.vec.HepLorentzVector
Compre 2 vectors
equals(SpacePoint, double) - Method in class hephysics.vec.SpacePoint
Tests for equality within errors
equals(Hep3Vector, double) - Method in class hephysics.vec.SpacePoint
Tests for equality within errors
equals(SpacePoint) - Method in class hephysics.vec.SpacePoint
Tests for equality
equals(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Deprecated.
Use java.util.Arrays instead.
equals(int) - Method in class jplot.GraphLabel
returns true if the current label corresponds to one of the pre-defined label types (X-label, Y-label etc).
equals(String) - Method in class jplot.GraphLabel
returns true if the current label corresponds to one of the pre-defined label types (X-label, Y-label etc).
EQUALS - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
equals(Object) - Method in class org.apache.commons.io.ByteOrderMark
Indicates if this BOM's bytes equals another.
equals(Object) - Method in class org.apache.commons.io.file.AccumulatorPathVisitor
 
equals(Object) - Method in class org.apache.commons.io.file.CleaningPathVisitor
 
equals(Object) - Method in class org.apache.commons.io.file.CopyDirectoryVisitor
 
equals(Object) - Method in class org.apache.commons.io.file.CountingPathVisitor
 
equals(Object) - Method in class org.apache.commons.io.file.DeletingPathVisitor
 
equals(String, String) - Static method in class org.apache.commons.io.FilenameUtils
Checks whether two fileNames are equal exactly.
equals(String, String, boolean, IOCase) - Static method in class org.apache.commons.io.FilenameUtils
Checks whether two fileNames are equal, optionally normalizing and providing control over the case-sensitivity.
equals(Object) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Test for the equality of two derivative structures.
equals(Object) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Test for the equality of two sparse gradients.
equals(Object) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
equals(Object) - Method in class org.apache.commons.math3.complex.Complex
Test for equality with another object.
equals(Complex, Complex, int) - Static method in class org.apache.commons.math3.complex.Complex
Test for the floating-point equality between Complex objects.
equals(Complex, Complex) - Static method in class org.apache.commons.math3.complex.Complex
Returns true iff the values are equal as defined by equals(x, y, 1).
equals(Complex, Complex, double) - Static method in class org.apache.commons.math3.complex.Complex
Returns true if, both for the real part and for the imaginary part, there is no double value strictly between the arguments or the difference between them is within the range of allowed error (inclusive).
equals(Object) - Method in class org.apache.commons.math3.complex.Quaternion
equals(Quaternion, double) - Method in class org.apache.commons.math3.complex.Quaternion
Checks whether this instance is equal to another quaternion within a given tolerance.
equals(Object) - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is equal to x.
equals(Object) - Method in class org.apache.commons.math3.fraction.BigFraction
Test for the equality of two fractions.
equals(Object) - Method in class org.apache.commons.math3.fraction.Fraction
Test for the equality of two fractions.
equals(Object) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Test for the equality of two 1D vectors.
equals(Object) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Test for the equality of two 3D vectors.
equals(Object) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Test for the equality of two 3D vectors.
equals(Object) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Test for the equality of two 2D vectors.
equals(Object) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
Deprecated.
equals(Object) - Method in class org.apache.commons.math3.geometry.spherical.oned.S1Point
Test for the equality of two points on the 2-sphere.
equals(Object) - Method in class org.apache.commons.math3.geometry.spherical.twod.S2Point
Test for the equality of two points on the 2-sphere.
equals(Object) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns true iff object is a FieldMatrix instance with the same dimensions as this and all corresponding matrix entries are equal.
equals(Object) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns true iff object is a RealMatrix instance with the same dimensions as this and all corresponding matrix entries are equal.
equals(Object) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Test for the equality of two vectors.
equals(Object) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Test for the equality of two real vectors.
equals(Object) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Test for the equality of two real vectors.
equals(Object) - Method in class org.apache.commons.math3.linear.RealVector
Test for the equality of two real vectors.
equals(Object) - Method in class org.apache.commons.math3.linear.SparseFieldVector
equals(Object) - Method in class org.apache.commons.math3.ml.clustering.DoublePoint
equals(Object) - Method in class org.apache.commons.math3.optim.linear.LinearConstraint
equals(Object) - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
equals(Object) - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated.
equals(Object) - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.
equals(Object) - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
Deprecated.
equals(Object) - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
Deprecated.
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns true iff object is an AbstractStorelessUnivariateStatistic returning the same values as this for getResult() and getN()
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns true iff object is a MultivariateSummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile
Returns true iff o is a PSquarePercentile returning the same values as this for getResult() and getN() and also having equal markers
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
Returns true iff object is a StatisticalSummaryValues instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns true iff object is a SummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns true iff object is a MultivariateSummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns true iff object is a SummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math3.stat.Frequency
equals(Object) - Method in class org.apache.commons.math3.util.BigReal
equals(Object) - Method in class org.apache.commons.math3.util.Decimal64
equals(Object) - Method in class org.apache.commons.math3.util.DefaultTransformer
equals(float[], float[]) - Static method in class org.apache.commons.math3.util.MathArrays
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by Precision.equals(float,float).
equals(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by Precision.equals(double,double).
equals(double, double) - Static method in class org.apache.commons.math3.util.MathUtils
Returns true if the values are equal according to semantics of Double.equals(Object).
equals(Object) - Method in class org.apache.commons.math3.util.Pair
Compare the specified object with this entry for equality.
equals(float, float) - Static method in class org.apache.commons.math3.util.Precision
Returns true iff they are equal as defined by equals(x, y, 1).
equals(float, float, float) - Static method in class org.apache.commons.math3.util.Precision
Returns true if the arguments are equal or within the range of allowed error (inclusive).
equals(float, float, int) - Static method in class org.apache.commons.math3.util.Precision
Returns true if the arguments are equal or within the range of allowed error (inclusive).
equals(double, double) - Static method in class org.apache.commons.math3.util.Precision
Returns true iff they are equal as defined by equals(x, y, 1).
equals(double, double, double) - Static method in class org.apache.commons.math3.util.Precision
Returns true if there is no double value strictly between the arguments or the difference between them is within the range of allowed error (inclusive).
equals(double, double, int) - Static method in class org.apache.commons.math3.util.Precision
Returns true if the arguments are equal or within the range of allowed error (inclusive).
equals(Object) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns true iff object is a ResizableDoubleArray with the same properties as this and an identical internal storage array.
equals(Object) - Method in class org.apache.commons.math3.util.TransformerMap
equals(Object) - Method in class org.jfree.chart.annotations.AbstractXYAnnotation
Tests this annotation for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Tests this object for equality with another.
equals(Object) - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Tests this annotation for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.CategoryTextAnnotation
Tests this object for equality with another.
equals(Object) - Method in class org.jfree.chart.annotations.TextAnnotation
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.XYBoxAnnotation
Tests this annotation for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.XYDrawableAnnotation
Tests this annotation for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.XYImageAnnotation
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.XYLineAnnotation
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Tests this annotation for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.XYPolygonAnnotation
Tests this annotation for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.XYShapeAnnotation
Tests this annotation for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Tests this annotation for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.Axis
Tests this axis for equality with another object.
equals(Object) - Method in class org.jfree.chart.axis.AxisLabelLocation
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.axis.AxisLocation
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.axis.AxisSpace
Tests this object for equality with another object.
equals(Object) - Method in class org.jfree.chart.axis.CategoryAnchor
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.axis.CategoryAxis
Tests this axis for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.CategoryLabelPosition
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.CategoryLabelPositions
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.axis.CategoryLabelWidthType
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.axis.CategoryTick
Tests this category tick for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Tests this object for equality with another.
equals(Object) - Method in class org.jfree.chart.axis.CyclicNumberAxis
Tests the axis for equality with another object.
equals(Object) - Method in class org.jfree.chart.axis.DateAxis
Tests this axis for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.DateTick
Tests this tick for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.DateTickMarkPosition
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.axis.DateTickUnit
Tests this unit for equality with another object.
equals(Object) - Method in class org.jfree.chart.axis.DateTickUnitType
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.axis.ExtendedCategoryAxis
Tests this axis for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.LogAxis
Tests this axis for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.MarkerAxisBand
Tests this axis for equality with another object.
equals(Object) - Method in class org.jfree.chart.axis.ModuloAxis
Tests this axis for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.MonthDateFormat
Tests this formatter for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.NumberAxis
Tests the axis for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.NumberTickUnit
Tests this formatter for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.NumberTickUnitSource
 
equals(Object) - Method in class org.jfree.chart.axis.PeriodAxis
Tests the axis for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.QuarterDateFormat
Tests this formatter for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns true if we are equal to the parameter
equals(Object) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Tests an object (usually another Segment) for equality with this segment.
equals(Object) - Method in class org.jfree.chart.axis.StandardTickUnitSource
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.SubCategoryAxis
Tests the axis for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.SymbolAxis
Tests this axis for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.Tick
Tests this tick for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.TickType
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.axis.TickUnit
Tests this unit for equality with another object.
equals(Object) - Method in class org.jfree.chart.axis.TickUnits
Tests an object for equality with this instance.
equals(Object) - Method in class org.jfree.chart.axis.ValueAxis
Tests the axis for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.axis.ValueTick
Tests this tick for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.block.AbstractBlock
Tests this block for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.block.BlockBorder
Tests this border for equality with an arbitrary instance.
equals(Object) - Method in class org.jfree.chart.block.BlockContainer
Tests this container for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.block.BorderArrangement
Tests this arrangement for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.block.CenterArrangement
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.block.ColorBlock
Tests this block for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.block.ColumnArrangement
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.block.FlowArrangement
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.block.GridArrangement
Compares this layout manager for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.block.LabelBlock
Tests this LabelBlock for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.block.LengthConstraintType
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.block.LineBorder
Tests this border for equality with an arbitrary instance.
equals(Object) - Method in class org.jfree.chart.ChartRenderingInfo
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.AxisEntity
Tests the entity for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.CategoryItemEntity
Tests the entity for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.CategoryLabelEntity
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.ChartEntity
Tests the entity for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.ContourEntity
Deprecated.
Tests the entity for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.JFreeChartEntity
Tests the entity for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.LegendItemEntity
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.PieSectionEntity
Tests this entity for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.PlotEntity
Tests the entity for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.StandardEntityCollection
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.TitleEntity
Tests the entity for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.XYAnnotationEntity
Tests the entity for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.entity.XYItemEntity
Tests the entity for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.event.ChartChangeEventType
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.JFreeChart
Tests this chart for equality with another object.
equals(Object) - Method in class org.jfree.chart.labels.AbstractCategoryItemLabelGenerator
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.AbstractPieItemLabelGenerator
Tests the generator for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.AbstractXYItemLabelGenerator
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.BoxAndWhiskerToolTipGenerator
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.chart.labels.BoxAndWhiskerXYToolTipGenerator
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.chart.labels.BubbleXYItemLabelGenerator
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.CustomXYToolTipGenerator
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.chart.labels.HighLowItemLabelGenerator
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.chart.labels.IntervalCategoryToolTipGenerator
Tests this tool tip generator for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.IntervalXYItemLabelGenerator
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.ItemLabelAnchor
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.labels.ItemLabelPosition
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.MultipleXYSeriesLabelGenerator
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.StandardCategoryItemLabelGenerator
Tests this generator for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.StandardCategorySeriesLabelGenerator
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.StandardCategoryToolTipGenerator
Tests this generator for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.StandardContourToolTipGenerator
Deprecated.
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.chart.labels.StandardCrosshairLabelGenerator
Tests this generator for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.StandardPieSectionLabelGenerator
Tests the generator for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.StandardXYItemLabelGenerator
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.StandardXYSeriesLabelGenerator
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.StandardXYToolTipGenerator
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.StandardXYZToolTipGenerator
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.labels.SymbolicXYItemLabelGenerator
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.chart.LegendItem
Tests this item for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.LegendItemCollection
Tests this collection for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.LegendRenderingOrder
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.needle.ArrowNeedle
Tests another object for equality with this object.
equals(Object) - Method in class org.jfree.chart.needle.LineNeedle
Tests another object for equality with this object.
equals(Object) - Method in class org.jfree.chart.needle.LongNeedle
Tests another object for equality with this object.
equals(Object) - Method in class org.jfree.chart.needle.MeterNeedle
Tests another object for equality with this object.
equals(Object) - Method in class org.jfree.chart.needle.MiddlePinNeedle
Tests another object for equality with this object.
equals(Object) - Method in class org.jfree.chart.needle.PinNeedle
Tests another object for equality with this object.
equals(Object) - Method in class org.jfree.chart.needle.PlumNeedle
Tests another object for equality with this object.
equals(Object) - Method in class org.jfree.chart.needle.PointerNeedle
Tests another object for equality with this object.
equals(Object) - Method in class org.jfree.chart.needle.ShipNeedle
Tests another object for equality with this object.
equals(Object) - Method in class org.jfree.chart.needle.WindNeedle
Tests another object for equality with this object.
equals(Object) - Method in class org.jfree.chart.PaintMap
Tests this map for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.panel.CrosshairOverlay
Tests this overlay for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.CategoryMarker
Tests the marker for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.CategoryPlot
Tests the plot for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Tests an object for equality with this instance.
equals(Object) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Tests the plot for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Tests this plot for equality with another object.
equals(Object) - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Tests the plot for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Tests this plot for equality with another object.
equals(Object) - Method in class org.jfree.chart.plot.CompassPlot
Tests an object for equality with this plot.
equals(Object) - Method in class org.jfree.chart.plot.Crosshair
Tests this crosshair for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.DatasetRenderingOrder
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.plot.DefaultDrawingSupplier
Tests this object for equality with another object.
equals(Object) - Method in class org.jfree.chart.plot.dial.AbstractDialLayer
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.DialBackground
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.DialCap
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.DialPlot
Tests this DialPlot instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.DialPointer
Checks this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.DialPointer.Pin
Tests this pointer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.DialPointer.Pointer
Tests this pointer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.StandardDialRange
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Tests this StandardDialScale for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.DialShape
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.plot.FastScatterPlot
Tests an arbitrary object for equality with this plot.
equals(Object) - Method in class org.jfree.chart.plot.IntervalMarker
Tests the marker for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.Marker
Tests the marker for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.MeterInterval
Checks this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.MeterPlot
Tests the plot for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.MultiplePiePlot
Tests this plot for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.PieLabelLinkStyle
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.plot.PieLabelRecord
Tests this record for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.PiePlot
Tests this plot for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.PiePlot3D
Tests this plot for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.Plot
Tests this plot for equality with another object.
equals(Object) - Method in class org.jfree.chart.plot.PlotOrientation
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.plot.PlotRenderingInfo
Tests this instance for equality against an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.PolarAxisLocation
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.plot.PolarPlot
Tests this plot for equality with another object.
equals(Object) - Method in class org.jfree.chart.plot.RingPlot
Tests this plot for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.SeriesRenderingOrder
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.plot.SpiderWebPlot
Tests this plot for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.ThermometerPlot
Tests this plot for equality with another object.
equals(Object) - Method in class org.jfree.chart.plot.ValueMarker
Tests this marker for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.plot.XYPlot
Tests this plot for equality with another object.
equals(Object) - Method in class org.jfree.chart.renderer.AbstractRenderer
Tests this renderer for equality with another object.
equals(Object) - Method in class org.jfree.chart.renderer.AreaRendererEndType
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Tests this renderer for equality with another object.
equals(Object) - Method in class org.jfree.chart.renderer.category.AreaRenderer
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.BarRenderer
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.CategoryStepRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.GanttRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.GradientBarPainter
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.GroupedStackedBarRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.IntervalBarRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.LevelRenderer
Tests an object for equality with this instance.
equals(Object) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Checks this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.StackedAreaRenderer
Checks this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.StackedBarRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.StackedBarRenderer3D
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.StandardBarPainter
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.StatisticalBarRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.StatisticalLineAndShapeRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.category.WaterfallBarRenderer
Tests an object for equality with this instance.
equals(Object) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.GrayPaintScale
Tests this GrayPaintScale instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.LookupPaintScale
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.Outlier
Tests this outlier for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Tests this renderer for equality with another object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Tests this renderer for equality with another object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.ClusteredXYBarRenderer
Tests this renderer for equality with an arbitrary object, returning true if obj is a ClusteredXYBarRenderer with the same settings as this renderer, and false otherwise.
equals(Object) - Method in class org.jfree.chart.renderer.xy.DeviationRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.GradientXYBarPainter
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.SamplingXYLineRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Tests the renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer2
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.StackedXYBarRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.StandardXYBarPainter
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Tests this renderer for equality with another object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.VectorRenderer
Tests this VectorRenderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer2
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Tests this XYBlockRenderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Tests this renderer for equality with another object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYBubbleRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYDotRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYLine3DRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYSplineRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.XYStepRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.renderer.xy.YIntervalRenderer
Tests this renderer for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.StandardChartTheme
Tests this theme for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.StrokeMap
Tests this map for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.title.CompositeTitle
Tests this title for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.title.ImageTitle
Tests this ImageTitle for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.title.LegendGraphic
Tests this LegendGraphic instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.title.LegendTitle
Tests this title for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.title.PaintScaleLegend
Tests this legend for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.title.TextTitle
Tests this title for equality with another object.
equals(Object) - Method in class org.jfree.chart.title.Title
Tests an object for equality with this title.
equals(Object) - Method in class org.jfree.chart.urls.CustomCategoryURLGenerator
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.chart.urls.CustomPieURLGenerator
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.chart.urls.CustomXYURLGenerator
Tests this generator for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.urls.StandardCategoryURLGenerator
Tests the generator for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.urls.StandardPieURLGenerator
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.chart.urls.StandardXYURLGenerator
Tests this generator for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.urls.TimeSeriesURLGenerator
Tests this generator for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.util.DefaultShadowGenerator
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.util.LogFormat
Tests this formatter for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.util.RelativeDateFormat
Tests this formatter for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.chart.util.XYCoordinateType
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.data.category.CategoryToPieDataset
Tests this dataset for equality with an arbitrary object, returning true if obj is a dataset containing the same keys and values in the same order as this dataset.
equals(Object) - Method in class org.jfree.data.category.DefaultCategoryDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.category.SlidingCategoryDataset
Tests this SlidingCategoryDataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.ComparableObjectItem
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.data.ComparableObjectSeries
Tests this series for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.DefaultKeyedValue
Tests this key-value pair for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.DefaultKeyedValues
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.data.DefaultKeyedValues2D
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.data.DomainOrder
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.data.function.LineFunction2D
Tests this function for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.function.NormalDistributionFunction2D
Tests this function for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.function.PolynomialFunction2D
Tests this function for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.function.PowerFunction2D
Tests this function for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Tests this SlidingCategoryDataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.gantt.Task
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.gantt.TaskSeries
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.gantt.XYTaskDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.general.DatasetGroup
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.general.DefaultHeatMapDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.general.DefaultKeyedValueDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.general.DefaultPieDataset
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.data.general.DefaultValueDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.general.Series
Tests the series for equality with another object.
equals(Object) - Method in class org.jfree.data.KeyedObject
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.data.KeyedObjects
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.KeyedObjects2D
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.KeyedValueComparatorType
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.data.KeyToGroupMap
Tests the map for equality against an arbitrary object.
equals(Object) - Method in class org.jfree.data.Range
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.RangeType
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.data.statistics.BoxAndWhiskerItem
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.statistics.HistogramBin
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.statistics.HistogramDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.statistics.HistogramType
Tests this type for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.statistics.MeanAndStandardDeviation
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.statistics.SimpleHistogramBin
Tests this bin for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Compares the dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.Day
Tests the equality of this Day object to an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.FixedMillisecond
Tests the equality of this object against an arbitrary Object.
equals(Object) - Method in class org.jfree.data.time.Hour
Tests the equality of this object against an arbitrary Object.
equals(Object) - Method in class org.jfree.data.time.Millisecond
Tests the equality of this object against an arbitrary Object.
equals(Object) - Method in class org.jfree.data.time.Minute
Tests the equality of this object against an arbitrary Object.
equals(Object) - Method in class org.jfree.data.time.Month
Tests the equality of this Month object to an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.ohlc.OHLC
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.Quarter
Tests the equality of this Quarter object to an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.Second
Tests the equality of this object against an arbitrary Object.
equals(Object) - Method in class org.jfree.data.time.SimpleTimePeriod
Tests this time period instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.TimePeriodAnchor
Returns true if this object is equal to the specified object, and false otherwise.
equals(Object) - Method in class org.jfree.data.time.TimePeriodValue
Tests this object for equality with the target object.
equals(Object) - Method in class org.jfree.data.time.TimePeriodValues
Tests the series for equality with another object.
equals(Object) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.TimeSeries
Tests the series for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.TimeSeriesCollection
Tests this time series collection for equality with another object.
equals(Object) - Method in class org.jfree.data.time.TimeSeriesDataItem
Tests this object for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.TimeTableXYDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.Week
Tests the equality of this Week object to an arbitrary object.
equals(Object) - Method in class org.jfree.data.time.Year
Tests the equality of this Year object to an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Tests this dataset for equality with an arbitrary instance.
equals(Object) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Tests this DefaultIntervalXYDataset instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Tests this collection for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.DefaultWindDataset
Checks this WindDataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.DefaultXYDataset
Tests this DefaultXYDataset instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.DefaultXYZDataset
Tests this DefaultXYDataset instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.IntervalXYDelegate
Tests the delegate for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.MatrixSeries
Tests this object instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.MatrixSeriesCollection
Tests this collection for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.OHLCDataItem
Checks this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.Vector
Tests this vector for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.VectorSeriesCollection
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.XYBarDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.XYCoordinate
Tests this coordinate for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.XYDataItem
Tests if this object is equal to another.
equals(Object) - Method in class org.jfree.data.xy.XYInterval
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.XYSeries
Tests this series for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.XYSeriesCollection
Tests this collection for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.YInterval
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Tests this instance for equality with an arbitrary object.
equals(Object) - Method in class org.jfree.data.xy.YWithXInterval
Tests this instance for equality with an arbitrary object.
equals(Number, Number) - Method in interface org.lsmp.djep.groupJep.GroupI
whether two numbers are equal
equals(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.BigReals
 
equals(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
equals(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Integers
 
equals(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.PermutationGroup
 
equals(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Quaternions
 
equals(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
equals(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Reals
 
equals(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Zn
 
equals(Permutation) - Method in class org.lsmp.djep.groupJep.values.Permutation
 
equals(Polynomial) - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
equals(PNodeI) - Method in class org.lsmp.djep.sjep.AbstractPNode
 
equals(PNodeI) - Method in class org.lsmp.djep.sjep.Monomial
 
equals(PNodeI) - Method in class org.lsmp.djep.sjep.PConstant
 
equals(PNodeI) - Method in class org.lsmp.djep.sjep.PFunction
 
equals(PNodeI) - Method in interface org.lsmp.djep.sjep.PNodeI
True is nodes represent the same parse trees
equals(Object) - Method in interface org.lsmp.djep.sjep.PNodeI
True is nodes represent the same parse trees
equals(PNodeI) - Method in class org.lsmp.djep.sjep.Polynomial
 
equals(Node, Node) - Method in class org.lsmp.djep.sjep.PolynomialCreator
Compares two nodes.
equals(PNodeI) - Method in class org.lsmp.djep.sjep.POperator
 
equals(PNodeI) - Method in class org.lsmp.djep.sjep.PVariable
 
equals(Dimensions) - Method in class org.lsmp.djep.vectorJep.Dimensions
Two dimensions are equal if the element of dims are the same.
equals(Object) - Method in class org.lsmp.djep.vectorJep.Dimensions
 
equals(Object) - Method in class org.lsmp.djep.vectorJep.values.Matrix
Are two matrices equal, element by element Overrides Object.
equals(Object) - Method in class org.lsmp.djep.vectorJep.values.MVector
value of constant ele(1).
equals(Object) - Method in class org.lsmp.djep.vectorJep.values.Scaler
 
equals(Object) - Method in class org.lsmp.djep.vectorJep.values.Tensor
value of constant ele(1).
equals(Complex, double) - Method in class org.nfunk.jep.type.Complex
Compares this object with the Complex number given as parameter
equals(Object) - Method in class org.nfunk.jep.type.Complex
Compares this object against the specified object.
equals(Object) - Method in class root.FakeTKey
 
equalsIncludingNaN(float[], float[]) - Static method in class org.apache.commons.math3.util.MathArrays
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by this method.
equalsIncludingNaN(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by this method.
equalsIncludingNaN(float, float) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are NaN or they are equal as defined by equals(x, y, 1).
equalsIncludingNaN(float, float, float) - Static method in class org.apache.commons.math3.util.Precision
Returns true if the arguments are both NaN, are equal, or are within the range of allowed error (inclusive).
equalsIncludingNaN(float, float, int) - Static method in class org.apache.commons.math3.util.Precision
Returns true if the arguments are both NaN or if they are equal as defined by equals(x, y, maxUlps).
equalsIncludingNaN(double, double) - Static method in class org.apache.commons.math3.util.Precision
Returns true if the arguments are both NaN or they are equal as defined by equals(x, y, 1).
equalsIncludingNaN(double, double, double) - Static method in class org.apache.commons.math3.util.Precision
Returns true if the arguments are both NaN, are equal or are within the range of allowed error (inclusive).
equalsIncludingNaN(double, double, int) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are NaN or if they are equal as defined by equals(x, y, maxUlps).
equalsNormalized(String, String) - Static method in class org.apache.commons.io.FilenameUtils
Checks whether two fileNames are equal after both have been normalized.
equalsNormalizedOnSystem(String, String) - Static method in class org.apache.commons.io.FilenameUtils
Checks whether two fileNames are equal after both have been normalized and using the case rules of the system.
equalsOnSystem(String, String) - Static method in class org.apache.commons.io.FilenameUtils
Checks whether two fileNames are equal using the case rules of the system.
equalsWithRelativeTolerance(Complex, Complex, double) - Static method in class org.apache.commons.math3.complex.Complex
Returns true if, both for the real part and for the imaginary part, there is no double value strictly between the arguments or the relative difference between them is smaller or equal to the given tolerance.
equalsWithRelativeTolerance(double, double, double) - Static method in class org.apache.commons.math3.util.Precision
Returns true if there is no double value strictly between the arguments or the relative difference between them is less than or equal to the given tolerance.
EQUALTO - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
equationChanged(String) - Method in class org.lsmp.djepExamples.MRpSurfExample
 
EquationsMapper - Class in org.apache.commons.math3.ode
Class mapping the part of a complete state or derivative that pertains to a specific differential equation.
EquationsMapper(int, int) - Constructor for class org.apache.commons.math3.ode.EquationsMapper
simple constructor.
EquiDepthHistogram - Class in cern.jet.stat.quantile
Read-only equi-depth histogram for selectivity estimation.
EquiDepthHistogram(float[]) - Constructor for class cern.jet.stat.quantile.EquiDepthHistogram
Constructs an equi-depth histogram with the given quantile elements.
equivalentBinEntries() - Method in class cern.hep.aida.ref.Histogram1D
 
equivalentBinEntries() - Method in class cern.hep.aida.ref.Histogram2D
 
equivalentBinEntries() - Method in class cern.hep.aida.ref.Histogram3D
 
equivalentBinEntries() - Method in interface colt.hep.aida.IHistogram
Number of equivalent entries.
EQUIVILENCE - Static variable in class org.lsmp.djep.xjep.XOperator
Equivilence relations = reflexive, transative and symetric.
erf(double) - Static method in class graph.SpecialFunction
 
Erf - Class in jhplot.math.num.special
Utility class that provides methods related to the error function.
erf(double) - Static method in class jhplot.math.num.special.Erf
Returns the error function erf(x) (1).
Erf - Class in org.apache.commons.math3.special
This is a utility class that provides computation methods related to the error functions.
erf(double) - Static method in class org.apache.commons.math3.special.Erf
Returns the error function.
erf(double, double) - Static method in class org.apache.commons.math3.special.Erf
Returns the difference between erf(x1) and erf(x2).
erf(double) - Static method in class org.jlab.groot.math.ErrorFunction
 
erf(double, double, double, double, double) - Static method in class org.jlab.groot.math.ErrorFunction
 
erf2(double) - Static method in class org.jlab.groot.math.ErrorFunction
 
erfc(double) - Static method in class graph.SpecialFunction
 
erfc(double) - Static method in class jhplot.math.num.special.Erf
Returns the complementary error function erfc(x) (1).
erfc(double) - Static method in class org.apache.commons.math3.special.Erf
Returns the complementary error function.
erfc(double) - Static method in class org.jlab.groot.math.ErrorFunction
 
erfcInv(double) - Static method in class org.apache.commons.math3.special.Erf
Returns the inverse erfc.
erfInv(double) - Static method in class org.apache.commons.math3.special.Erf
Returns the inverse erf.
ERR_SCALE - Static variable in class org.apache.commons.math3.dfp.Dfp
The amount under/overflows are scaled by before going to trap handler
error() - Method in class cern.hep.aida.bin.AbstractBin
Returns error(0).
error(int) - Method in class cern.hep.aida.bin.AbstractBin
Returns a custom definable error measure; override this method if necessary.
ERROR - Static variable in class graph.ScanString
Flag an error
ERROR - Static variable in class graph.ScanWord
Token returned when an error is encountered
ERROR - Static variable in interface hep.lcio.event.LCIO
 
error(IOException) - Method in class org.apache.commons.io.input.ObservableInputStream.Observer
Called to indicate that an error occurred on the underlying stream.
error(int) - Method in class org.freehep.math.minuit.MnApplication
 
error(String) - Method in class org.freehep.math.minuit.MnApplication
 
error(int) - Method in class org.freehep.math.minuit.MnUserParameters
 
error(String) - Method in class org.freehep.math.minuit.MnUserParameters
 
error(int) - Method in class org.freehep.math.minuit.MnUserParameterState
 
error(String) - Method in class org.freehep.math.minuit.MnUserParameterState
 
error() - Method in class org.jlab.groot.math.StatNumber
 
error() - Method in class org.jlab.groot.math.UserParameter
 
ErrorCatchingVisitor - Class in org.lsmp.djep.xjep
An abstract ParserVisitor which adds some useful error handling facilities.
ErrorCatchingVisitor() - Constructor for class org.lsmp.djep.xjep.ErrorCatchingVisitor
 
errorDef() - Method in class org.freehep.math.minuit.FunctionMinimum
 
errorDef() - Method in class org.freehep.math.minuit.MnApplication
 
errorFunction(double) - Static method in class cern.jet.stat.Probability
Returns the error function of the normal distribution; formerly named erf.
ErrorFunction - Class in org.jlab.groot.math
 
ErrorFunction() - Constructor for class org.jlab.groot.math.ErrorFunction
 
errorFunctionComplemented(double) - Static method in class cern.jet.stat.Probability
Returns the complementary Error function of the normal distribution; formerly named erfc.
ErrorLog - Static variable in interface jminhep.gui.Constants
 
ErrorMessage(String) - Static method in class jhplot.utils.Util
Generate error message with long output.
ErrorMessageLine(String) - Static method in class jhplot.utils.Util
Generate error message as one line.
errors() - Method in class org.freehep.math.minuit.MnApplication
 
errors() - Method in class org.freehep.math.minuit.MnUserParameterState
 
ERRORS_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
ERRORS_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
errorsFill(boolean) - Method in class jplot.LinePars
Fill area between lower and upper error
errorsFillSys(boolean) - Method in class jplot.LinePars
Fill area between lower and upper error for system errors.
errorsSysX(boolean) - Method in class jplot.LinePars
Show systematical errors on X
errorsSysY(boolean) - Method in class jplot.LinePars
Show systematical errors on Y
errorsX(boolean) - Method in class jplot.LinePars
Show errors on X
errorsY(boolean) - Method in class jplot.LinePars
Show errors on Y
estimate(double[][], int) - Static method in class org.apache.commons.math3.distribution.fitting.MultivariateNormalMixtureExpectationMaximization
Helper method to create a multivariate normal mixture model which can be used to initialize MultivariateNormalMixtureExpectationMaximization.fit(MixtureMultivariateNormalDistribution).
estimateErrorVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Estimates the variance of the error.
estimateParameters() - Method in class org.jlab.groot.math.Func1D
 
estimateRegressandVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Returns the variance of the regressand, ie Var(y).
estimateRegressandVariance() - Method in interface org.apache.commons.math3.stat.regression.MultipleLinearRegression
Returns the variance of the regressand, ie Var(y).
estimateRegressionParameters() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Estimates the regression parameters b.
estimateRegressionParameters() - Method in interface org.apache.commons.math3.stat.regression.MultipleLinearRegression
Estimates the regression parameters b.
estimateRegressionParametersStandardErrors() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Returns the standard errors of the regression parameters.
estimateRegressionParametersStandardErrors() - Method in interface org.apache.commons.math3.stat.regression.MultipleLinearRegression
Returns the standard errors of the regression parameters.
estimateRegressionParametersVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Estimates the variance of the regression parameters, ie Var(b).
estimateRegressionParametersVariance() - Method in interface org.apache.commons.math3.stat.regression.MultipleLinearRegression
Estimates the variance of the regression parameters, ie Var(b).
estimateRegressionStandardError() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Estimates the standard error of the regression.
estimateResiduals() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Estimates the residuals, ie u = y - X*b.
estimateResiduals() - Method in interface org.apache.commons.math3.stat.regression.MultipleLinearRegression
Estimates the residuals, ie u = y - X*b.
et() - Method in class hephysics.jet.ParticleD
Compute transverse energy.
et() - Method in class hephysics.vec.HepLorentzVector
Transverse energy.
et2() - Method in class hephysics.jet.ParticleD
Compute transverse energy squared.
et2() - Method in class hephysics.vec.HepLorentzVector
Transverse energy squared.
eta() - Method in class hephysics.jet.ParticleD
Compute pseudorapidity.
eta() - Method in class hephysics.jet.ParticleF
Same as getEta().
ETA_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.BLJets
 
ETA_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Electrons
 
ETA_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.GenJets
 
ETA_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Jets
 
ETA_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Muons
 
ETA_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
ETA_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Photons
 
ETA_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
ETAOUTER_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
EUCLID - Static variable in class cern.colt.matrix.doublealgo.Statistic
Euclidean distance function; Sqrt(Sum( (x[i]-y[i])^2 )).
Euclidean1D - Class in org.apache.commons.math3.geometry.euclidean.oned
This class implements a one-dimensional space.
Euclidean1D.NoSubSpaceException - Exception in org.apache.commons.math3.geometry.euclidean.oned
Specialized exception for inexistent sub-space.
Euclidean2D - Class in org.apache.commons.math3.geometry.euclidean.twod
This class implements a two-dimensional space.
Euclidean3D - Class in org.apache.commons.math3.geometry.euclidean.threed
This class implements a three-dimensional space.
EuclideanDistance - Class in org.apache.commons.math3.ml.distance
Calculates the L2 (Euclidean) distance between two points.
EuclideanDistance() - Constructor for class org.apache.commons.math3.ml.distance.EuclideanDistance
 
EuclideanDoublePoint - Class in org.apache.commons.math3.stat.clustering
Deprecated.
As of 3.2 (to be removed in 4.0), use DoublePoint instead
EuclideanDoublePoint(double[]) - Constructor for class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
Deprecated.
Build an instance wrapping an integer array.
EuclideanIntegerPoint - Class in org.apache.commons.math3.stat.clustering
Deprecated.
As of 3.2 (to be removed in 4.0), use DoublePoint instead
EuclideanIntegerPoint(int[]) - Constructor for class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
Deprecated.
Build an instance wrapping an integer array.
euler(double[], F1D, double) - Static method in class jhplot.math.Numeric
Uses the Euler method to solve an ODE.
EulerFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements a simple Euler integrator for Ordinary Differential Equations.
EulerFieldIntegrator(Field<T>, T) - Constructor for class org.apache.commons.math3.ode.nonstiff.EulerFieldIntegrator
Simple constructor.
EulerIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements a simple Euler integrator for Ordinary Differential Equations.
EulerIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.EulerIntegrator
Simple constructor.
eV - Static variable in class cern.clhep.Units
 
eval(double) - Method in class jhplot.F1D
Evaluate a function at a specific point in x
eval(double[]) - Method in class jhplot.F1D
Evaluate a function for an array of x-values
eval(double, double) - Method in class jhplot.F1D
Evaluate a function for graphic representation.
eval() - Method in class jhplot.F1D
Evaluate a function for graphic representation.
eval(double, double, int) - Method in class jhplot.F1D
Evaluate a function for graphic representation.
eval(double, double) - Method in class jhplot.F2D
Evaluate a function at a specific point in (x,y)
eval(double[], double[]) - Method in class jhplot.F2D
Evaluate a function for an array of x-values
eval(double, double, double) - Method in class jhplot.F3D
Evaluate a function at a specific point in (x,y,z)
eval(String) - Method in class jhplot.FND
Evaluate a function at a specific point in x
eval(String, double, double, String) - Method in class jhplot.FND
Evaluate a function at a specific point for one single variable.
eval(String, double, double) - Method in class jhplot.FND
Evaluate a function at a specific point for one single variable.
eval() - Method in class jhplot.stat.BunchingParameters
Evaluate bunching parameters at the end of the run
eval() - Method in class jhplot.stat.FactorialMoments
Evaluate factorial moments at the end of the run
eval() - Method in class jhplot.stat.PCA
 
eval(Node) - Method in class org.lsmp.djep.matrixJep.MatrixEvaluator
 
Eval - Class in org.lsmp.djep.xjep
Symbolic eval(x^3,x,2) operator.
Eval() - Constructor for class org.lsmp.djep.xjep.Eval
Create a function that evaluates the lhs with values given on rhs.
eval(Node) - Method in interface org.nfunk.jep.EvaluatorI
Evaluates a node and returns and object with the value of the node.
eval(Node) - Method in class org.nfunk.jep.EvaluatorVisitor
Evaluates a given node, in the current context.
eval(PostfixMathCommandI, Node[]) - Method in class org.nfunk.jep.EvaluatorVisitor
Evaluates a PostfixMathCommandI with given arguments.
evaluate() - Method in class jhplot.math.exp4j.Expression
 
evaluate(double) - Method in class jhplot.math.num.ContinuedFraction
Evaluate this continued fraction at the given value.
evaluate(double) - Method in interface jhplot.math.num.Function
Evaluate this function, f, at the domain value x.
evaluate(double) - Method in class jhplot.math.num.PowerSeries
Evaluate this series at the given value.
evaluate(double) - Method in class jhplot.math.num.Series
Evaluate this series at the given value.
evaluate() - Method in class jplot3d.JSurfacePanel
 
evaluate(double[], double[], double) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Evaluate the Lagrange polynomial using Neville's Algorithm.
evaluate(double[], double[], double) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Evaluate the Newton polynomial using nested multiplication.
evaluate(RealVector) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresAdapter
Evaluate the model at the specified point.
evaluate(RealVector) - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresProblem
Evaluate the model at the specified point.
evaluate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Evaluate all the non-evaluated points of the simplex.
evaluate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated.
Evaluate all the non-evaluated points of the simplex.
evaluate(double[]) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation calls AbstractStorelessUnivariateStatistic.clear(), then invokes AbstractStorelessUnivariateStatistic.increment(double) in a loop over the the input array, and then uses AbstractStorelessUnivariateStatistic.getResult() to compute the return value.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation calls AbstractStorelessUnivariateStatistic.clear(), then invokes AbstractStorelessUnivariateStatistic.increment(double) in a loop over the specified portion of the input array, and then uses AbstractStorelessUnivariateStatistic.getResult() to compute the return value.
evaluate() - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Returns the result of evaluating the statistic over the stored data.
evaluate(double[]) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Returns the result of evaluating the statistic over the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Returns the result of evaluating the statistic over the specified entries in the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Returns the geometric mean of the entries in the specified portion of the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Returns the kurtosis of the entries in the specified portion of the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns the arithmetic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns the weighted arithmetic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns the weighted arithmetic mean of the entries in the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the mean, using instance properties varianceDirection and biasCorrection.
evaluate(double[], SemiVariance.Direction) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
This method calculates SemiVariance for the entire array against the mean, using the current value of the biasCorrection instance property.
evaluate(double[], double) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the cutoff, using instance properties variancDirection and biasCorrection.
evaluate(double[], double, SemiVariance.Direction) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the cutoff in the given direction, using the current value of the biasCorrection instance property.
evaluate(double[], double, SemiVariance.Direction, boolean, int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the cutoff in the given direction with the provided bias correction.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Returns the Skewness of the entries in the specifed portion of the input array.
evaluate(double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the input array, or Double.NaN if the array is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double, int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the specified portion of the input array, using the precomputed mean value.
evaluate(double[], double) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the input array, using the precomputed mean value.
evaluate(double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the variance of the entries in the input array, or Double.NaN if the array is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the weighted variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the weighted variance of the entries in the the input array.
evaluate(double[], double, int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.
evaluate(double[], double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the variance of the entries in the input array, using the precomputed mean value.
evaluate(double[], double[], double, int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the weighted variance of the entries in the specified portion of the input array, using the precomputed weighted mean value.
evaluate(double[], double[], double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the weighted variance of the values in the input array, using the precomputed weighted mean value.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Returns the maximum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Returns the minimum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double, KthSelector) - Method in enum org.apache.commons.math3.stat.descriptive.rank.Percentile.EstimationType
Evaluate method to compute the percentile for a given bounded array.
evaluate(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns the result of evaluating the statistic over the stored data.
evaluate(double[], double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns an estimate of the pth percentile of the values in the values array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns an estimate of the quantileth percentile of the designated values in the values array.
evaluate(double[], int, int, double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns an estimate of the pth percentile of the values in the values array, starting with the element in (0-based) position begin in the array and including length values.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns the product of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns the weighted product of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns the weighted product of the entries in the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
The sum of the entries in the specified portion of the input array, or 0 if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
The weighted sum of the entries in the specified portion of the input array, or 0 if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
The weighted sum of the entries in the the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Returns the sum of the natural logs of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Returns the sum of the squares of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[]) - Method in interface org.apache.commons.math3.stat.descriptive.UnivariateStatistic
Returns the result of evaluating the statistic over the input array.
evaluate(double[], int, int) - Method in interface org.apache.commons.math3.stat.descriptive.UnivariateStatistic
Returns the result of evaluating the statistic over the specified entries in the input array.
evaluate(double[], double[]) - Method in interface org.apache.commons.math3.stat.descriptive.WeightedEvaluation
Returns the result of evaluating the statistic over the input array, using the supplied weights.
evaluate(double[], double[], int, int) - Method in interface org.apache.commons.math3.stat.descriptive.WeightedEvaluation
Returns the result of evaluating the statistic over the specified entries in the input array, using corresponding entries in the supplied weights array.
evaluate(double) - Method in class org.apache.commons.math3.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, double) - Method in class org.apache.commons.math3.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, int) - Method in class org.apache.commons.math3.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, double, int) - Method in class org.apache.commons.math3.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double[]) - Method in interface org.apache.commons.math3.util.MathArrays.Function
Operates on an entire array.
evaluate(double[], int, int) - Method in interface org.apache.commons.math3.util.MathArrays.Function
 
evaluate(double) - Method in class org.jlab.groot.demo.CustomFunction
 
evaluate(double) - Method in class org.jlab.groot.math.F1D
 
evaluate(double) - Method in class org.jlab.groot.math.Func1D
 
evaluate(MatrixNodeI, MatrixEvaluator, MatrixJep) - Method in class org.lsmp.djep.matrixJep.function.MAssign
A special methods for evaluating an assignment.
evaluate(MatrixNodeI, MatrixEvaluator, MatrixJep) - Method in class org.lsmp.djep.matrixJep.function.MIf
Evaluate the node, uses lazy evaluation.
evaluate(MatrixNodeI, MatrixEvaluator, MatrixJep) - Method in class org.lsmp.djep.matrixJep.function.MMap
 
evaluate(MatrixNodeI, MatrixJep) - Method in class org.lsmp.djep.matrixJep.MatrixEvaluator
 
evaluate(Node) - Method in class org.lsmp.djep.matrixJep.MatrixJep
Evaluate a node.
evaluate(MatrixNodeI, MatrixEvaluator, MatrixJep) - Method in interface org.lsmp.djep.matrixJep.MatrixSpecialEvaluationI
Returns the result of evaluating this node and the tree below.
evaluate(MRpCommandList) - Method in class org.lsmp.djep.mrpe.MRpEval
Evaluate the expression.
evaluate(RpCommandList) - Method in class org.lsmp.djep.rpe.RpEval
Evaluate the expression.
evaluate(Node, EvaluatorI) - Method in class org.lsmp.djep.vectorJep.function.GenMat
 
evaluate(Node, EvaluatorI) - Method in class org.lsmp.djep.vectorJep.function.VMap
 
evaluate(Node) - Method in class org.lsmp.djep.vectorJep.VectorJep
Evaluate a node.
evaluate(Object[]) - Method in class org.lsmp.djep.xjep.function.Max
 
evaluate(Object[]) - Method in class org.lsmp.djep.xjep.function.MaxArg
 
evaluate(Node, Variable, double, double, double, EvaluatorI) - Method in class org.lsmp.djep.xjep.function.MaxArg
 
evaluate(Object[]) - Method in class org.lsmp.djep.xjep.function.Min
 
evaluate(Object[]) - Method in class org.lsmp.djep.xjep.function.MinArg
 
evaluate(Node, Variable, double, double, double, EvaluatorI) - Method in class org.lsmp.djep.xjep.function.MinArg
 
evaluate(Object[]) - Method in class org.lsmp.djep.xjep.function.Product
 
evaluate(Object[]) - Method in class org.lsmp.djep.xjep.function.Simpson
 
evaluate(Object[]) - Method in class org.lsmp.djep.xjep.function.Sum
 
evaluate(Node, EvaluatorI) - Method in class org.lsmp.djep.xjep.function.SumType
Evaluates the operator in given context.
evaluate(Node, Variable, double, double, double, EvaluatorI) - Method in class org.lsmp.djep.xjep.function.SumType
Evaluates the node by repeatibly setting the value of the variable from min to max, and calculating the value of the first argument.
evaluate(Object[]) - Method in class org.lsmp.djep.xjep.function.SumType
Evaluates the function given the set of y values.
evaluate(Object[]) - Method in class org.lsmp.djep.xjep.function.Trapezium
 
evaluate(Node, Variable, double, double, double, EvaluatorI) - Method in class org.lsmp.djep.xjep.function.Trapezium
 
evaluate(PostfixMathCommandI, Node) - Method in class org.lsmp.djep.xjep.XJep
 
evaluate(CommandElement[], SymbolTable) - Method in class org.nfunk.jep.evaluation.CommandEvaluator
 
evaluate(Node, EvaluatorI) - Method in class org.nfunk.jep.function.Assign
For assignment set the value of the variable on the lhs to value returned by evaluating the righthand side.
evaluate(Node, EvaluatorI) - Method in interface org.nfunk.jep.function.CallbackEvaluationI
Performs some special evaluation on the node.
evaluate(Node, EvaluatorI) - Method in class org.nfunk.jep.function.If
 
evaluate(Node, Object, ParserVisitor, Stack, SymbolTable) - Method in interface org.nfunk.jep.function.SpecialEvaluationI
Deprecated.
Performs some special evaluation on the node.
evaluate(Node) - Method in class org.nfunk.jep.JEP
Evaluate an expression.
evaluate() - Method in class org.nfunk.jepexamples.ThreadTest
Perform a simple evaluation using a new JEP instance.
evaluateAsync(ExecutorService) - Method in class jhplot.math.exp4j.Expression
 
evaluateRaw(Node) - Method in class org.lsmp.djep.matrixJep.MatrixJep
Evaluate a node.
evaluateRaw(Node) - Method in class org.lsmp.djep.vectorJep.VectorJep
Evaluate a node.
evaluateStep(StepInterpolator) - Method in class org.apache.commons.math3.ode.events.EventState
Evaluate the impact of the proposed step on the event handler.
evaluateStep(FieldStepInterpolator<T>) - Method in class org.apache.commons.math3.ode.events.FieldEventState
Evaluate the impact of the proposed step on the event handler.
evaluationChecker(ConvergenceChecker<PointVectorValuePair>) - Static method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresFactory
View a convergence checker specified for a PointVectorValuePair as one specified for an LeastSquaresProblem.Evaluation.
EvaluationRmsChecker - Class in org.apache.commons.math3.fitting.leastsquares
Check if an optimization has converged based on the change in computed RMS.
EvaluationRmsChecker(double) - Constructor for class org.apache.commons.math3.fitting.leastsquares.EvaluationRmsChecker
Create a convergence checker for the RMS with the same relative and absolute tolerance.
EvaluationRmsChecker(double, double) - Constructor for class org.apache.commons.math3.fitting.leastsquares.EvaluationRmsChecker
Create a convergence checker for the RMS with a relative and absolute tolerance.
Evaluator - Class in org.nfunk.jepexamples
This applet is an simple example for how JEP can be used to evaluate expressions.
Evaluator() - Constructor for class org.nfunk.jepexamples.Evaluator
 
EvaluatorI - Interface in org.nfunk.jep
 
EvaluatorVisitor - Class in org.nfunk.jep
This class is used for the evaluation of an expression.
EvaluatorVisitor() - Constructor for class org.nfunk.jep.EvaluatorVisitor
Constructor.
EVD - Class in jhplot.math.pca.covmatrixevd
Eigenvalue decomposition with eigenvectors sorted according to corresponding eigenvalues in a decreasing order.
EVD(Matrix) - Constructor for class jhplot.math.pca.covmatrixevd.EVD
 
EVDBased - Class in jhplot.math.pca.covmatrixevd
Basic covariance matrix eigenvalue decomposition
EVDBased() - Constructor for class jhplot.math.pca.covmatrixevd.EVDBased
 
EVDResult - Class in jhplot.math.pca.covmatrixevd
 
EVDResult(Matrix, Matrix) - Constructor for class jhplot.math.pca.covmatrixevd.EVDResult
 
EVENT_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent
 
EVENT_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent
 
EVENT_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent
 
EVENT_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent
 
EventException - Exception in hep.lcio.exceptions
An exception thrown when adding a item which already exists to an event
EventException(String) - Constructor for exception hep.lcio.exceptions.EventException
 
EventFilter - Class in org.apache.commons.math3.ode.events
Wrapper used to detect only increasing or decreasing events.
EventFilter(EventHandler, FilterType) - Constructor for class org.apache.commons.math3.ode.events.EventFilter
Wrap an event handler.
EventGenerator - Interface in hep.physics.event.generator
An interface to be implemented by all event generators.
EventHandler - Interface in org.apache.commons.math3.ode.events
This interface represents a handler for discrete events triggered during ODE integration.
EventHandler.Action - Enum in org.apache.commons.math3.ode.events
Enumerate for actions to be performed when an event occurs.
eventOccurred(double, double[], boolean) - Method in class org.apache.commons.math3.ode.events.EventFilter
Handle an event and choose what to do next.
eventOccurred(double, double[], boolean) - Method in interface org.apache.commons.math3.ode.events.EventHandler
Handle an event and choose what to do next.
eventOccurred(FieldODEStateAndDerivative<T>, boolean) - Method in interface org.apache.commons.math3.ode.events.FieldEventHandler
Handle an event and choose what to do next.
EVENTS_FIELD_NUMBER - Static variable in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
EVENTS_FIELD_NUMBER - Static variable in class promc.io.ProMCDescriptionFile.ProMCDescription
 
EVENTS_FIELD_NUMBER - Static variable in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
EVENTS_FIELD_NUMBER - Static variable in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
EventShape - Class in hep.physics.jet
Event Shape and Thrust utilities.
EventShape() - Constructor for class hep.physics.jet.EventShape
Create a new instance of EventShape
EventState - Class in org.apache.commons.math3.ode.events
This class handles the state for one event handler during integration steps.
EventState(EventHandler, double, double, int, UnivariateSolver) - Constructor for class org.apache.commons.math3.ode.events.EventState
Simple constructor.
evolve(Population, StoppingCondition) - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Evolve the given population.
exactLog2(int) - Static method in class org.apache.commons.math3.transform.TransformUtils
Returns the base-2 logarithm of the specified int.
exactP(double, int, int, boolean) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Computes \(P(D_{n,m} > d)\) if strict is true; otherwise \(P(D_{n,m} \ge d)\), where \(D_{n,m}\) is the 2-sample Kolmogorov-Smirnov statistic.
exactP(double, int, int, boolean) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
ExceptionContext - Class in org.apache.commons.math3.exception.util
Class that contains the actual implementation of the functionality mandated by the ExceptionContext interface.
ExceptionContext(Throwable) - Constructor for class org.apache.commons.math3.exception.util.ExceptionContext
Simple constructor.
ExceptionContextProvider - Interface in org.apache.commons.math3.exception.util
Interface for accessing the context data structure stored in Commons Math exceptions.
Exch(Z) - Method in class Jampack.Z
Interchanges the real and imaginary parts of two Z's.
execute() - Method in class hep.lcio.util.CommandHandler
Execute the command from parsed args.
execute() - Method in class hep.lcio.util.CompareCommandHandler
Execute the merge compare with current arguments.
execute() - Method in class hep.lcio.util.ConcatenateCommandHandler
Execute the concat command with current options.
execute() - Method in class hep.lcio.util.HeaderCountCommandHandler
Execute the count command with current arguments.
execute() - Method in class hep.lcio.util.MergeCommandHandler
Execute the merge command with current arguments.
execute() - Method in class hep.lcio.util.PrintCommandHandler
 
execute() - Method in class hep.lcio.util.RandomEventCommandHandler
Execute the random command with current options.
execute() - Method in class hep.lcio.util.RunCommandHandler
 
execute() - Method in class hep.lcio.util.SelectCommandHandler
 
execute() - Method in class hep.lcio.util.SIODumpCommandHandler
Execute the siodump command with current options.
execute() - Method in class hep.lcio.util.SizeCommandHandler
 
execute() - Method in class hep.lcio.util.SplitCommandHandler
Execute the split command with current options.
execute() - Method in class hep.lcio.util.StdhepConvertCommandHandler
 
execute() - Method in class hep.lcio.util.ValidateCommandHandler
Execute the validate command with current options.
executeQuery(String) - Method in class org.jfree.data.jdbc.JDBCCategoryDataset
Populates the dataset by executing the supplied query against the existing database connection.
executeQuery(Connection, String) - Method in class org.jfree.data.jdbc.JDBCCategoryDataset
Populates the dataset by executing the supplied query against the existing database connection.
executeQuery(String) - Method in class org.jfree.data.jdbc.JDBCPieDataset
ExecuteQuery will attempt execute the query passed to it against the existing database connection.
executeQuery(Connection, String) - Method in class org.jfree.data.jdbc.JDBCPieDataset
ExecuteQuery will attempt execute the query passed to it against the existing database connection.
executeQuery(String) - Method in class org.jfree.data.jdbc.JDBCXYDataset
ExecuteQuery will attempt execute the query passed to it against the existing database connection.
executeQuery(Connection, String) - Method in class org.jfree.data.jdbc.JDBCXYDataset
ExecuteQuery will attempt execute the query passed to it against the provided database connection.
exists(String) - Method in class org.jlab.groot.data.Directory
 
exitApplication() - Method in class jhepsim.HepsimGUI
Exit application.
exitWhenFinished() - Static method in class org.apache.commons.io.FileCleaner
exitWhenFinished() - Method in class org.apache.commons.io.FileCleaningTracker
Call this method to cause the file cleaner thread to terminate when there are no more objects being tracked for deletion.
exp - Static variable in class cern.jet.math.Functions
Function that returns Math.exp(a).
exp() - Method in class jhplot.math.Complex
Complex exponential (doesn't change this Complex number).
exp(ValueErr) - Method in class jhplot.math.ValueErr
Get exponential function
EXP - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
exp(double) - Static method in class net.jafama.FastMath
 
exp(double) - Static method in class net.jafama.StrictFastMath
 
exp() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Exponential.
exp(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute exponential of a derivative structure.
exp() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Exponential.
Exp - Class in org.apache.commons.math3.analysis.function
Exponential function.
Exp() - Constructor for class org.apache.commons.math3.analysis.function.Exp
 
exp() - Method in class org.apache.commons.math3.complex.Complex
Compute the exponential function of this complex number.
exp() - Method in class org.apache.commons.math3.dfp.Dfp
Exponential.
exp(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
Computes e to the given power.
exp() - Method in interface org.apache.commons.math3.RealFieldElement
Exponential.
exp() - Method in class org.apache.commons.math3.util.Decimal64
Exponential.
exp(double) - Static method in class org.apache.commons.math3.util.FastMath
Exponential function.
Exp - Class in org.nfunk.jep.function
The exp function.
Exp() - Constructor for class org.nfunk.jep.function.Exp
 
exp(Object) - Method in class org.nfunk.jep.function.Exp
 
exp10(double) - Static method in class jplot.Axis
 
expand() - Method in class jhplot.F1D
Convert this function rewrite in expanded form.
expand() - Method in class jhplot.F2D
Convert this function rewrite in expanded form.
expand(Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.axis.AxisSpace
Expands an area by the amount of space represented by this object.
expand(Range, double, double) - Static method in class org.jfree.data.Range
Creates a new range by adding margins to an existing range.
expand() - Method in class org.lsmp.djep.sjep.Monomial
 
expand() - Method in class org.lsmp.djep.sjep.PConstant
 
expand() - Method in class org.lsmp.djep.sjep.PFunction
 
expand() - Method in interface org.lsmp.djep.sjep.PNodeI
complete expansion.
expand() - Method in class org.lsmp.djep.sjep.Polynomial
 
expand(Node) - Method in class org.lsmp.djep.sjep.PolynomialCreator
Expands an expression.
expand() - Method in class org.lsmp.djep.sjep.POperator
 
expand() - Method in class org.lsmp.djep.sjep.PVariable
 
ExpandableStatefulODE - Class in org.apache.commons.math3.ode
This class represents a combined set of first order differential equations, with at least a primary set of equations expandable by some sets of secondary equations.
ExpandableStatefulODE(FirstOrderDifferentialEquations) - Constructor for class org.apache.commons.math3.ode.ExpandableStatefulODE
Build an expandable set from its primary ODE set.
ExpandBrackets - Class in org.lsmp.djep.rewrite
 
ExpandBrackets(XJep) - Constructor for class org.lsmp.djep.rewrite.ExpandBrackets
TODO cope with a * uminus(x+x)
ExpandPower - Class in org.lsmp.djep.rewrite
 
ExpandPower(XJep) - Constructor for class org.lsmp.djep.rewrite.ExpandPower
 
expandTestString(String, String) - Method in class org.lsmp.djepJUnit.SJepTest
 
expandToInclude(Range, double) - Static method in class org.jfree.data.Range
Returns a range that includes all the values in the specified range AND the specified value.
ExpData - Class in jhplot.stat.limit
Build experiment.
ExpData() - Constructor for class jhplot.stat.limit.ExpData
Simple constructor
ExpData(int, double, double) - Constructor for class jhplot.stat.limit.ExpData
Build an experiment
ExpData(int, double, double, double, double) - Constructor for class jhplot.stat.limit.ExpData
Build an experimental data
EXPECT_DELAY_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
expectedTokenSequences - Variable in exception jplot3dp.MathParser.ParseException
Each entry in this array is an array of integers.
expectedTokenSequences - Variable in exception org.nfunk.jep.ParseException
Each entry in this array is an array of integers.
explainMissing() - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
expm1(double) - Static method in class net.jafama.FastMath
Much more accurate than exp(value)-1, for arguments (and results) close to zero.
expm1(double) - Static method in class net.jafama.StrictFastMath
Much more accurate than exp(value)-1, for arguments (and results) close to zero.
expm1() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Exponential minus 1.
expm1(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute exp(x) - 1 of a derivative structure.
expm1() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Exponential minus 1.
Expm1 - Class in org.apache.commons.math3.analysis.function
ex-1 function.
Expm1() - Constructor for class org.apache.commons.math3.analysis.function.Expm1
 
expm1() - Method in class org.apache.commons.math3.dfp.Dfp
Exponential minus 1.
expm1() - Method in interface org.apache.commons.math3.RealFieldElement
Exponential minus 1.
expm1() - Method in class org.apache.commons.math3.util.Decimal64
Exponential minus 1.
expm1(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute exp(x) - 1
Exponent - Class in jhplot.fit
Exponential distribution.
Exponent() - Constructor for class jhplot.fit.Exponent
 
Exponent(String) - Constructor for class jhplot.fit.Exponent
 
Exponent(String[], String[]) - Constructor for class jhplot.fit.Exponent
 
EXPONENT - Static variable in interface org.nfunk.jep.ParserConstants
 
Exponential - Class in cern.jet.random
Exponential Distribution (aka Negative Exponential Distribution); See the math definition animated definition.
Exponential(double, RandomEngine) - Constructor for class cern.jet.random.Exponential
Constructs a Negative Exponential distribution.
Exponential - Class in jhplot.math.num.pdf
The Exponential distribution (1).
Exponential() - Constructor for class jhplot.math.num.pdf.Exponential
Default constructor.
Exponential(double) - Constructor for class jhplot.math.num.pdf.Exponential
Create a distribution with the given mean.
exponential(double) - Static method in class jhplot.math.Random
Generate a random number from an exponantial random variable (Mean = 1/lambda, variance = 1/lambda^2).
EXPONENTIAL_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Exponential random deviates with mean = μ.
exponentialDecay(double, double, long) - Static method in class org.apache.commons.math3.ml.neuralnet.sofm.LearningFactorFunctionFactory
Creates an exponential decay function.
exponentialDecay(double, double, long) - Static method in class org.apache.commons.math3.ml.neuralnet.sofm.NeighbourhoodSizeFunctionFactory
Creates an exponential decay function.
ExponentialDecayFunction - Class in org.apache.commons.math3.ml.neuralnet.sofm.util
Exponential decay function: a e-x / b, where x is the (integer) independent variable.
ExponentialDecayFunction(double, double, long) - Constructor for class org.apache.commons.math3.ml.neuralnet.sofm.util.ExponentialDecayFunction
Creates an instance.
ExponentialDistribution - Class in org.apache.commons.math3.distribution
Implementation of the exponential distribution.
ExponentialDistribution(double) - Constructor for class org.apache.commons.math3.distribution.ExponentialDistribution
Create an exponential distribution with the given mean.
ExponentialDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.ExponentialDistribution
Create an exponential distribution with the given mean.
ExponentialDistribution(RandomGenerator, double) - Constructor for class org.apache.commons.math3.distribution.ExponentialDistribution
Creates an exponential distribution.
ExponentialDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.ExponentialDistribution
Creates an exponential distribution.
ExponentialPower - Class in cern.jet.random
Exponential Power distribution.
ExponentialPower(double, RandomEngine) - Constructor for class cern.jet.random.ExponentialPower
Constructs an Exponential Power distribution.
ExponentialRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Exponential distribution.
ExponentialRandomVariable() - Constructor for class jhplot.math.num.random.ExponentialRandomVariable
Default constructor.
ExponentialRandomVariable(double) - Constructor for class jhplot.math.num.random.ExponentialRandomVariable
Create a random variable with the given mean.
ExponentialRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.ExponentialRandomVariable
Create a random variable with the given parameters.
exponentLengthToJava2D(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.LogAxis
Converts a length in data coordinates into the corresponding length in Java2D coordinates.
export(String) - Method in class jhplot.gui.GHPanel
Fast export of the canvas to an image file.
export(String) - Method in class jhplot.HChart
Export graph into an image file.
export(String, int, int) - Method in class jhplot.HChart
Export graph into an image file.
export(String) - Method in class jhplot.HPlotJas
Fast export of the canvas to an image file.
export(Component, String, String) - Static method in class jhplot.io.images.ExportVGraphics
Fast export of the canvas to an image file.
exportCSV(File) - Method in class jplot3d.SurfaceModelCanvas
 
exportDialog(Component, String, JFrame) - Static method in class jhplot.io.images.ExportVGraphics
Exports the image to some graphic format.
exportHipo(SparseVectorGrid, String) - Static method in class org.jlab.groot.matrix.SparseGridIO
 
ExportUtils - Class in org.jfree.chart.util
Utility functions for exporting charts to SVG and PDF format.
ExportUtils() - Constructor for class org.jfree.chart.util.ExportUtils
 
ExportVGraphics - Class in jhplot.io.images
Export graphics in different formats.
ExportVGraphics() - Constructor for class jhplot.io.images.ExportVGraphics
 
expQuick(double) - Static method in class net.jafama.FastMath
Quick exp, with a max relative error of about 2.94e-2 for |value| < 700.0 or so, and no accuracy at all outside this range.
expQuick(double) - Static method in class net.jafama.StrictFastMath
Quick exp, with a max relative error of about 2.94e-2 for |value| < 700.0 or so, and no accuracy at all outside this range.
Expression - Class in jhplot.math.exp4j
 
Expression() - Method in class jplot3dp.MathParser.MathParser
 
expression - Variable in class jplot3dp.ModelView.ModelFunction
 
Expression() - Method in class org.nfunk.jep.Parser
 
ExpressionBuilder - Class in jhplot.math.exp4j
Factory class for Expression instances.
ExpressionBuilder(String) - Constructor for class jhplot.math.exp4j.ExpressionBuilder
Create a new ExpressionBuilder instance and initialize it with a given expression string.
ExpressionCompiler - Class in org.nfunk.jep.evaluation
 
ExpressionCompiler() - Constructor for class org.nfunk.jep.evaluation.ExpressionCompiler
 
ExtendedCategoryAxis - Class in org.jfree.chart.axis
An extended version of the CategoryAxis class that supports sublabels on the axis.
ExtendedCategoryAxis(String) - Constructor for class org.jfree.chart.axis.ExtendedCategoryAxis
Creates a new axis.
ExtendedFreeGroup - Class in org.lsmp.djep.groupJep.groups
An extended version of a Free Group, limted seport for powers and division.
ExtendedFreeGroup(RingI, String) - Constructor for class org.lsmp.djep.groupJep.groups.ExtendedFreeGroup
 
extendedPrint(RpCommandList) - Static method in class org.lsmp.djepExamples.RpExample
 
extendLine(double[], double[], double, double) - Static method in class jplot.Geometry
Extend a given line segment to a specified length.
extendLine(double[], double[], double) - Static method in class jplot.Geometry
Extend a given line segment to a given length and holding the first point of the line as fixed.
extendLine(Line2D, double, double) - Static method in class org.jfree.chart.util.LineUtilities
Creates a new line by extending an existing line.
EXTENSION_COMPARATOR - Static variable in class org.apache.commons.io.comparator.ExtensionFileComparator
Case-sensitive extension comparator instance (see IOCase.SENSITIVE)
EXTENSION_INSENSITIVE_COMPARATOR - Static variable in class org.apache.commons.io.comparator.ExtensionFileComparator
Case-insensitive extension comparator instance (see IOCase.INSENSITIVE)
EXTENSION_INSENSITIVE_REVERSE - Static variable in class org.apache.commons.io.comparator.ExtensionFileComparator
Reverse case-insensitive extension comparator instance (see IOCase.INSENSITIVE)
EXTENSION_REVERSE - Static variable in class org.apache.commons.io.comparator.ExtensionFileComparator
Reverse case-sensitive extension comparator instance (see IOCase.SENSITIVE)
EXTENSION_SEPARATOR - Static variable in class org.apache.commons.io.FilenameUtils
The extension separator character.
EXTENSION_SEPARATOR_STR - Static variable in class org.apache.commons.io.FilenameUtils
The extension separator String.
EXTENSION_SYSTEM_COMPARATOR - Static variable in class org.apache.commons.io.comparator.ExtensionFileComparator
System sensitive extension comparator instance (see IOCase.SYSTEM)
EXTENSION_SYSTEM_REVERSE - Static variable in class org.apache.commons.io.comparator.ExtensionFileComparator
Reverse system sensitive path comparator instance (see IOCase.SYSTEM)
ExtensionFileComparator - Class in org.apache.commons.io.comparator
Compare the file name extensions for order (see FilenameUtils.getExtension(String)).
ExtensionFileComparator() - Constructor for class org.apache.commons.io.comparator.ExtensionFileComparator
Construct a case sensitive file extension comparator instance.
ExtensionFileComparator(IOCase) - Constructor for class org.apache.commons.io.comparator.ExtensionFileComparator
Construct a file extension comparator instance with the specified case-sensitivity.
ExtensionFileFilter - Class in jhplot.utils
File filters
ExtensionFileFilter(String, String) - Constructor for class jhplot.utils.ExtensionFileFilter
 
ExtensionFileFilter(String, String[]) - Constructor for class jhplot.utils.ExtensionFileFilter
 
ExteriorProduct - Class in org.lsmp.djep.vectorJep.function
An overloaded operator, either cross product or power.
ExteriorProduct() - Constructor for class org.lsmp.djep.vectorJep.function.ExteriorProduct
 
exteriorProduct(MVector, MVector) - Method in class org.lsmp.djep.vectorJep.function.ExteriorProduct
 
extOfInt(int) - Method in class org.freehep.math.minuit.MnUserParameterState
 
extract(int, int, double[]) - Static method in class jhplot.math.ArrayMathUtils
Extracts a sub-array (will invert the resulting array if k0 > k1).
extract(int, int, int[]) - Static method in class jhplot.math.ArrayMathUtils
Extracts a sub-array (will invert the resulting array if k0 > k1).
extractColumnFromHeatMapDataset(HeatMapDataset, int, Comparable) - Static method in class org.jfree.data.general.HeatMapUtilities
Returns a dataset containing one series that holds a copy of the (y, z) data from one column (x-index) of the specified dataset.
extractEquationData(double[], double[]) - Method in class org.apache.commons.math3.ode.EquationsMapper
Extract equation data from a complete state or derivative array.
extractEquationData(int, T[]) - Method in class org.apache.commons.math3.ode.FieldEquationsMapper
Extract equation data from a complete state or derivative array.
extractRowFromHeatMapDataset(HeatMapDataset, int, Comparable) - Static method in class org.jfree.data.general.HeatMapUtilities
Returns a dataset containing one series that holds a copy of the (x, z) data from one row (y-index) of the specified dataset.
extraEntries() - Method in interface colt.hep.aida.IHistogram
Number of under and overflow entries in the histogram.
extraEntries() - Method in class jhplot.H1D
Number of under and overflow entries in the histogram.
extraEntries() - Method in class jhplot.H2D
Get the number of entries in the underflow and overflow bins.
extraEntries() - Method in class jhplot.HProf1D
Number of under and overflow entries in the histogram.
extraEntries() - Method in class jhplot.HProf2D
Get the number of entries in the underflow and overflow bins.
Eye - Class in Jampack
Eye generates a matrix whose diagonal elements are one and whose off diagonal elements are zero.
Eye() - Constructor for class Jampack.Eye
 

F

f(double[][], Function) - Static method in class jhplot.math.DoubleArray
Apply a scalar function to every element of an array.
f(double[], Function) - Static method in class jhplot.math.DoubleArray
Apply a scalar function to every element of an array.
f(double) - Method in interface jhplot.math.Function
 
F1D - Class in jhplot
Create a function in one dimension using "x" as a variable.
F1D(String) - Constructor for class jhplot.F1D
Create a function in 1D.
F1D(FProxy) - Constructor for class jhplot.F1D
Initialize function from proxy.
F1D(String, String) - Constructor for class jhplot.F1D
Create new function.
F1D(String, String, double, double) - Constructor for class jhplot.F1D
Create a new function.
F1D(String, double, double, boolean) - Constructor for class jhplot.F1D
Define a ranged function.
F1D(String, IFunction, double, double) - Constructor for class jhplot.F1D
Create F1D function from JAIDA IFunction.
F1D(String, String, double, double, boolean) - Constructor for class jhplot.F1D
Create a new function.
F1D(IFunction, double, double) - Constructor for class jhplot.F1D
Create a F1D function from JAIDA IFunction in ranges.
F1D(String, double, double) - Constructor for class jhplot.F1D
Create a new function in pre-defined range for plotting.
F1D(String, String, boolean) - Constructor for class jhplot.F1D
Create a new function in pre-defined range for plotting.
F1D(String, double[], boolean) - Constructor for class jhplot.F1D
Create a polynomial analytical function using a list of values.
F1D(String, boolean) - Constructor for class jhplot.F1D
Build a function.
F1D(String, ExpressionBuilder) - Constructor for class jhplot.F1D
Create a function in 1D.
F1D(Expression, double, double) - Constructor for class jhplot.F1D
Create a function from the expression.
F1D(String, Expression, double, double) - Constructor for class jhplot.F1D
Create a function in 1D.
F1D(String, Expression) - Constructor for class jhplot.F1D
Create a function in 1D.
F1D(Expression) - Constructor for class jhplot.F1D
Create a function in 1D.
F1D(ExpressionBuilder) - Constructor for class jhplot.F1D
Build a function.
F1D(IFunction) - Constructor for class jhplot.F1D
Create a F1D function from JAIDA IFunction.
F1D(String, IFunction) - Constructor for class jhplot.F1D
Create F1D function from JAIDA IFunction.
F1D - Static variable in class jplot.LinePars
 
F1D - Class in org.jlab.groot.math
 
F1D(String) - Constructor for class org.jlab.groot.math.F1D
 
F1D(String, String, double, double) - Constructor for class org.jlab.groot.math.F1D
 
F1D_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
F2D - Class in jhplot
Create 2D function.
F2D(String) - Constructor for class jhplot.F2D
Create a function in 2D for evaluation.
F2D(String, String) - Constructor for class jhplot.F2D
Create new function.
F2D(String, String, double, double, double, double) - Constructor for class jhplot.F2D
Create a function in 2D.
F2D(String, double, double, double, double) - Constructor for class jhplot.F2D
Build a 2D function.
F2D(String, IFunction, double, double, double, double) - Constructor for class jhplot.F2D
Create a F2D function from JAIDA IFunction.
F2D(String, Expression, double, double, double, double) - Constructor for class jhplot.F2D
Create a function in 2D.
F2D(Expression, double, double, double, double) - Constructor for class jhplot.F2D
Create a function in 2D.
F2D(IFunction) - Constructor for class jhplot.F2D
Create a F2D function from JAIDA IFunction.
F2D(FProxy) - Constructor for class jhplot.F2D
Initialize function from proxy.
F2D(IFunction, double, double, double, double) - Constructor for class jhplot.F2D
Create a F2D function from JAIDA IFunction.
F2D_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
F3D - Class in jhplot
Create 3D function using 3 independent variables: x,y,z.
F3D(String) - Constructor for class jhplot.F3D
Create a function in 3D for evaluation.
F3D(String, String, double, double, double, double, double, double) - Constructor for class jhplot.F3D
Create a function in 3D.
F3D(String, double, double, double, double, double, double) - Constructor for class jhplot.F3D
Build a 3D function.
F3D(String, String, IFunction, double, double, double, double, double, double) - Constructor for class jhplot.F3D
Create a function in 3D from a AIDA IFunction.
F3D(String, IFunction, double, double, double, double, double, double) - Constructor for class jhplot.F3D
 
F3D(FProxy) - Constructor for class jhplot.F3D
Initialize function from proxy.
F3D(IFunction, double, double, double, double, double, double) - Constructor for class jhplot.F3D
Create a function in 3D from a AIDA IFunction.
fac(double) - Static method in class graph.SpecialFunction
 
fac(int) - Static method in class graph.SpecialFunction
 
face() - Static method in class jhepsim.SetEnv
Set faces.
factorial(int) - Static method in class cern.jet.math.Arithmetic
Instantly returns the factorial k!.
factorial - Static variable in class cern.jet.math.IntFunctions
Function that returns (int) Arithmetic.factorial(a).
factorial(int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
factorial(int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Returns n!.
factorialDouble(int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
factorialDouble(int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Compute n!, the factorial of n (the product of the numbers 1 to n), as a double.
factorialLog(int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
factorialLog(int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Compute the natural logarithm of the factorial of n.
FactorialMoments - Class in jhplot.stat
Normalised factorial moments (NFM).
FactorialMoments(int, int, int, double, double) - Constructor for class jhplot.stat.FactorialMoments
Initialize factorial-moment calculations.
factories() - Method in class jhplot.HPlot
Create various JAIDA factories: IAnalysisFactory, ITree, IFitFactory, IFunctionFactory
factorize() - Method in class jhplot.F1D
Convert this function rewrite in factorized form (if can).
factorize() - Method in class jhplot.F2D
Convert this function rewrite in factorized form (if can).
FakeTKey - Class in root
 
FakeTKey(TNamed) - Constructor for class root.FakeTKey
 
FALSE - Static variable in class org.apache.commons.io.filefilter.FalseFileFilter
Singleton instance of false filter.
FalseFileFilter - Class in org.apache.commons.io.filefilter
A file filter that always returns false.
falseFileFilter() - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that always returns false.
FalsePositionRootFinder - Class in jhplot.math.num.root
The false position method (1) for finding roots of functions.
FalsePositionRootFinder(Function) - Constructor for class jhplot.math.num.root.FalsePositionRootFinder
Create a root finder for the given function.
FalsePositionRootFinder(Function, int, double) - Constructor for class jhplot.math.num.root.FalsePositionRootFinder
Create a root finder for the given function.
farad - Static variable in class cern.clhep.Units
 
fastButton - Variable in class org.jlab.groot.studio.StudioToolBar
 
FastCosineTransformer - Class in org.apache.commons.math3.transform
Implements the Fast Cosine Transform for transformation of one-dimensional real data sets.
FastCosineTransformer(DctNormalization) - Constructor for class org.apache.commons.math3.transform.FastCosineTransformer
Creates a new instance of this class, with various normalization conventions.
FastFourierTransformer - Class in org.apache.commons.math3.transform
Implements the Fast Fourier Transform for transformation of one-dimensional real or complex data sets.
FastFourierTransformer(DftNormalization) - Constructor for class org.apache.commons.math3.transform.FastFourierTransformer
Creates a new instance of this class, with various normalization conventions.
FastHadamardTransformer - Class in org.apache.commons.math3.transform
Implements the Fast Hadamard Transform (FHT).
FastHadamardTransformer() - Constructor for class org.apache.commons.math3.transform.FastHadamardTransformer
 
FastMath - Class in net.jafama
Class providing math treatments that: - are meant to be faster than java.lang.Math class equivalents (if any), - are still somehow accurate and robust (handling of NaN and such), - do not (or not directly) generate objects at run time (no "new").
FastMath - Class in org.apache.commons.math3.util
Faster, more accurate, portable alternative to Math and StrictMath for large scale computation.
FastScatterPlot - Class in org.jfree.chart.plot
A fast scatter plot.
FastScatterPlot() - Constructor for class org.jfree.chart.plot.FastScatterPlot
Creates a new instance of FastScatterPlot with default axes.
FastScatterPlot(float[][], ValueAxis, ValueAxis) - Constructor for class org.jfree.chart.plot.FastScatterPlot
Creates a new fast scatter plot.
FastSineTransformer - Class in org.apache.commons.math3.transform
Implements the Fast Sine Transform for transformation of one-dimensional real data sets.
FastSineTransformer(DstNormalization) - Constructor for class org.apache.commons.math3.transform.FastSineTransformer
Creates a new instance of this class, with various normalization conventions.
fbar(int, double) - Static method in class jhplot.math.KolmogorovSmirnovDist
Computes the complementary cumulative probability P[D_n >= x] of the Kolmogorov-Smirnov distribution with sample size n at x.
FCNBase - Interface in org.freehep.math.minuit
User function base class, has to be implemented by the user.
fcnbase() - Method in class org.freehep.math.minuit.MnApplication
 
FCNGradientBase - Interface in org.freehep.math.minuit
Extension of FCNBase for providing the analytical gradient of the function.
FDATA_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
FDATA_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
FDATA_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent.Event
 
FDistribution - Class in jhplot.math.num.pdf
The F distribution (1).
FDistribution() - Constructor for class jhplot.math.num.pdf.FDistribution
Default constructor.
FDistribution(double, double) - Constructor for class jhplot.math.num.pdf.FDistribution
Create a distribution with the given numerator degrees of freedom and denominator degrees of freedom.
FDistribution - Class in org.apache.commons.math3.distribution
Implementation of the F-distribution.
FDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.FDistribution
Creates an F distribution using the given degrees of freedom.
FDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.FDistribution
Creates an F distribution using the given degrees of freedom and inverse cumulative probability accuracy.
FDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.FDistribution
Creates an F distribution.
FDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.FDistribution
Creates an F distribution.
FeatureInitializer - Interface in org.apache.commons.math3.ml.neuralnet
Defines how to assign the first value of a neuron's feature.
FeatureInitializerFactory - Class in org.apache.commons.math3.ml.neuralnet
Creates functions that will select the initial values of a neuron's features.
fermi - Static variable in class cern.clhep.Units
 
fewestTracks() - Method in class hep.physics.jet.AbstractJetFinder
 
fewestTracks() - Method in class hep.physics.jet.FixNumberOfJetsFinder
 
fewestTracks() - Method in interface hep.physics.jet.JetFinder
Find the jet with the fewest particles
fexp10(double) - Static method in class jplot.Axis
 
fi(int) - Method in interface jhplot.math.IndexFunction
 
Field<T> - Interface in org.apache.commons.math3
Interface representing a field.
FieldBracketingNthOrderBrentSolver<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.analysis.solvers
This class implements a modification of the Brent algorithm.
FieldBracketingNthOrderBrentSolver(T, T, T, int) - Constructor for class org.apache.commons.math3.analysis.solvers.FieldBracketingNthOrderBrentSolver
Construct a solver.
FieldButcherArrayProvider<T extends RealFieldElement<T>> - Interface in org.apache.commons.math3.ode.nonstiff
This interface represents an integrator based on Butcher arrays.
FieldDecompositionSolver<T extends FieldElement<T>> - Interface in org.apache.commons.math3.linear
Interface handling decomposition algorithms that can solve A × X = B.
FieldElement<T> - Interface in org.apache.commons.math3
Interface representing field elements.
FieldEquationsMapper<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode
Class mapping the part of a complete state or derivative that pertains to a set of differential equations.
FieldEventHandler<T extends RealFieldElement<T>> - Interface in org.apache.commons.math3.ode.events
This interface represents a handler for discrete events triggered during ODE integration.
FieldEventState<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.events
This class handles the state for one event handler during integration steps.
FieldEventState(FieldEventHandler<T>, double, T, int, BracketedRealFieldUnivariateSolver<T>) - Constructor for class org.apache.commons.math3.ode.events.FieldEventState
Simple constructor.
FieldExpandableODE<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode
This class represents a combined set of first order differential equations, with at least a primary set of equations expandable by some sets of secondary equations.
FieldExpandableODE(FirstOrderFieldDifferentialEquations<T>) - Constructor for class org.apache.commons.math3.ode.FieldExpandableODE
Build an expandable set from its primary ODE set.
FieldFixedStepHandler<T extends RealFieldElement<T>> - Interface in org.apache.commons.math3.ode.sampling
This interface represents a handler that should be called after each successful fixed step.
FieldHermiteInterpolator<T extends FieldElement<T>> - Class in org.apache.commons.math3.analysis.interpolation
Polynomial interpolator using both sample values and sample derivatives.
FieldHermiteInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.FieldHermiteInterpolator
Create an empty interpolator.
FieldI - Interface in org.lsmp.djep.groupJep.interfaces
Represents a field.
FieldLUDecomposition<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Calculates the LUP-decomposition of a square matrix.
FieldLUDecomposition(FieldMatrix<T>) - Constructor for class org.apache.commons.math3.linear.FieldLUDecomposition
Calculates the LU-decomposition of the given matrix.
FieldMatrix<T extends FieldElement<T>> - Interface in org.apache.commons.math3.linear
Interface defining field-valued matrix with basic algebraic operations.
FieldMatrixChangingVisitor<T extends FieldElement<?>> - Interface in org.apache.commons.math3.linear
Interface defining a visitor for matrix entries.
FieldMatrixPreservingVisitor<T extends FieldElement<?>> - Interface in org.apache.commons.math3.linear
Interface defining a visitor for matrix entries.
FieldODEState<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode
Container for time, main and secondary state vectors.
FieldODEState(T, T[]) - Constructor for class org.apache.commons.math3.ode.FieldODEState
Simple constructor.
FieldODEState(T, T[], T[][]) - Constructor for class org.apache.commons.math3.ode.FieldODEState
Simple constructor.
FieldODEStateAndDerivative<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode
Container for time, main and secondary state vectors as well as their derivatives.
FieldODEStateAndDerivative(T, T[], T[]) - Constructor for class org.apache.commons.math3.ode.FieldODEStateAndDerivative
Simple constructor.
FieldODEStateAndDerivative(T, T[], T[], T[][], T[][]) - Constructor for class org.apache.commons.math3.ode.FieldODEStateAndDerivative
Simple constructor.
FieldRotation<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.geometry.euclidean.threed
This class is a re-implementation of Rotation using RealFieldElement.
FieldRotation(T, T, T, T, boolean) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build a rotation from the quaternion coordinates.
FieldRotation(FieldVector3D<T>, T) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
FieldRotation(FieldVector3D<T>, T, RotationConvention) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build a rotation from an axis and an angle.
FieldRotation(T[][], double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build a rotation from a 3X3 matrix.
FieldRotation(FieldVector3D<T>, FieldVector3D<T>, FieldVector3D<T>, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build the rotation that transforms a pair of vectors into another pair.
FieldRotation(FieldVector3D<T>, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build one of the rotations that transform one vector into another one.
FieldRotation(RotationOrder, T, T, T) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
FieldRotation(RotationOrder, RotationConvention, T, T, T) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build a rotation from three Cardan or Euler elementary rotations.
FieldSecondaryEquations<T extends RealFieldElement<T>> - Interface in org.apache.commons.math3.ode
This interface allows users to add secondary differential equations to a primary set of differential equations.
FieldStepHandler<T extends RealFieldElement<T>> - Interface in org.apache.commons.math3.ode.sampling
This interface represents a handler that should be called after each successful step.
FieldStepInterpolator<T extends RealFieldElement<T>> - Interface in org.apache.commons.math3.ode.sampling
This interface represents an interpolator over the last step during an ODE integration.
FieldStepNormalizer<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.sampling
This class wraps an object implementing FieldFixedStepHandler into a FieldStepHandler.
FieldStepNormalizer(double, FieldFixedStepHandler<T>) - Constructor for class org.apache.commons.math3.ode.sampling.FieldStepNormalizer
Simple constructor.
FieldStepNormalizer(double, FieldFixedStepHandler<T>, StepNormalizerMode) - Constructor for class org.apache.commons.math3.ode.sampling.FieldStepNormalizer
Simple constructor.
FieldStepNormalizer(double, FieldFixedStepHandler<T>, StepNormalizerBounds) - Constructor for class org.apache.commons.math3.ode.sampling.FieldStepNormalizer
Simple constructor.
FieldStepNormalizer(double, FieldFixedStepHandler<T>, StepNormalizerMode, StepNormalizerBounds) - Constructor for class org.apache.commons.math3.ode.sampling.FieldStepNormalizer
Simple constructor.
FieldVector<T extends FieldElement<T>> - Interface in org.apache.commons.math3.linear
Interface defining a field-valued vector with basic algebraic operations.
FieldVector3D<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.geometry.euclidean.threed
This class is a re-implementation of Vector3D using RealFieldElement.
FieldVector3D(T, T, T) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Simple constructor.
FieldVector3D(T[]) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Simple constructor.
FieldVector3D(T, T) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Simple constructor.
FieldVector3D(T, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Multiplicative constructor Build a vector from another one and a scale factor.
FieldVector3D(T, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Multiplicative constructor Build a vector from another one and a scale factor.
FieldVector3D(double, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Multiplicative constructor Build a vector from another one and a scale factor.
FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from two other ones and corresponding scale factors.
FieldVector3D(T, Vector3D, T, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from two other ones and corresponding scale factors.
FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from two other ones and corresponding scale factors.
FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from three other ones and corresponding scale factors.
FieldVector3D(T, Vector3D, T, Vector3D, T, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from three other ones and corresponding scale factors.
FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from three other ones and corresponding scale factors.
FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from four other ones and corresponding scale factors.
FieldVector3D(T, Vector3D, T, Vector3D, T, Vector3D, T, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from four other ones and corresponding scale factors.
FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from four other ones and corresponding scale factors.
FieldVectorChangingVisitor<T extends FieldElement<?>> - Interface in org.apache.commons.math3.linear
This interface defines a visitor for the entries of a vector.
FieldVectorPreservingVisitor<T extends FieldElement<?>> - Interface in org.apache.commons.math3.linear
This interface defines a visitor for the entries of a vector.
FIFTEEN_MINUTE_SEGMENT_SIZE - Static variable in class org.jfree.chart.axis.SegmentedTimeline
Defines a 15-minute segment size in ms.
file() - Method in class hep.lcio.util.MergeFileParameters
Get a file object for these input events.
file - Static variable in class jhepsim.Main
 
FILE - Static variable in class org.apache.commons.io.filefilter.FileFileFilter
Singleton instance of file filter
file_input - Static variable in class jminhep.gui.MainFrame
 
file_open - Static variable in class jminhep.gui.MainFrame
 
file_save - Static variable in class jminhep.gui.MainFrame
 
FileAida - Class in jhplot.io
Open an AIDA file and retrieve objects for plotting.
FileAida(String) - Constructor for class jhplot.io.FileAida
Create object to read AIDA file.
FileAida(String, boolean) - Constructor for class jhplot.io.FileAida
Create object to read AIDA file.
FileAida() - Constructor for class jhplot.io.FileAida
Create FileAida
FileAlterationListener - Interface in org.apache.commons.io.monitor
A listener that receives events of file system modifications.
FileAlterationListenerAdaptor - Class in org.apache.commons.io.monitor
Convenience FileAlterationListener implementation that does nothing.
FileAlterationListenerAdaptor() - Constructor for class org.apache.commons.io.monitor.FileAlterationListenerAdaptor
 
FileAlterationMonitor - Class in org.apache.commons.io.monitor
A runnable that spawns a monitoring thread triggering any registered FileAlterationObserver at a specified interval.
FileAlterationMonitor() - Constructor for class org.apache.commons.io.monitor.FileAlterationMonitor
Constructs a monitor with a default interval of 10 seconds.
FileAlterationMonitor(long) - Constructor for class org.apache.commons.io.monitor.FileAlterationMonitor
Constructs a monitor with the specified interval.
FileAlterationMonitor(long, FileAlterationObserver...) - Constructor for class org.apache.commons.io.monitor.FileAlterationMonitor
Constructs a monitor with the specified interval and set of observers.
FileAlterationObserver - Class in org.apache.commons.io.monitor
FileAlterationObserver represents the state of files below a root directory, checking the file system and notifying listeners of create, change or delete events.
FileAlterationObserver(String) - Constructor for class org.apache.commons.io.monitor.FileAlterationObserver
Constructs an observer for the specified directory.
FileAlterationObserver(String, FileFilter) - Constructor for class org.apache.commons.io.monitor.FileAlterationObserver
Constructs an observer for the specified directory and file filter.
FileAlterationObserver(String, FileFilter, IOCase) - Constructor for class org.apache.commons.io.monitor.FileAlterationObserver
Construct an observer for the specified directory, file filter and file comparator.
FileAlterationObserver(File) - Constructor for class org.apache.commons.io.monitor.FileAlterationObserver
Constructs an observer for the specified directory.
FileAlterationObserver(File, FileFilter) - Constructor for class org.apache.commons.io.monitor.FileAlterationObserver
Constructs an observer for the specified directory and file filter.
FileAlterationObserver(File, FileFilter, IOCase) - Constructor for class org.apache.commons.io.monitor.FileAlterationObserver
Constructs an observer for the specified directory, file filter and file comparator.
FileCleaner - Class in org.apache.commons.io
Deprecated.
FileCleaner() - Constructor for class org.apache.commons.io.FileCleaner
Deprecated.
 
FileCleaningTracker - Class in org.apache.commons.io
Keeps track of files awaiting deletion, and deletes them when an associated marker object is reclaimed by the garbage collector.
FileCleaningTracker() - Constructor for class org.apache.commons.io.FileCleaningTracker
 
fileContentEquals(Path, Path) - Static method in class org.apache.commons.io.file.PathUtils
Compares the file contents of two Paths to determine if they are equal or not.
fileContentEquals(Path, Path, LinkOption[], OpenOption[]) - Static method in class org.apache.commons.io.file.PathUtils
Compares the file contents of two Paths to determine if they are equal or not.
FileDeleteStrategy - Class in org.apache.commons.io
Strategy for deleting files.
FileEntry - Class in org.apache.commons.io.monitor
The state of a file or directory, capturing the following File attributes at a point in time.
FileEntry(File) - Constructor for class org.apache.commons.io.monitor.FileEntry
Construct a new monitor for a specified File.
FileEntry(FileEntry, File) - Constructor for class org.apache.commons.io.monitor.FileEntry
Construct a new monitor for a specified File.
fileExists(String) - Method in class hep.lcio.util.LCIOConcat
 
FileExistsException - Exception in org.apache.commons.io
Indicates that a file already exists.
FileExistsException() - Constructor for exception org.apache.commons.io.FileExistsException
Default Constructor.
FileExistsException(String) - Constructor for exception org.apache.commons.io.FileExistsException
Construct an instance with the specified message.
FileExistsException(File) - Constructor for exception org.apache.commons.io.FileExistsException
Construct an instance with the specified file.
FileFileFilter - Class in org.apache.commons.io.filefilter
This filter accepts Files that are files (not directories).
fileFileFilter() - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that checks if the file is a file (and not a directory).
FileFilterUtils - Class in org.apache.commons.io.filefilter
Useful utilities for working with file filters.
FileFilterUtils() - Constructor for class org.apache.commons.io.filefilter.FileFilterUtils
FileFilterUtils is not normally instantiated.
FileList - Class in jhplot.utils
Get list of files in all directories (including subdirectories).
FileList() - Constructor for class jhplot.utils.FileList
 
fileNameOfPath(String) - Static method in class jhepsim.Util
 
fileNameOfPath(String) - Static method in class jhplot.utils.Util
 
fileNameOfPath(String) - Static method in class jminhep.utils.Util
 
FilenameUtils - Class in org.apache.commons.io
General file name and file path manipulation utilities.
FilenameUtils() - Constructor for class org.apache.commons.io.FilenameUtils
Instances should NOT be constructed in standard programming.
fileNotFound() - Method in interface org.apache.commons.io.input.TailerListener
This method is called if the tailed file is not found.
fileNotFound() - Method in class org.apache.commons.io.input.TailerListenerAdapter
This method is called if the tailed file is not found.
FilePrintable - Interface in jhplot.math.io
BSD License
FileRoot - Class in jhplot.io
Class to read ROOT files.
FileRoot(String) - Constructor for class jhplot.io.FileRoot
Main constructor to build root file reader.
FileRoot(URL) - Constructor for class jhplot.io.FileRoot
Open file from URL
fileRotated() - Method in interface org.apache.commons.io.input.TailerListener
Called if a file rotation is detected.
fileRotated() - Method in class org.apache.commons.io.input.TailerListenerAdapter
Called if a file rotation is detected.
fileSep - Static variable in interface jminhep.gui.Constants
 
FileSystem - Enum in org.apache.commons.io
Abstracts an OS' file system details, currently supporting the single use case of converting a file name String to a legal file name with FileSystem.toLegalFileName(String, char).
FileSystemUtils - Class in org.apache.commons.io
Deprecated.
As of 2.6 deprecated without replacement. Use equivalent methods in FileStore instead, e.g. Files.getFileStore(Paths.get("/home")).getUsableSpace() or iterate over FileSystems.getDefault().getFileStores()
FileSystemUtils() - Constructor for class org.apache.commons.io.FileSystemUtils
Deprecated.
Instances should NOT be constructed in standard programming.
FileUtil - Class in hep.lcio.util
Miscellaneous java file utilities.
FileUtil() - Constructor for class hep.lcio.util.FileUtil
 
FileUtils - Class in org.apache.commons.io
General file manipulation utilities.
FileUtils() - Constructor for class org.apache.commons.io.FileUtils
Instances should NOT be constructed in standard programming.
FileWriterWithEncoding - Class in org.apache.commons.io.output
Writer of files that allows the encoding to be set.
FileWriterWithEncoding(String, String) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
FileWriterWithEncoding(String, String, boolean) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
FileWriterWithEncoding(String, Charset) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
FileWriterWithEncoding(String, Charset, boolean) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
FileWriterWithEncoding(String, CharsetEncoder) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
FileWriterWithEncoding(String, CharsetEncoder, boolean) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
FileWriterWithEncoding(File, String) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
FileWriterWithEncoding(File, String, boolean) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
FileWriterWithEncoding(File, Charset) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
FileWriterWithEncoding(File, Charset, boolean) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
FileWriterWithEncoding(File, CharsetEncoder) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
FileWriterWithEncoding(File, CharsetEncoder, boolean) - Constructor for class org.apache.commons.io.output.FileWriterWithEncoding
Constructs a FileWriterWithEncoding with a file encoding.
fill(double) - Method in class cern.hep.aida.ref.Histogram1D
 
fill(double, double) - Method in class cern.hep.aida.ref.Histogram1D
 
fill(double, double) - Method in class cern.hep.aida.ref.Histogram2D
 
fill(double, double, double) - Method in class cern.hep.aida.ref.Histogram2D
 
fill(double, double, double) - Method in class cern.hep.aida.ref.Histogram3D
 
fill(double, double, double, double) - Method in class cern.hep.aida.ref.Histogram3D
 
fill(double) - Method in interface colt.hep.aida.IHistogram1D
Fill histogram with weight 1.
fill(double, double) - Method in interface colt.hep.aida.IHistogram1D
Fill histogram with specified weight.
fill(double, double) - Method in interface colt.hep.aida.IHistogram2D
Fill the histogram with weight 1.
fill(double, double, double) - Method in interface colt.hep.aida.IHistogram2D
Fill the histogram with specified weight.
fill(double, double, double) - Method in interface colt.hep.aida.IHistogram3D
Fill the histogram with weight 1; equivalent to fill(x,y,z,1)..
fill(double, double, double, double) - Method in interface colt.hep.aida.IHistogram3D
Fill the histogram with specified weight.
fill(P0D) - Method in class jhplot.H1D
Fill histogram from P0D array
fill(int, AbstractDistribution) - Method in class jhplot.H1D
Fill histogram with random numbers.
fill(P0I) - Method in class jhplot.H1D
Fill histogram from P0I array
fill(double) - Method in class jhplot.H1D
Fill histogram with a value
fill(PND) - Method in class jhplot.H1D
Fill histogram with values from a PND array.
fill(PND, PND) - Method in class jhplot.H1D
Fill histograms with values from PND array.
fill(double[]) - Method in class jhplot.H1D
Fill histogram with array of double values
fill(Cloud1D) - Method in class jhplot.H1D
Fill histogram with array of double values
fill(double[], double[]) - Method in class jhplot.H1D
Fill histogram with array of double values.
fill(int[]) - Method in class jhplot.H1D
Fill histogram with array of integer values
fill(double, double) - Method in class jhplot.H1D
Fill histogram a with weight
fill(float) - Method in class jhplot.H1DA
Adds a data point to the histogram.
fill(double, double) - Method in class jhplot.H2D
Fill H2D histogram assuming all weights are unity.
fill(double, double, double) - Method in class jhplot.H2D
Fill H2D histogram with weights
fill(double[], double[]) - Method in class jhplot.H2D
Fill H2D histogram from 2 arrays (X amd Y).
fill(Cloud2D) - Method in class jhplot.H2D
Fill H2D histogram from Cloud2D.
fill(P0D, P0D) - Method in class jhplot.H2D
Fill H2D histogram from 2 arrays.
fill(P0I, P0I) - Method in class jhplot.H2D
Fill H2D histogram from 2 arrays.
fill(double[], double[], double[]) - Method in class jhplot.H2D
Fill H2D histogram from arrays.
fill(double, double) - Method in class jhplot.HProf1D
Fill profile histogram with X and Y
fill(double, double, double) - Method in class jhplot.HProf1D
Fill profile histogram with X and Y
fill(double[], double[]) - Method in class jhplot.HProf1D
Fill histogram with array of double values.
fill(double[], double[], double[]) - Method in class jhplot.HProf1D
Fill histogram with array of double values.
fill(double, double, double) - Method in class jhplot.HProf2D
Fill histogram assuming all weights are unity.
fill(double, double, double, double) - Method in class jhplot.HProf2D
Fill histogram assuming all weights are unity.
fill(double[], double[], double[]) - Method in class jhplot.HProf2D
Fill histogram from 2 arrays.
fill(double[], double[], double[], double[]) - Method in class jhplot.HProf2D
Fill histogram from 2 arrays.
fill(int, int, double) - Static method in class jhplot.math.DoubleArray
Fills an m x n matrix of doubles with constant c.
fill(int, double) - Static method in class jhplot.math.DoubleArray
Provides an m element array filled with constant c.
fill(int, double, double) - Method in class jhplot.P0D
Fill with a sequence of numbers between min and max.
fill(double[]) - Method in class jhplot.P0D
Fill a P0D container from an array.
fill(int[]) - Method in class jhplot.P0D
Fill a P0D container from an array.
fill(int, double, double) - Method in class jhplot.P0I
Fill with a sequence of numbers between min and max.
fill(double[]) - Method in class jhplot.P0I
Fill a P0I container from an array.
fill(int[]) - Method in class jhplot.P0I
Fill a P0I container from an array.
fill(double[], double[]) - Method in class jhplot.P1D
Fill a P1D container from 2 arrays.
fill(int[], int[]) - Method in class jhplot.P1D
Fill a P1D container from 2 integer arrays.
fill(P0D, P0D) - Method in class jhplot.P1D
Fill a P1D container from 2 P0D arrays.
fill(Cloud2D) - Method in class jhplot.P1D
Fill a P1D container from a Cloud2D.
fill(double[], double[], double[]) - Method in class jhplot.P1D
Fill a P1D container from 3 arrays (one represents symmetrical errors on Y).
fill(P0D, P0D, P0D) - Method in class jhplot.P1D
Fill a P1D container from P0D arrays (one represents symmetrical errors on Y).
fill(double[], double[], double[], double[]) - Method in class jhplot.P1D
Fill a P1D container from 4 arrays (last represents asymmetrical upper and lower errors on Y).
fill(double[], double[], double[], double[], double[], double[], double[], double[], double[], double[]) - Method in class jhplot.P1D
Fill the values of a X-Y plot-points with full errors.
fill(double[], double[], double[]) - Method in class jhplot.P2D
Fill a P2D container from 3 arrays.
fill(char, int) - Static method in class jminhep.utils.StringUtil
Creates a string of length "length" composed of the character "c", or the null string if c <= 0.
fill() - Method in class jplot.LinePars
 
fill(boolean) - Method in class jplot.LinePars
 
fill(double[]) - Method in class org.apache.commons.math3.random.ValueServer
Fills the input array with values generated using getNext() repeatedly.
fill(int) - Method in class org.apache.commons.math3.random.ValueServer
Returns an array of length length with values generated using getNext() repeatedly.
fill(Shape) - Method in class org.jfree.chart.fx.FXGraphics2D
Fills the specified shape with the current paint.
fill(double) - Method in class org.jlab.groot.data.H1F
Increments the bin corresponding to that value by 1
fill(double, double) - Method in class org.jlab.groot.data.H1F
Increments the bin corresponding to that value by that weight
fill(DataVector) - Method in class org.jlab.groot.data.H1F
 
fill(DataVector, DataVector) - Method in class org.jlab.groot.data.H1F
 
fill(double, double) - Method in class org.jlab.groot.data.H2F
Adds 1.0 to the bin with that value
fill(double, double, double) - Method in class org.jlab.groot.data.H2F
 
fill(double[]) - Method in class org.jlab.groot.matrix.SparseVectorGrid
fill the grid element 0 with weight of 1.0
fill(double[], int) - Method in class org.jlab.groot.matrix.SparseVectorGrid
fill the grid with values from array for element = order with default weight of 1.0
fill(double[], int, double) - Method in class org.jlab.groot.matrix.SparseVectorGrid
increment the value of the particular bin, the bin is determined by axis.
fill(ITree) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
fillArc(int, int, int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Fills an arc contained within the rectangle (x, y, width, height), starting at startAngle and continuing through arcAngle degrees, using the current paint.
fillArea - Variable in class org.jfree.chart.renderer.xy.XYSplineRenderer.XYSplineState
The area to fill under the curve.
fillDataArrays(Vector, int, int) - Method in class jplot.DataFile
Reads the current file and returns the data arrays.
fillDomainGridBand(Graphics2D, XYPlot, ValueAxis, Rectangle2D, double, double) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Fills a band between two values on the axis.
fillDomainGridBand(Graphics2D, XYPlot, ValueAxis, Rectangle2D, double, double) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Fills a band between two values on the axis.
fillFromToWith(int, int, boolean) - Method in class cern.colt.list.AbstractBooleanList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, byte) - Method in class cern.colt.list.AbstractByteList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, char) - Method in class cern.colt.list.AbstractCharList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, double) - Method in class cern.colt.list.AbstractDoubleList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, float) - Method in class cern.colt.list.AbstractFloatList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, int) - Method in class cern.colt.list.AbstractIntList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, long) - Method in class cern.colt.list.AbstractLongList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, short) - Method in class cern.colt.list.AbstractShortList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, Object) - Method in class cern.colt.list.ObjectArrayList
Sets the specified range of elements in the specified array to the specified value.
fillIDataPointSet(IDataPointSet) - Method in class jhplot.P1D
Fill IDataPointSet.
fillInvBinSizeWeight(double) - Method in class jhplot.H1D
Fill histogram with a value, weighting it by inverse of bin size.
fillInvBinSizeWeight(double) - Method in class jhplot.HProf1D
Fill histogram with a value, weighting it by inverse of bin size.
fillOval(int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Fills an oval framed by the rectangle (x, y, width, height).
fillP0D(P0D, P0D) - Method in class jhplot.HProf1D
Fill histogram from two P0D arrays
fillPolygon(int[], int[], int) - Method in class org.jfree.chart.fx.FXGraphics2D
Fills the specified polygon using the current paint.
fillRandom(int, AbstractDistribution) - Method in class cern.colt.list.DoubleArrayList
Fill array with random numbers
fillRandom(int, AbstractDistribution) - Method in class cern.colt.list.IntArrayList
Fill array with random numbers
fillRandom(DataPoint, DataPoint, int, int) - Method in class jminhep.cluster.DataHolder
Fill an existing data holder with random numbers
fillRangeGridBand(Graphics2D, XYPlot, ValueAxis, Rectangle2D, double, double) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Fills a band between two values on the range axis.
fillRangeGridBand(Graphics2D, XYPlot, ValueAxis, Rectangle2D, double, double) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Fills a band between two values on the range axis.
fillRect(int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Fills the specified rectangle with the current paint.
fillRoundRect(int, int, int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Fills a rectangle with rounded corners using the current paint.
fillSurface - Variable in class jplot3dp.ModelView.ModelFunction
 
fillTable() - Method in class fitter.SEditor
 
Filter - Class in hep.physics.filter
An iterator that filters an input iterator to only accept items that are accepted by a given predicate.
Filter(Iterator, Predicate) - Constructor for class hep.physics.filter.Filter
 
filter(IOFileFilter, File...) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Applies an IOFileFilter to the provided File objects.
filter(IOFileFilter, Iterable<File>) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Applies an IOFileFilter to the provided File objects.
FilterCollectionWriter - Class in org.apache.commons.io.output
Abstract class for writing filtered character streams to a Collection of writers.
filterList(IOFileFilter, Iterable<File>) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Applies an IOFileFilter to the provided File objects.
filterList(IOFileFilter, File...) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Applies an IOFileFilter to the provided File objects.
filterSet(IOFileFilter, File...) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Applies an IOFileFilter to the provided File objects.
filterSet(IOFileFilter, Iterable<File>) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Applies an IOFileFilter to the provided File objects.
FilterType - Enum in org.apache.commons.math3.ode.events
Enumerate for filtering events.
FINAL_STATE - Static variable in interface hep.physics.particle.Particle
 
finalizeStep() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Finalize the step.
find(double) - Method in class jhplot.P0D
Returns the index of first occurrence of the specified element
find(int) - Method in class jhplot.P0I
Returns the index of first occurrence of the specified element
findBest(double[], Iterable<Neuron>, DistanceMeasure) - Static method in class org.apache.commons.math3.ml.neuralnet.MapUtils
Finds the neuron that best matches the given features.
findBestAndSecondBest(double[], Iterable<Neuron>, DistanceMeasure) - Static method in class org.apache.commons.math3.ml.neuralnet.MapUtils
Finds the two neurons that best match the given features.
findBin(double) - Method in class jhplot.H1D
Convert a coordinate on the axis to a bin number
findBin(double) - Method in class org.jlab.groot.data.DataVector
 
findBin(double, int) - Method in class org.jlab.groot.data.DataVector
 
findBin(double, double) - Method in class org.jlab.groot.data.H2F
Finds which bin has that value.
findBinX(double) - Method in class jhplot.H2D
Convert a coordinate X on the axis to a bin number
findBinY(double) - Method in class jhplot.H2D
Convert a coordinate Y on the axis to a bin number
findCumulativeRangeBounds(CategoryDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Calculates the range of values for a dataset where each item is the running total of the items for the current series.
findDataArea(Point2D) - Method in class org.jfree.chart.fx.ChartCanvas
Returns the data area (the area inside the axes) for the plot or subplot.
findDerivative(String, DJep) - Method in class org.lsmp.djep.djep.PartialDerivative
 
findDomainBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the lower and upper bounds (range) of the x-values in the specified dataset.
findDomainBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.ClusteredXYBarRenderer
Returns the x-value bounds for the specified dataset.
findDomainBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.VectorRenderer
Returns the lower and upper bounds (range) of the x-values in the specified dataset.
findDomainBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the lower and upper bounds (range) of the x-values in the specified dataset.
findDomainBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Returns the lower and upper bounds (range) of the x-values in the specified dataset.
findDomainBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Returns the range required by this renderer to display all the domain values in the specified dataset.
findDomainBounds(XYDataset) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the lower and upper bounds (range) of the x-values in the specified dataset.
findDomainBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Returns the lower and upper bounds (range) of the x-values in the specified dataset.
findDomainBounds(XYDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the range of values in the domain (x-values) of a dataset.
findDomainBounds(XYDataset, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the range of values in the domain (x-values) of a dataset.
findDomainBounds(XYDataset, List, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the bounds of the x-values in the specified dataset taking into account only the visible series and including any x-interval if requested.
findex(int, IndexFunction) - Static method in class jhplot.math.DoubleArray
Provides a sequence of values to which some function has been applied.
findGrayColors(double) - Method in class jplot.Contour
Compute gray colors
findHullVertices(Collection<Vector2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.hull.MonotoneChain
Find the convex hull vertices from the set of input points.
findIndex(double[], double) - Static method in class jminhep.utils.ArrayOps
#5 Find the index of a specific value in an array of integers.
findItemIndicesForX(XYDataset, int, double) - Static method in class org.jfree.data.general.DatasetUtilities
Finds the indices of the the items in the dataset that span the specified x-value.
findLargest(double[]) - Static method in class jminhep.utils.ArrayOps
#1 Find the index of the Lagest value
findLargest(double[], int) - Static method in class jminhep.utils.ArrayOps
#1 Find the index of the Lagest value
findLinePolygonIntersections(double[], double[], double, double, double, double) - Static method in class jplot.Geometry
Find the intersections between a polygon and a straight line.
findLineSegmentIntersection(double, double, double, double, double, double, double, double, double[]) - Static method in class jplot.Geometry
Compute the intersection between two line segments, or two lines of infinite length.
findLiveItems(XYDataset, int, double, double) - Static method in class org.jfree.chart.renderer.RendererUtilities
Finds a range of item indices that is guaranteed to contain all the x-values from x0 to x1 (inclusive).
findLiveItemsLowerBound(XYDataset, int, double, double) - Static method in class org.jfree.chart.renderer.RendererUtilities
Finds the lower index of the range of live items in the specified data series.
findLiveItemsUpperBound(XYDataset, int, double, double) - Static method in class org.jfree.chart.renderer.RendererUtilities
Finds the upper index of the range of live items in the specified data series.
findMatching(LCCollection, SimCalorimeterHit) - Static method in class hep.lcio.util.MergeUtil
Find a SimCalorimeterHit in coll with matching cellId0, cellId1.
findMax(double[]) - Static method in class jminhep.utils.ArrayOps
#1 Find the largest value in an array of integers.
findMax(String[]) - Static method in class jminhep.utils.ArrayOps
#2 Find the largest value in an array of Strings.
findMaximumDomainValue(XYDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the maximum domain value for the specified dataset.
findMaximumRangeValue(CategoryDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the maximum range value for the specified dataset.
findMaximumRangeValue(XYDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the maximum range value for the specified dataset.
findMaximumStackedRangeValue(CategoryDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the maximum value in the dataset range, assuming that values in each category are "stacked".
findMin(int[]) - Static method in class jminhep.utils.ArrayOps
#3 Find the smallest value in an array of integers.
findMin(String[]) - Static method in class jminhep.utils.ArrayOps
#4 Find the smallest value in an array of Strings.
findMinimumDomainValue(XYDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Finds the minimum domain (or X) value for the specified dataset.
findMinimumRangeValue(CategoryDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the minimum range value for the specified dataset.
findMinimumRangeValue(XYDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the minimum range value for the specified dataset.
findMinimumStackedRangeValue(CategoryDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the minimum value in the dataset range, assuming that values in each category are "stacked".
findPolygonExtent(double[], double[], double[], double[], double[], double[]) - Static method in class jplot.Geometry
Find the 3D extent of a polyline.
findPolygonExtent(int[], int[], int[], int[]) - Static method in class jplot.Geometry
Find the extent of a polygon.
findPolygonPosition(int[], int[], double, int[]) - Static method in class jplot.Geometry
Return the x,y position at distance "length" into the given polyline.
findRangeBounds(CategoryDataset) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(CategoryDataset, boolean) - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(CategoryDataset) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Returns the range of values from the specified dataset that the renderer will require to display all the data.
findRangeBounds(CategoryDataset) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(CategoryDataset) - Method in class org.jfree.chart.renderer.category.GroupedStackedBarRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(CategoryDataset) - Method in class org.jfree.chart.renderer.category.IntervalBarRenderer
Returns the range of values from the specified dataset.
findRangeBounds(CategoryDataset) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(CategoryDataset) - Method in class org.jfree.chart.renderer.category.StackedAreaRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(CategoryDataset) - Method in class org.jfree.chart.renderer.category.StackedBarRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(CategoryDataset) - Method in class org.jfree.chart.renderer.category.StackedBarRenderer3D
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(CategoryDataset) - Method in class org.jfree.chart.renderer.category.StatisticalBarRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(CategoryDataset) - Method in class org.jfree.chart.renderer.category.StatisticalLineAndShapeRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(CategoryDataset) - Method in class org.jfree.chart.renderer.category.WaterfallBarRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.DeviationRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer2
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.StackedXYBarRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.VectorRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the lower and upper bounds (range) of the y-values in the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Returns the range required by this renderer to display all the range values in the specified dataset.
findRangeBounds(XYDataset) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the lower and upper bounds (range) of the y-values in the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(XYDataset) - Method in class org.jfree.chart.renderer.xy.YIntervalRenderer
Returns the range of values the renderer requires to display all the items from the specified dataset.
findRangeBounds(CategoryDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the range of values in the range for the dataset.
findRangeBounds(CategoryDataset, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the range of values in the range for the dataset.
findRangeBounds(CategoryDataset, List, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Finds the bounds of the y-values in the specified dataset, including only those series that are listed in visibleSeriesKeys.
findRangeBounds(XYDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the range of values in the range for the dataset.
findRangeBounds(XYDataset, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the range of values in the range for the dataset.
findRangeBounds(XYDataset, List, Range, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Finds the bounds of the y-values in the specified dataset, including only those series that are listed in visibleSeriesKeys, and those items whose x-values fall within the specified range.
findRoot(double, double) - Method in class jhplot.math.num.root.BisectionRootFinder
Find a root of the target function that lies in the interval [ min, max].
findRoot(double, double) - Method in class jhplot.math.num.root.BrentRootFinder
Find a root of the target function that lies between the two initial approximations, x0 and x1.
findRoot(double, double) - Method in class jhplot.math.num.root.FalsePositionRootFinder
Find a root of the target function that lies in the interval [ min, max].
findRoot(double) - Method in class jhplot.math.num.root.NewtonRootFinder
Find a root of the target function that lies close to x.
findRoot(double, double) - Method in class jhplot.math.num.root.SecantRootFinder
Find a root of the target function that lies around the two initial approximations, x0 and x1.
findSlice(double[]) - Method in class jhplot.math.Slicing
 
findSmallest(double[]) - Static method in class jminhep.utils.ArrayOps
#1 Find the index of the Smallest value
findSmallest(double[], int) - Static method in class jminhep.utils.ArrayOps
#1 Find the index of the Smallest value
findSpectrumColors(double) - Method in class jplot.Contour
Compute spectrum colors
findStackedRangeBounds(CategoryDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the minimum and maximum values for the dataset's range (y-values), assuming that the series in one category are stacked.
findStackedRangeBounds(CategoryDataset, double) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the minimum and maximum values for the dataset's range (y-values), assuming that the series in one category are stacked.
findStackedRangeBounds(CategoryDataset, KeyToGroupMap) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the minimum and maximum values for the dataset's range (y-values), assuming that the series in one category are stacked.
findStackedRangeBounds(TableXYDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the minimum and maximum values for the dataset's range, assuming that the series are stacked.
findStackedRangeBounds(TableXYDataset, double) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the minimum and maximum values for the dataset's range, assuming that the series are stacked, using the specified base value.
findSubplot(PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Returns the subplot (if any) that contains the (x, y) point (specified in Java2D space).
findSubplot(PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Returns the subplot (if any) that contains the (x, y) point (specified in Java2D space).
findSubplot(PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Returns the subplot (if any) that contains the (x, y) point (specified in Java2D space).
findVal(String[], String) - Static method in class jminhep.utils.ArrayOps
#6 Find the index of a specific value in an array of Strings.
findValueRange() - Method in class org.jfree.data.time.TimeSeries
Returns the range of y-values in the time series.
findValueRange(Range, TimeZone) - Method in class org.jfree.data.time.TimeSeries
Returns the range of y-values in the time series that fall within the specified range of x-values.
findValueRange(Range, TimePeriodAnchor, TimeZone) - Method in class org.jfree.data.time.TimeSeries
Finds the range of y-values that fall within the specified range of x-values (where the x-values are interpreted as milliseconds since the epoch and converted to time periods using the specified timezone).
findYValue(XYDataset, int, double) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the interpolated value of y that corresponds to the specified x-value in the given series.
findZBounds(XYZDataset) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Return the range of z-values in the specified dataset.
findZBounds(XYZDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the range of values in the z-dimension for the dataset.
findZBounds(XYZDataset, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the range of values in the z-dimension for the dataset.
findZBounds(XYZDataset, List, Range, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Finds the bounds of the z-values in the specified dataset, including only those series that are listed in visibleSeriesKeys, and those items whose x-values fall within the specified range.
fine_structure_const - Static variable in class cern.clhep.PhysicalConstants
 
finished() - Method in class graph.LoadData
 
finished() - Method in class org.apache.commons.io.input.ObservableInputStream.Observer
Called to indicate that EOF has been seen on the underlying stream.
finishedloading() - Method in class graph.Graph2D
Decrement the loading Data counter by one.
FINITE - Static variable in class org.apache.commons.math3.dfp.Dfp
Indicator value for normal finite numbers.
FiniteDifferencesDifferentiator - Class in org.apache.commons.math3.analysis.differentiation
Univariate functions differentiator using finite differences.
FiniteDifferencesDifferentiator(int, double) - Constructor for class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Build a differentiator with number of points and step size when independent variable is unbounded.
FiniteDifferencesDifferentiator(int, double, double, double) - Constructor for class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Build a differentiator with number of points and step size when independent variable is bounded.
fireChartChanged() - Method in class org.jfree.chart.JFreeChart
Sends a default ChartChangeEvent to all registered listeners.
fireInitializationEvent(IterationEvent) - Method in class org.apache.commons.math3.util.IterationManager
Informs all registered listeners that the initial phase (prior to the main iteration loop) has been completed.
fireIterationPerformedEvent(IterationEvent) - Method in class org.apache.commons.math3.util.IterationManager
Informs all registered listeners that a new iteration (in the main iteration loop) has been performed.
fireIterationStartedEvent(IterationEvent) - Method in class org.apache.commons.math3.util.IterationManager
Informs all registered listeners that a new iteration (in the main iteration loop) has been started.
fireOverlayChanged() - Method in class org.jfree.chart.panel.AbstractOverlay
Sends a default ChartChangeEvent to all registered listeners.
fireSeriesChanged() - Method in class org.jfree.data.general.Series
General method for signalling to registered listeners that the series has been changed.
fireTerminationEvent(IterationEvent) - Method in class org.apache.commons.math3.util.IterationManager
Informs all registered listeners that the final phase (post-iterations) has been completed.
first - Variable in class org.freehep.math.minuit.Point
 
FIRST_HOUR_IN_DAY - Static variable in class org.jfree.data.time.Hour
Useful constant for the first hour in the day.
FIRST_MILLISECOND_IN_SECOND - Static variable in class org.jfree.data.time.Millisecond
A constant for the first millisecond in a second.
FIRST_MINUTE_IN_HOUR - Static variable in class org.jfree.data.time.Minute
Useful constant for the first minute in a day.
FIRST_MONDAY_AFTER_1900 - Static variable in class org.jfree.chart.axis.SegmentedTimeline
Deprecated.
As of 1.0.7. This field doesn't take into account changes to the default time zone.
FIRST_MONTH_IN_QUARTER - Static variable in class org.jfree.data.time.Quarter
The first month in each quarter.
FIRST_QUARTER - Static variable in class org.jfree.data.time.Quarter
Constant for quarter 1.
FIRST_SECOND_IN_MINUTE - Static variable in class org.jfree.data.time.Second
Useful constant for the first second in a minute.
FIRST_WEEK_IN_YEAR - Static variable in class org.jfree.data.time.Week
Constant for the first week in the year.
firstIncluded() - Method in enum org.apache.commons.math3.ode.sampling.StepNormalizerBounds
Returns a value indicating whether the first point should be passed to the underlying fixed step size step handler.
firstIntersection(Vector3D, Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Get the first sub-hyperplane crossed by a semi-infinite line.
firstMaxVal - Variable in class jhplot.stat.JointProbabilityState
 
firstMondayAfter1900() - Static method in class org.jfree.chart.axis.SegmentedTimeline
Returns the milliseconds for midnight of the first Monday after 1-Jan-1900, ignoring daylight savings.
FirstOrderConverter - Class in org.apache.commons.math3.ode
This class converts second order differential equations to first order ones.
FirstOrderConverter(SecondOrderDifferentialEquations) - Constructor for class org.apache.commons.math3.ode.FirstOrderConverter
Simple constructor.
FirstOrderDifferentialEquations - Interface in org.apache.commons.math3.ode
This interface represents a first order differential equations set.
FirstOrderFieldDifferentialEquations<T extends RealFieldElement<T>> - Interface in org.apache.commons.math3.ode
This interface represents a first order differential equations set.
FirstOrderFieldIntegrator<T extends RealFieldElement<T>> - Interface in org.apache.commons.math3.ode
This interface represents a first order integrator for differential equations.
FirstOrderIntegrator - Interface in org.apache.commons.math3.ode
This interface represents a first order integrator for differential equations.
firstProbMap - Variable in class jhplot.stat.JointProbabilityState
 
fit(H1D) - Method in class jhplot.HFitter
Fit histogram
fit(P1D) - Method in class jhplot.HFitter
Fit P1D
fit(PND) - Method in class jhplot.HFitter
Fit PND (all errors set to be zero).
fit(H2D) - Method in class jhplot.HFitter
Fit H2D histogram
fit(H1D, String, String) - Method in class jhplot.HPlot
Fit 1D histogram with the function F1D
fit(MixtureMultivariateNormalDistribution, int, double) - Method in class org.apache.commons.math3.distribution.fitting.MultivariateNormalMixtureExpectationMaximization
Fit a mixture model to the data supplied to the constructor.
fit(MixtureMultivariateNormalDistribution) - Method in class org.apache.commons.math3.distribution.fitting.MultivariateNormalMixtureExpectationMaximization
Fit a mixture model to the data supplied to the constructor.
fit(Collection<WeightedObservedPoint>) - Method in class org.apache.commons.math3.fitting.AbstractCurveFitter
Fits a curve.
fit(T, double[]) - Method in class org.apache.commons.math3.fitting.CurveFitter
Deprecated.
Fit a curve.
fit(int, T, double[]) - Method in class org.apache.commons.math3.fitting.CurveFitter
Deprecated.
Fit a curve.
fit(double[]) - Method in class org.apache.commons.math3.fitting.GaussianFitter
Deprecated.
Fits a Gaussian function to the observed points.
fit() - Method in class org.apache.commons.math3.fitting.GaussianFitter
Deprecated.
Fits a Gaussian function to the observed points.
fit(double[]) - Method in class org.apache.commons.math3.fitting.HarmonicFitter
Deprecated.
Fit an harmonic function to the observed points.
fit() - Method in class org.apache.commons.math3.fitting.HarmonicFitter
Deprecated.
Fit an harmonic function to the observed points.
fit(int, double[]) - Method in class org.apache.commons.math3.fitting.PolynomialFitter
Deprecated.
Get the coefficients of the polynomial fitting the weighted data points.
fit(double[]) - Method in class org.apache.commons.math3.fitting.PolynomialFitter
Deprecated.
Get the coefficients of the polynomial fitting the weighted data points.
fit(T, double[]) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated.
Fit a curve.
fit(int, T, double[]) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated.
Fit a curve.
fit(double[]) - Method in class org.apache.commons.math3.optimization.fitting.GaussianFitter
Deprecated.
Fits a Gaussian function to the observed points.
fit() - Method in class org.apache.commons.math3.optimization.fitting.GaussianFitter
Deprecated.
Fits a Gaussian function to the observed points.
fit(double[]) - Method in class org.apache.commons.math3.optimization.fitting.HarmonicFitter
Deprecated.
Fit an harmonic function to the observed points.
fit() - Method in class org.apache.commons.math3.optimization.fitting.HarmonicFitter
Deprecated.
Fit an harmonic function to the observed points.
fit() - Method in class org.apache.commons.math3.optimization.fitting.PolynomialFitter
Deprecated.
Since 3.1 (to be removed in 4.0). Please use PolynomialFitter.fit(double[]) instead.
fit(int, double[]) - Method in class org.apache.commons.math3.optimization.fitting.PolynomialFitter
Deprecated.
Get the coefficients of the polynomial fitting the weighted data points.
fit(double[]) - Method in class org.apache.commons.math3.optimization.fitting.PolynomialFitter
Deprecated.
Get the coefficients of the polynomial fitting the weighted data points.
fit(Func1D, IDataSet, String) - Static method in class org.jlab.groot.fitter.DataFitter
 
fitF() - Method in class jhplot.HPlot
Return FitFactory associated with the plot
Fitness - Interface in org.apache.commons.math3.genetics
Fitness of a chromosome.
fitness() - Method in interface org.apache.commons.math3.genetics.Fitness
Compute the fitness.
FitPanel - Class in org.jlab.groot.ui
 
FitPanel(EmbeddedCanvas, int) - Constructor for class org.jlab.groot.ui.FitPanel
 
FITPRINTOUT - Static variable in class org.jlab.groot.fitter.DataFitter
 
fitSlicesX() - Method in class org.jlab.groot.fitter.ParallelSliceFitter
 
fitSlicesY() - Method in class org.jlab.groot.fitter.ParallelSliceFitter
 
fitter - package fitter
 
Fitter - Class in fitter
 
Fitter(HPlot, String) - Constructor for class fitter.Fitter
 
FitterFunction - Class in org.jlab.groot.fitter
 
FitterFunction(Func1D, IDataSet) - Constructor for class org.jlab.groot.fitter.FitterFunction
 
FitterFunction(Func1D, IDataSet, String) - Constructor for class org.jlab.groot.fitter.FitterFunction
 
fix(int) - Method in class org.freehep.math.minuit.MnApplication
 
fix(String) - Method in class org.freehep.math.minuit.MnApplication
 
fix(int) - Method in class org.freehep.math.minuit.MnUserParameters
Fixes the specified parameter (so that the minimizer will no longer vary it)
fix(String) - Method in class org.freehep.math.minuit.MnUserParameters
Fixes the specified parameter (so that the minimizer will no longer vary it)
fix(int) - Method in class org.freehep.math.minuit.MnUserParameterState
 
fix(String) - Method in class org.freehep.math.minuit.MnUserParameterState
 
fix1stArgument(BivariateFunction, double) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Creates a unary function by fixing the first argument of a binary function.
fix2ndArgument(BivariateFunction, double) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Creates a unary function by fixing the second argument of a binary function.
fixBinWidths(double) - Method in class org.jlab.groot.data.H1F
Changes the bin widths to vary with a set minimum slope to be allowed as its own bin.
FIXED - Static variable in class org.jfree.chart.block.LengthConstraintType
FIXED.
FixedAxis - Class in cern.hep.aida.ref
Fixed-width axis; A reference implementation of hep.aida.IAxis.
FixedAxis(int, double, double) - Constructor for class cern.hep.aida.ref.FixedAxis
Create an Axis
FixedElapsedTime - Class in org.apache.commons.math3.genetics
Stops after a fixed amount of time has elapsed.
FixedElapsedTime(long) - Constructor for class org.apache.commons.math3.genetics.FixedElapsedTime
Create a new FixedElapsedTime instance.
FixedElapsedTime(long, TimeUnit) - Constructor for class org.apache.commons.math3.genetics.FixedElapsedTime
Create a new FixedElapsedTime instance.
FixedGenerationCount - Class in org.apache.commons.math3.genetics
Stops after a fixed number of generations.
FixedGenerationCount(int) - Constructor for class org.apache.commons.math3.genetics.FixedGenerationCount
Create a new FixedGenerationCount instance.
FixedMillisecond - Class in org.jfree.data.time
Wrapper for a java.util.Date object that allows it to be used as a RegularTimePeriod.
FixedMillisecond() - Constructor for class org.jfree.data.time.FixedMillisecond
Constructs a millisecond based on the current system time.
FixedMillisecond(long) - Constructor for class org.jfree.data.time.FixedMillisecond
Constructs a millisecond.
FixedMillisecond(Date) - Constructor for class org.jfree.data.time.FixedMillisecond
Constructs a millisecond.
FixedStepHandler - Interface in org.apache.commons.math3.ode.sampling
This interface represents a handler that should be called after each successful fixed step.
fixedWidthDoubletoString(double, int, int) - Static method in class Jama.examples.MagicSquareExample
Format double with Fw.d.
fixedWidthIntegertoString(int, int) - Static method in class Jama.examples.MagicSquareExample
Format integer with Iw.
fixNode(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTree.VanishingCutHandler
Fix a node with both vanished cut and children.
FixNumberOfJetsFinder - Class in hep.physics.jet
 
FixNumberOfJetsFinder() - Constructor for class hep.physics.jet.FixNumberOfJetsFinder
Default constructor, sets up JadeEJetFinder.
FixNumberOfJetsFinder(int) - Constructor for class hep.physics.jet.FixNumberOfJetsFinder
Constructor specifying number of requested jets, sets up JadeEJetFinder as default.
FixNumberOfJetsFinder(AbstractJetFinder) - Constructor for class hep.physics.jet.FixNumberOfJetsFinder
Constructor to specify a specfic JetFinder to use.
FixNumberOfJetsFinder(int, AbstractJetFinder) - Constructor for class hep.physics.jet.FixNumberOfJetsFinder
Constructor to specify rquested number of jets and a specfic JetFinder to use.
FixNumberOfJetsFinder.NumJetsNotFoundException - Exception in hep.physics.jet
 
FLAG_DIV_ZERO - Static variable in class org.apache.commons.math3.dfp.DfpField
IEEE 854-1987 flag for division by zero.
FLAG_INEXACT - Static variable in class org.apache.commons.math3.dfp.DfpField
IEEE 854-1987 flag for inexact result.
FLAG_INVALID - Static variable in class org.apache.commons.math3.dfp.DfpField
IEEE 854-1987 flag for invalid operation.
FLAG_OVERFLOW - Static variable in class org.apache.commons.math3.dfp.DfpField
IEEE 854-1987 flag for overflow.
FLAG_UNDERFLOW - Static variable in class org.apache.commons.math3.dfp.DfpField
IEEE 854-1987 flag for underflow.
flatten(Object[]) - Static method in class org.apache.commons.math3.exception.util.ArgUtils
Transform a multidimensional array into a one-dimensional list.
FLOAT_MIN_NORMAL - Static variable in class net.jafama.NumbersUtils
Float.MIN_NORMAL since Java 6.
FloatArrayList - Class in cern.colt.list
Resizable list holding float elements; implemented with arrays.
FloatArrayList() - Constructor for class cern.colt.list.FloatArrayList
Constructs an empty list.
FloatArrayList(float[]) - Constructor for class cern.colt.list.FloatArrayList
Constructs a list containing the specified elements.
FloatArrayList(int) - Constructor for class cern.colt.list.FloatArrayList
Constructs an empty list with the specified initial capacity.
FloatComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
FLOATING_POINT_LITERAL - Static variable in interface org.nfunk.jep.ParserConstants
 
FloatListAdapter - Class in cern.colt.list.adapter
Adapter that permits an AbstractFloatList to be viewed and treated as a JDK 1.2 AbstractList.
FloatListAdapter(AbstractFloatList) - Constructor for class cern.colt.list.adapter.FloatListAdapter
Constructs a list backed by the specified content list.
FloatProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
floatValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a float.
floatValue() - Method in class org.apache.commons.math3.fraction.Fraction
Gets the fraction as a float.
floatValue() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation performs casting to a float.
floatValue() - Method in class org.lsmp.djep.groupJep.groups.Quaternions.Quaternion
 
floatValue() - Method in class org.lsmp.djep.groupJep.values.Permutation
 
floatValue() - Method in class org.lsmp.djep.groupJep.values.Polynomial
value of constant coeff.
floatValue() - Method in class org.lsmp.djep.groupJep.values.Rational
 
floatValue() - Method in class org.lsmp.djep.vectorJep.values.Scaler
value of constant coeff.
floatValue() - Method in class org.nfunk.jep.type.Complex
Returns real part.
flog10(double) - Static method in class jplot.Axis
 
floor(double) - Static method in class cern.jet.math.Arithmetic
Returns the largest long <= value.
floor - Static variable in class cern.jet.math.Functions
Function that returns Math.floor(a).
floor(double[][]) - Static method in class jhplot.math.IntegerArray
 
floor(double[]) - Static method in class jhplot.math.IntegerArray
 
floor(double, int) - Method in class jplot3d.SurfaceModelCanvas
 
FLOOR - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
floor(float) - Static method in class net.jafama.FastMath
 
floor(double) - Static method in class net.jafama.FastMath
 
floor(float) - Static method in class net.jafama.StrictFastMath
 
floor(double) - Static method in class net.jafama.StrictFastMath
 
floor() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the largest whole number smaller than instance.
floor() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Get the largest whole number smaller than instance.
Floor - Class in org.apache.commons.math3.analysis.function
floor function.
Floor() - Constructor for class org.apache.commons.math3.analysis.function.Floor
 
floor() - Method in class org.apache.commons.math3.dfp.Dfp
Round to an integer using the round floor mode.
floor() - Method in interface org.apache.commons.math3.RealFieldElement
Get the largest whole number smaller than instance.
floor() - Method in class org.apache.commons.math3.util.Decimal64
Get the largest whole number smaller than instance.
floor(double) - Static method in class org.apache.commons.math3.util.FastMath
Get the largest whole number smaller than x.
Floor - Class in org.nfunk.jep.function
A PostfixMathCommandI which find the smallest integer below the number ceil(pi) give 3 ceil(-i) give -4
Floor() - Constructor for class org.nfunk.jep.function.Floor
 
floor(Object) - Method in class org.nfunk.jep.function.Floor
 
floorDiv(int, int) - Static method in class org.apache.commons.math3.util.FastMath
Finds q such that a = q b + r with 0 <= r < b if b > 0 and b < r <= 0 if b < 0.
floorDiv(long, long) - Static method in class org.apache.commons.math3.util.FastMath
Finds q such that a = q b + r with 0 <= r < b if b > 0 and b < r <= 0 if b < 0.
floorMod(int, int) - Static method in class org.apache.commons.math3.util.FastMath
Finds r such that a = q b + r with 0 <= r < b if b > 0 and b < r <= 0 if b < 0.
floorMod(long, long) - Static method in class org.apache.commons.math3.util.FastMath
Finds r such that a = q b + r with 0 <= r < b if b > 0 and b < r <= 0 if b < 0.
floorPowerOfTwo(int) - Static method in class net.jafama.NumbersUtils
 
floorPowerOfTwo(long) - Static method in class net.jafama.NumbersUtils
 
FlowArrangement - Class in org.jfree.chart.block
Arranges blocks in a flow layout.
FlowArrangement() - Constructor for class org.jfree.chart.block.FlowArrangement
Creates a new instance.
FlowArrangement(HorizontalAlignment, VerticalAlignment, double, double) - Constructor for class org.jfree.chart.block.FlowArrangement
Creates a new instance.
flush() - Method in class cern.colt.buffer.DoubleBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.DoubleBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.DoubleBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.IntBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.IntBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.IntBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.ObjectBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in interface hep.lcio.io.LCWriter
Flushes the output file/stream.
flush() - Method in class jhplot.math.io.LEDataOutputStream
 
flush() - Method in class org.apache.commons.io.output.AppendableWriter
Flushes the stream.
flush() - Method in class org.apache.commons.io.output.BrokenOutputStream
Throws the configured exception.
flush() - Method in class org.apache.commons.io.output.BrokenWriter
Throws the configured exception.
flush() - Method in class org.apache.commons.io.output.ClosedOutputStream
Throws an IOException to indicate that the stream is closed.
flush() - Method in class org.apache.commons.io.output.ClosedWriter
Throws an IOException to indicate that the stream is closed.
flush() - Method in class org.apache.commons.io.output.DemuxOutputStream
Flushes stream associated with current thread.
flush() - Method in class org.apache.commons.io.output.FileWriterWithEncoding
Flush the stream.
flush() - Method in class org.apache.commons.io.output.FilterCollectionWriter
Flushes the stream.
flush() - Method in class org.apache.commons.io.output.LockableFileWriter
Flush the stream.
flush() - Method in class org.apache.commons.io.output.NullWriter
 
flush() - Method in class org.apache.commons.io.output.ProxyCollectionWriter
Invokes the delegate's flush() method.
flush() - Method in class org.apache.commons.io.output.ProxyOutputStream
Invokes the delegate's flush() method.
flush() - Method in class org.apache.commons.io.output.ProxyWriter
Invokes the delegate's flush() method.
flush() - Method in class org.apache.commons.io.output.StringBuilderWriter
Flushing this writer has no effect.
flush() - Method in class org.apache.commons.io.output.TeeOutputStream
Flushes both streams.
flush() - Method in class org.apache.commons.io.output.ThresholdingOutputStream
Flushes this output stream and forces any buffered output bytes to be written out.
flush() - Method in class org.apache.commons.io.output.WriterOutputStream
Flush the stream.
flush() - Method in class org.apache.commons.io.output.XmlStreamWriter
Flushes the underlying writer.
FND - Class in jhplot
Create a function in multiple dimensions.
FND(String, String, String) - Constructor for class jhplot.FND
Create a function in any dimension evaluation.
FND(String, String) - Constructor for class jhplot.FND
Build a function, setting its title to the definition.
FND(FProxy) - Constructor for class jhplot.FND
Initialize function from proxy.
FND_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
FNon - Class in jhplot
Non-parametric function implementation.
FNon(String, int, int) - Constructor for class jhplot.FNon
Initialization.
FNon(String[], String[]) - Constructor for class jhplot.FNon
Initialization where you can redefine the names of the parameters.
focusGained(FocusEvent) - Method in class org.jfree.chart.editor.DefaultPolarPlotEditor
Does nothing.
focusLost(FocusEvent) - Method in class org.jfree.chart.editor.DefaultLogAxisEditor
 
focusLost(FocusEvent) - Method in class org.jfree.chart.editor.DefaultPolarPlotEditor
Revalidates minimum/maximum range.
FOG - Static variable in class jplot3d.ColorModel
 
fogEnabled - Variable in class jplot3dp.ModelView
 
fogEnd - Variable in class jplot3dp.ModelView
 
fogStart - Variable in class jplot3dp.ModelView
 
font_face - Static variable in class jhepsim.SetEnv
 
font_family - Static variable in class jhepsim.SetEnv
 
font_name - Static variable in class jhepsim.SetEnv
 
font_size - Static variable in class jhepsim.SetEnv
 
font_style - Static variable in class jhepsim.SetEnv
 
FontBold - Static variable in class jminhep.gui.SetEnv
 
fontChanged() - Method in class jplot.GraphSettings
Returns a flag to indicate that some of the graph-fonts have changed.
FontChooser - Class in jhepsim
 
FontChooser - Class in jminhep.gui
Font selector
FontChooser.NwList - Class in jhepsim
Private inner class for a list which displays a list of options in addition to a label indicating the currently selected item.
FontChooser.NwList - Class in jminhep.gui
Private inner class for a list which displays a list of options in addition to a label indicating the currently selected item.
fontNames - Static variable in class jhplot.utils.GHFontChooser
 
fontNames - Static variable in class jplot.JPlot
 
FontPlain - Static variable in class jminhep.gui.SetEnv
 
FontProperties - Class in org.jlab.groot.base
 
FontProperties() - Constructor for class org.jlab.groot.base.FontProperties
 
fontSizes - Static variable in class jhplot.utils.GHFontChooser
 
FORCE - Static variable in class org.apache.commons.io.FileDeleteStrategy
The singleton instance for forced file deletion, which always deletes, even if the file represents a non-empty directory.
force_end_labels - Variable in class graph.Axis
Rescale the axis so that labels fall at the end of the Axis.
forceDelete(File) - Static method in class org.apache.commons.io.FileUtils
Deletes a file.
forceDeleteOnExit(File) - Static method in class org.apache.commons.io.FileUtils
Schedules a file to be deleted when JVM exits.
forceMkdir(File) - Static method in class org.apache.commons.io.FileUtils
Makes a directory, including any necessary but nonexistent parent directories.
forceMkdirParent(File) - Static method in class org.apache.commons.io.FileUtils
Makes any necessary but nonexistent parent directories for a given File.
forceSide(int, UnivariateFunction, BracketedUnivariateSolver<UnivariateFunction>, double, double, double, AllowedSolution) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Force a root found by a non-bracketing solver to lie on a specified side, as if the solver were a bracketing one.
forEach(BooleanProcedure) - Method in class cern.colt.list.AbstractBooleanList
Applies a procedure to each element of the receiver, if any.
forEach(ByteProcedure) - Method in class cern.colt.list.AbstractByteList
Applies a procedure to each element of the receiver, if any.
forEach(CharProcedure) - Method in class cern.colt.list.AbstractCharList
Applies a procedure to each element of the receiver, if any.
forEach(DoubleProcedure) - Method in class cern.colt.list.AbstractDoubleList
Applies a procedure to each element of the receiver, if any.
forEach(FloatProcedure) - Method in class cern.colt.list.AbstractFloatList
Applies a procedure to each element of the receiver, if any.
forEach(IntProcedure) - Method in class cern.colt.list.AbstractIntList
Applies a procedure to each element of the receiver, if any.
forEach(LongProcedure) - Method in class cern.colt.list.AbstractLongList
Applies a procedure to each element of the receiver, if any.
forEach(ShortProcedure) - Method in class cern.colt.list.AbstractShortList
Applies a procedure to each element of the receiver, if any.
forEach(BooleanProcedure) - Method in class cern.colt.list.BooleanArrayList
Applies a procedure to each element of the receiver, if any.
forEach(ByteProcedure) - Method in class cern.colt.list.ByteArrayList
Applies a procedure to each element of the receiver, if any.
forEach(CharProcedure) - Method in class cern.colt.list.CharArrayList
Applies a procedure to each element of the receiver, if any.
forEach(DoubleProcedure) - Method in class cern.colt.list.DoubleArrayList
Applies a procedure to each element of the receiver, if any.
forEach(FloatProcedure) - Method in class cern.colt.list.FloatArrayList
Applies a procedure to each element of the receiver, if any.
forEach(IntProcedure) - Method in class cern.colt.list.IntArrayList
Applies a procedure to each element of the receiver, if any.
forEach(LongProcedure) - Method in class cern.colt.list.LongArrayList
Applies a procedure to each element of the receiver, if any.
forEach(ObjectProcedure) - Method in class cern.colt.list.ObjectArrayList
Applies a procedure to each element of the receiver, if any.
forEach(ShortProcedure) - Method in class cern.colt.list.ShortArrayList
Applies a procedure to each element of the receiver, if any.
forEach(DoubleProcedure) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Applies a procedure to each element of the receiver, if any.
forEachCoordinateInState(boolean, IntIntProcedure) - Method in class cern.colt.bitvector.BitMatrix
Applies a procedure to each coordinate that holds a bit in the given state.
forEachIndexFromToInState(int, int, boolean, IntProcedure) - Method in class cern.colt.bitvector.BitVector
Applies a procedure to each bit index within the specified range that holds a bit in the given state.
forEachKey(DoubleProcedure) - Method in class cern.colt.map.AbstractDoubleIntMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.AbstractIntDoubleMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.AbstractIntIntMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.AbstractIntObjectMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.AbstractLongObjectMap
Applies a procedure to each key of the receiver, if any.
forEachKey(DoubleProcedure) - Method in class cern.colt.map.OpenDoubleIntHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.OpenIntDoubleHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.OpenIntIntHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.OpenIntObjectHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.OpenLongObjectHashMap
Applies a procedure to each key of the receiver, if any.
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix2D
Assigns the result of a function to each non-zero cell; x[row,col] = function(x[row,col]).
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
 
forEachPair(DoubleIntProcedure) - Method in class cern.colt.map.AbstractDoubleIntMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntDoubleProcedure) - Method in class cern.colt.map.AbstractIntDoubleMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntIntProcedure) - Method in class cern.colt.map.AbstractIntIntMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntObjectProcedure) - Method in class cern.colt.map.AbstractIntObjectMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongObjectProcedure) - Method in class cern.colt.map.AbstractLongObjectMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(DoubleIntProcedure) - Method in class cern.colt.map.OpenDoubleIntHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntDoubleProcedure) - Method in class cern.colt.map.OpenIntDoubleHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntIntProcedure) - Method in class cern.colt.map.OpenIntIntHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntObjectProcedure) - Method in class cern.colt.map.OpenIntObjectHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongObjectProcedure) - Method in class cern.colt.map.OpenLongObjectHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
form(double) - Method in interface cern.colt.matrix.impl.Former
Formats a double into a string (like sprintf in C).
format(DoubleMatrix2D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string representations of all cells; no alignment considered.
Format - Class in corejava
A class for formatting numbers that follows printf conventions.
Format(String) - Constructor for class corejava.Format
Formats the number following printf conventions.
format(double) - Method in class corejava.Format
Formats a double into a string (like sprintf in C)
format(int) - Method in class corejava.Format
Formats an integer into a string (like sprintf in C)
format(long) - Method in class corejava.Format
Formats a long integer into a string (like sprintf in C)
format(char) - Method in class corejava.Format
Formats a character into a string (like sprintf in C)
format(String) - Method in class corejava.Format
Formats a string into a larger string (like sprintf in C)
format(Complex) - Method in class org.apache.commons.math3.complex.ComplexFormat
format(Double) - Method in class org.apache.commons.math3.complex.ComplexFormat
format(Complex, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.complex.ComplexFormat
Formats a Complex object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.complex.ComplexFormat
Formats a object to produce a string.
format(double, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.AbstractFormat
Formats a double value as a fraction and appends the result to a StringBuffer.
format(long, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.AbstractFormat
Formats a long value as a fraction and appends the result to a StringBuffer.
format(BigFraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
Formats a BigFraction object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
Formats an object and appends the result to a StringBuffer.
format(Fraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.FractionFormat
Formats a Fraction object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.FractionFormat
Formats an object and appends the result to a StringBuffer.
format(BigFraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.ProperBigFractionFormat
Formats a BigFraction object to produce a string.
format(Fraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.ProperFractionFormat
Formats a Fraction object to produce a string.
format(Vector<Euclidean1D>, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Formats a Vector object to produce a string.
format(Vector<Euclidean3D>, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Formats a Vector3D object to produce a string.
format(Vector<Euclidean2D>, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Formats a Vector object to produce a string.
format(Vector<S>) - Method in class org.apache.commons.math3.geometry.VectorFormat
Formats a Vector object to produce a string.
format(Vector<S>, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.geometry.VectorFormat
Formats a Vector object to produce a string.
format(RealMatrix) - Method in class org.apache.commons.math3.linear.RealMatrixFormat
format(RealMatrix, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Formats a RealMatrix object to produce a string.
format(RealVector) - Method in class org.apache.commons.math3.linear.RealVectorFormat
format(RealVector, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.linear.RealVectorFormat
Formats a RealVector object to produce a string.
format(double, StringBuffer, FieldPosition) - Method in class org.jfree.chart.axis.CompassFormat
Formats a number into the specified string buffer.
format(long, StringBuffer, FieldPosition) - Method in class org.jfree.chart.axis.CompassFormat
Formats a number into the specified string buffer.
format(Date, StringBuffer, FieldPosition) - Method in class org.jfree.chart.axis.MonthDateFormat
Formats the given date.
format(Date, StringBuffer, FieldPosition) - Method in class org.jfree.chart.axis.QuarterDateFormat
Formats the given date.
format(double, StringBuffer, FieldPosition) - Method in class org.jfree.chart.util.HexNumberFormat
Formats the specified number as a hexadecimal string.
format(long, StringBuffer, FieldPosition) - Method in class org.jfree.chart.util.HexNumberFormat
Formats the specified number as a hexadecimal string.
format(double, StringBuffer, FieldPosition) - Method in class org.jfree.chart.util.HMSNumberFormat
Formats the specified number as a string of the form HH:MM:SS.
format(long, StringBuffer, FieldPosition) - Method in class org.jfree.chart.util.HMSNumberFormat
Formats the specified number as a string of the form HH:MM:SS.
format(double, StringBuffer, FieldPosition) - Method in class org.jfree.chart.util.LogFormat
Returns a formatted representation of the specified number.
format(long, StringBuffer, FieldPosition) - Method in class org.jfree.chart.util.LogFormat
Formats the specified number as a hexadecimal string.
format(Date, StringBuffer, FieldPosition) - Method in class org.jfree.chart.util.RelativeDateFormat
Formats the given date as the amount of elapsed time (relative to the base date specified in the constructor).
format(double, StringBuffer, FieldPosition) - Method in class org.lsmp.djep.xjep.BaseFormat
Format a double value in specific base.
format(long, StringBuffer, FieldPosition) - Method in class org.lsmp.djep.xjep.BaseFormat
Format a double value in specific base.
formatBigFraction(BigFraction) - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
This static method calls formatBigFraction() on a default instance of BigFractionFormat.
formatDouble(double, NumberFormat, StringBuffer, FieldPosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
Formats a double value to produce a string.
formatFraction(Fraction) - Static method in class org.apache.commons.math3.fraction.FractionFormat
This static method calls formatFraction() on a default instance of FractionFormat.
formatNum(double, int) - Static method in class jplot.Utils
 
formatNum(double, int) - Static method in class jplot3d.NumUtil
 
formatNumber(double, int) - Static method in class jplot.GraphGeneral
formats a double precision number such that it is correctly rounded for output.
Formatter - Class in cern.colt.matrix.doublealgo
Flexible, well human readable matrix print formatting; By default decimal point aligned.
Formatter() - Constructor for class cern.colt.matrix.doublealgo.Formatter
Constructs and returns a matrix formatter with format "%G".
Formatter(String) - Constructor for class cern.colt.matrix.doublealgo.Formatter
Constructs and returns a matrix formatter.
Formatter - Class in cern.colt.matrix.objectalgo
Flexible, well human readable matrix print formatting.
Formatter() - Constructor for class cern.colt.matrix.objectalgo.Formatter
Constructs and returns a matrix formatter with alignment LEFT.
Formatter(String) - Constructor for class cern.colt.matrix.objectalgo.Formatter
Constructs and returns a matrix formatter.
formatValue(Object, StringBuffer) - Method in class org.lsmp.djep.xjep.PrintVisitor
Appends a formatted versions of val to the string buffer.
formatValue(Object) - Method in class org.lsmp.djep.xjep.PrintVisitor
Returns a formated version of the value.
Former - Interface in cern.colt.matrix.impl
Formats a double into a string (like sprintf in C).
FormerFactory - Class in cern.colt.matrix.impl
Factory producing implementations of Former via method create(); Implementations of can use existing libraries such as corejava.PrintfFormat or corejava.Format or other.
FormerFactory() - Constructor for class cern.colt.matrix.impl.FormerFactory
 
FormLin(double) - Static method in class jplot.Utils
Format numbers for Lin format
FormLin(float) - Static method in class jplot.Utils
Format numbers for Log format
FormLog(float) - Static method in class jplot.Utils
Format numbers for Log format
FormLog(double) - Static method in class jplot.Utils
Format numbers for Log format
FormNum(double, double, double) - Static method in class jplot.Utils
Format numbers.
formObjectArray(double[][]) - Static method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Creates an object array from an array of doubles.
formObjectArray(double[]) - Static method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Creates an object array from an array of doubles.
FormPow(String, boolean) - Static method in class jplot.Utils
Format numbers as 10^##
forName(String) - Static method in enum org.apache.commons.io.IOCase
Factory method to create an IOCase from a name.
FORWARD - Static variable in class org.jfree.chart.plot.DatasetRenderingOrder
Render datasets in the order 0, 1, 2, ..., N-1, where N is the number of datasets.
FORWARD - Static variable in class org.jfree.chart.plot.SeriesRenderingOrder
Render series in the order 0, 1, 2, ..., N-1, where N is the number of series.
FOUR_FIFTHS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "4/5".
FOUR_FIFTHS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "4/5".
FPR - Class in jhplot
Class to build parametric functions using two independent variables, u and v.
FPR(String, String, int, int) - Constructor for class jhplot.FPR
Create a parametric function.
FPR(FProxy) - Constructor for class jhplot.FPR
Initialize function from proxy.
FPR(String, int, int) - Constructor for class jhplot.FPR
Create a parametric function.
FPR(String) - Constructor for class jhplot.FPR
Create a parametric function.
FPR_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
FProbability(double, int, int) - Static method in class jhplot.stat.Statistics
Computes probability of F-ratio.
FProxy - Class in jhplot
A proxy for all functions.
FProxy(int, String, String, IFunction, double[], int, boolean) - Constructor for class jhplot.FProxy
Create a proxy for all functions of DMelt.
FRAC - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
Fractal - Class in org.nfunk.jepexamples
 
Fractal() - Constructor for class org.nfunk.jepexamples.Fractal
 
FractalCanvas - Class in org.nfunk.jepexamples
This class performs the drawing of the fractal.
FractalCanvas(String, TextField) - Constructor for class org.nfunk.jepexamples.FractalCanvas
Constructor.
Fraction - Class in org.apache.commons.math3.fraction
Representation of a rational number.
Fraction(double) - Constructor for class org.apache.commons.math3.fraction.Fraction
Create a fraction given the double value.
Fraction(double, double, int) - Constructor for class org.apache.commons.math3.fraction.Fraction
Create a fraction given the double value and maximum error allowed.
Fraction(double, int) - Constructor for class org.apache.commons.math3.fraction.Fraction
Create a fraction given the double value and maximum denominator.
Fraction(int) - Constructor for class org.apache.commons.math3.fraction.Fraction
Create a fraction from an int.
Fraction(int, int) - Constructor for class org.apache.commons.math3.fraction.Fraction
Create a fraction given the numerator and denominator.
FractionConversionException - Exception in org.apache.commons.math3.fraction
Error thrown when a double value cannot be converted to a fraction in the allowed number of iterations.
FractionConversionException(double, int) - Constructor for exception org.apache.commons.math3.fraction.FractionConversionException
Constructs an exception with specified formatted detail message.
FractionConversionException(double, long, long) - Constructor for exception org.apache.commons.math3.fraction.FractionConversionException
Constructs an exception with specified formatted detail message.
FractionField - Class in org.apache.commons.math3.fraction
Representation of the fractional numbers field.
FractionFormat - Class in org.apache.commons.math3.fraction
Formats a Fraction number in proper format or improper format.
FractionFormat() - Constructor for class org.apache.commons.math3.fraction.FractionFormat
Create an improper formatting instance with the default number format for the numerator and denominator.
FractionFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.FractionFormat
Create an improper formatting instance with a custom number format for both the numerator and denominator.
FractionFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.FractionFormat
Create an improper formatting instance with a custom number format for the numerator and a custom number format for the denominator.
fractionMatrixToRealMatrix(FieldMatrix<Fraction>) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Convert a FieldMatrix/Fraction matrix to a RealMatrix.
frame - Variable in class graph.Graph2D
If set true a frame will be drawn around the data window.
frame - Variable in class jplot.JPlot
 
framecolor - Variable in class graph.Graph2D
The color of the frame to be drawn
FRandomVariable - Class in jhplot.math.num.random
A random variable generator for the F distribution.
FRandomVariable() - Constructor for class jhplot.math.num.random.FRandomVariable
Default constructor.
FRandomVariable(double, double) - Constructor for class jhplot.math.num.random.FRandomVariable
Create a random variable with the given numerator degrees of freedom and denominator degrees of freedom.
FRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.FRandomVariable
Create a random variable with the given parameters.
FreeGroup - Class in org.lsmp.djep.groupJep.groups
A free group generated by a symbol t.
FreeGroup(RingI, String) - Constructor for class org.lsmp.djep.groupJep.groups.FreeGroup
Create the ring K(t) where t is a free variable.
FreeGroupElement - Class in org.lsmp.djep.groupJep.values
An element of a free group with one generator.
FreeGroupElement(FreeGroup, Number[]) - Constructor for class org.lsmp.djep.groupJep.values.FreeGroupElement
An element of a free group with one generator.
freeSpace(String) - Static method in class org.apache.commons.io.FileSystemUtils
Deprecated.
Use freeSpaceKb(String) Deprecated from 1.3, may be removed in 2.0
freeSpaceKb(String) - Static method in class org.apache.commons.io.FileSystemUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use FileStore.getUsableSpace().
freeSpaceKb(String, long) - Static method in class org.apache.commons.io.FileSystemUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use FileStore.getUsableSpace().
freeSpaceKb() - Static method in class org.apache.commons.io.FileSystemUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use FileStore.getUsableSpace().
freeSpaceKb(long) - Static method in class org.apache.commons.io.FileSystemUtils
Deprecated.
As of 2.6 deprecated without replacement. Please use FileStore.getUsableSpace().
frequencies(DoubleArrayList, IntArrayList) - Method in class cern.hep.aida.bin.DynamicBin1D
Computes the frequency (number of occurances, count) of each distinct element.
frequencies(DoubleArrayList, DoubleArrayList, IntArrayList) - Static method in class cern.jet.stat.Descriptive
Computes the frequency (number of occurances, count) of each distinct value in the given sorted data.
Frequency - Class in org.apache.commons.math3.stat
Maintains a frequency distribution.
Frequency() - Constructor for class org.apache.commons.math3.stat.Frequency
Default constructor.
Frequency(Comparator<?>) - Constructor for class org.apache.commons.math3.stat.Frequency
Constructor allowing values Comparator to be specified.
FREQUENCY - Static variable in class org.jfree.data.statistics.HistogramType
Frequency histogram.
fro(Zmat, int, int, int, int) - Static method in class Jampack.Norm
Computes the Frobenius norm of a the submatrix (ii1:ii2, jj1,jj2) of a Zmat.
fro(Zmat) - Static method in class Jampack.Norm
Computes the Frobenius norm of a Zmat.
fro(Z1) - Static method in class Jampack.Norm
Computes the Frobenius norm of a Z1.
fro(Zdiagmat) - Static method in class Jampack.Norm
Computes the Frobenius norm of a Zdiagmat.
from(LorentzVector) - Static method in class j4np.physics.LorentzVector
 
from(Vector3) - Static method in class j4np.physics.Vector3
 
FromBase - Class in org.lsmp.djep.xjep.function
 
FromBase() - Constructor for class org.lsmp.djep.xjep.function.FromBase
 
FromBase(int) - Constructor for class org.lsmp.djep.xjep.function.FromBase
 
FromBase(int, String) - Constructor for class org.lsmp.djep.xjep.function.FromBase
 
fromBase(String, int) - Method in class org.lsmp.djep.xjep.function.FromBase
 
fromJama(Matrix, Matrix) - Static method in class org.lsmp.djep.jama.JamaUtil
 
fromJama(Matrix) - Static method in class org.lsmp.djep.jama.JamaUtil
 
fromXML(String) - Static method in class jhplot.IO
Get object to XML using XSream package
fromXML(String) - Static method in class jhplot.io.Serialized
Get object to XML using XSream package
FS - Static variable in class jplot.JPlot
 
fs - Static variable in class jplot.Utils
 
FULL - Static variable in class org.jfree.data.RangeType
Full range (positive and negative).
FULL_BRACKET - Static variable in class org.lsmp.djep.xjep.PrintVisitor
All brackets are printed.
FUN - Static variable in class org.lsmp.djep.rpe.RpEval
 
func(F1D) - Method in class jhplot.P0D
Transform P0D array to array with values given by a function.
func(String, F1D) - Method in class jhplot.P0D
Make transformation of P0D using a function.
func(F1D) - Method in class jhplot.P0I
Transform P0I array to array with values given by a function.
func(String, F1D) - Method in class jhplot.P0I
Make transformation of P0I using a function.
FUNC - Static variable in class org.nfunk.jep.evaluation.CommandElement
 
Func1D - Class in org.jlab.groot.math
 
Func1D(String) - Constructor for class org.jlab.groot.math.Func1D
 
Func1D(String, double, double) - Constructor for class org.jlab.groot.math.Func1D
 
funcF() - Method in class jhplot.HPlot
Return FunctionFactory associated with the plot
funcionDesk - Static variable in class org.jlab.groot.math.FunctionFactory
 
function(Function) - Method in class jhplot.math.exp4j.ExpressionBuilder
Add a Function implementation available for use in the expression
Function - Class in jhplot.math.exp4j.function
A class representing a Function which can be used in an expression
Function(String, int) - Constructor for class jhplot.math.exp4j.function.Function
Create a new Function with a given name and number of arguments
Function(String) - Constructor for class jhplot.math.exp4j.function.Function
Create a new Function with a given name that takes a single argument
Function - Interface in jhplot.math
BSD License
Function - Interface in jhplot.math.num
A single variable function.
function(UnivariateFunction, double, double) - Static method in class org.apache.commons.math3.ml.neuralnet.FeatureInitializerFactory
Creates an initializer from a univariate function f(x).
FUNCTION - Static variable in class org.jlab.groot.base.DatasetAttributes
 
Function() - Method in class org.nfunk.jep.Parser
 
Function2D - Interface in org.jfree.data.function
A function of the form y = f(x).
FunctionFactory - Class in org.jlab.groot.math
 
FunctionFactory() - Constructor for class org.jlab.groot.math.FunctionFactory
 
FunctionMinimum - Class in org.freehep.math.minuit
Result of the minimization.
FunctionPlotter - Class in org.jlab.groot.graphics
 
FunctionPlotter(IDataSet) - Constructor for class org.jlab.groot.graphics.FunctionPlotter
 
FunctionPlotter - Class in org.nfunk.jepexamples
This applet is a demonstration of the possible applications of the JEP mathematical expression parser.
FunctionPlotter() - Constructor for class org.nfunk.jepexamples.FunctionPlotter
 
functions - Static variable in class cern.hep.aida.bin.BinFunctions1D
Little trick to allow for "aliasing", that is, renaming this class.
Functions - Class in cern.jet.math
Function objects to be passed to generic methods.
functions - Static variable in class cern.jet.math.Functions
Little trick to allow for "aliasing", that is, renaming this class.
functions(Function...) - Method in class jhplot.math.exp4j.ExpressionBuilder
Add multiple Function implementations available for use in the expression
functions(List<Function>) - Method in class jhplot.math.exp4j.ExpressionBuilder
Add multiple Function implementations available for use in the expression
Functions - Class in jhplot.math.exp4j.function
Class representing the builtin functions available for use in expressions You can enabled fast math calculation using
Functions() - Constructor for class jhplot.math.exp4j.function.Functions
 
functions - Variable in class jplot3dp.ModelView
 
FunctionsList() - Constructor for class jplot3dp.ModelView.FunctionsList
 
FunctionTable - Class in org.nfunk.jep
 
FunctionTable() - Constructor for class org.nfunk.jep.FunctionTable
 
FunctionToken - Class in jhplot.math.exp4j.tokenizer
 
FunctionToken(Function) - Constructor for class jhplot.math.exp4j.tokenizer.FunctionToken
 
FunctionUtils - Class in org.apache.commons.math3.analysis
Utilities for manipulating function objects.
Fuzzines - Static variable in class jminhep.clcontrol.Global
 
FuzzyCMeansAlg - Class in jminhep.algorithms
Fuzzy C-means cluster algorithm.
FuzzyCMeansAlg(DataHolder) - Constructor for class jminhep.algorithms.FuzzyCMeansAlg
Initialize Fuzzy C-means calculations
FuzzyKMeansClusterer<T extends Clusterable> - Class in org.apache.commons.math3.ml.clustering
Fuzzy K-Means clustering algorithm.
FuzzyKMeansClusterer(int, double) - Constructor for class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Creates a new instance of a FuzzyKMeansClusterer.
FuzzyKMeansClusterer(int, double, int, DistanceMeasure) - Constructor for class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Creates a new instance of a FuzzyKMeansClusterer.
FuzzyKMeansClusterer(int, double, int, DistanceMeasure, double, RandomGenerator) - Constructor for class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Creates a new instance of a FuzzyKMeansClusterer.
fval() - Method in class org.freehep.math.minuit.FunctionMinimum
Returns the function value at the minimum.
fval() - Method in class org.freehep.math.minuit.MnUserParameterState
returns the function value at the minimum
FXGraphics2D - Class in org.jfree.chart.fx
A Graphics2D implementation that writes to a JavaFX Canvas.
FXGraphics2D(GraphicsContext) - Constructor for class org.jfree.chart.fx.FXGraphics2D
Creates a new instance that will render to the specified JavaFX GraphicsContext.

G

g - Static variable in class cern.clhep.Units
 
g(double, double[]) - Method in class org.apache.commons.math3.ode.events.EventFilter
Compute the value of the switching function.
g(double, double[]) - Method in interface org.apache.commons.math3.ode.events.EventHandler
Compute the value of the switching function.
g(FieldODEStateAndDerivative<T>) - Method in interface org.apache.commons.math3.ode.events.FieldEventHandler
Compute the value of the switching function.
g(double[], long[]) - Method in class org.apache.commons.math3.stat.inference.GTest
Computes the G statistic for Goodness of Fit comparing observed and expected frequency counts.
g(double[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
g2d - Variable in class graph.Axis
The graph canvas this axis is attached to (if it is attached to any)
g2d - Variable in class graph.DataSet
The Graphics canvas that is driving the whole show.
G2Dint - Class in graph
This class is an extension of Graph2D class.
G2Dint() - Constructor for class graph.G2Dint
 
GAdd - Class in org.lsmp.djep.groupJep.function
Add function for use with arbitary groups.
GAdd(GroupI) - Constructor for class org.lsmp.djep.groupJep.function.GAdd
 
Gamma - Class in cern.jet.random
Gamma(double, double, RandomEngine) - Constructor for class cern.jet.random.Gamma
Constructs a Gamma distribution.
Gamma - Class in cern.jet.stat
Gamma and Beta functions.
gamma(double) - Static method in class cern.jet.stat.Gamma
Returns the Gamma function of the argument.
gamma(double, double, double) - Static method in class cern.jet.stat.Probability
Returns the integral from zero to x of the gamma probability density function.
gamma(double) - Static method in class graph.SpecialFunction
 
Gamma - Class in jhplot.math.num.pdf
The Gamma distribution (1).
Gamma() - Constructor for class jhplot.math.num.pdf.Gamma
Default constructor.
Gamma(double, double) - Constructor for class jhplot.math.num.pdf.Gamma
Create a distribution with the given alpha and beta values.
Gamma - Class in jhplot.math.num.special
Utility class that provides methods related to the gamma family of functions.
gamma(double) - Static method in class jhplot.stat.Statistics
Returns the Gamma function of the argument.
Gamma - Class in org.apache.commons.math3.special
This is a utility class that provides computation methods related to the Γ (Gamma) family of functions.
GAMMA - Static variable in class org.apache.commons.math3.special.Gamma
gamma(double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the value of Γ(x).
gammaComplemented(double, double, double) - Static method in class cern.jet.stat.Probability
Returns the integral from x to infinity of the gamma probability density function:
GammaDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Gamma distribution.
GammaDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.GammaDistribution
Creates a new gamma distribution with specified values of the shape and scale parameters.
GammaDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.GammaDistribution
Creates a new gamma distribution with specified values of the shape and scale parameters.
GammaDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.GammaDistribution
Creates a Gamma distribution.
GammaDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.GammaDistribution
Creates a Gamma distribution.
GammaRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Gamma distribution.
GammaRandomVariable() - Constructor for class jhplot.math.num.random.GammaRandomVariable
Default constructor.
GammaRandomVariable(double, double) - Constructor for class jhplot.math.num.random.GammaRandomVariable
Create a random variable with the given alpha and beta values.
GammaRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.GammaRandomVariable
Create a random variable with the given parameters.
GanttCategoryDataset - Interface in org.jfree.data.gantt
An extension of the IntervalCategoryDataset interface that adds support for multiple sub-intervals.
GanttRenderer - Class in org.jfree.chart.renderer.category
A renderer for simple Gantt charts.
GanttRenderer() - Constructor for class org.jfree.chart.renderer.category.GanttRenderer
Creates a new renderer.
GASCONSTANT - Static variable in class graph.SpecialFunction
Gas Constant.
Gaus2D - Class in org.jlab.groot.demo
 
Gaus2D() - Constructor for class org.jlab.groot.demo.Gaus2D
 
gauss - Static variable in class cern.clhep.Units
 
Gauss - Class in jhplot.fit
Gaussian distribution.
Gauss() - Constructor for class jhplot.fit.Gauss
 
Gauss(String) - Constructor for class jhplot.fit.Gauss
 
Gauss(String[], String[]) - Constructor for class jhplot.fit.Gauss
 
gauss(double, double, double) - Static method in class org.jlab.groot.math.FunctionFactory
 
Gaussian - Class in org.apache.commons.math3.analysis.function
Gaussian function.
Gaussian(double, double, double) - Constructor for class org.apache.commons.math3.analysis.function.Gaussian
Gaussian with given normalization factor, mean and standard deviation.
Gaussian(double, double) - Constructor for class org.apache.commons.math3.analysis.function.Gaussian
Normalized gaussian with given mean and standard deviation.
Gaussian() - Constructor for class org.apache.commons.math3.analysis.function.Gaussian
Normalized gaussian with zero mean and unit standard deviation.
Gaussian.Parametric - Class in org.apache.commons.math3.analysis.function
Parametric function where the input array contains the parameters of the Gaussian, ordered as follows: Norm Mean Standard deviation
gaussian4(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using the Gaussian integration formula (4 points).
gaussian8(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using the Gaussian integration formula (8 points).
GAUSSIAN_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Gaussian random deviates with mean = μ, std dev = σ.
GaussianCurveFitter - Class in org.apache.commons.math3.fitting
Fits points to a Gaussian function.
GaussianCurveFitter.ParameterGuesser - Class in org.apache.commons.math3.fitting
Guesses the parameters norm, mean, and sigma of a Gaussian.Parametric based on the specified observed points.
GaussianFitter - Class in org.apache.commons.math3.fitting
Deprecated.
As of 3.3. Please use GaussianCurveFitter and WeightedObservedPoints instead.
GaussianFitter(MultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.fitting.GaussianFitter
Deprecated.
Constructs an instance using the specified optimizer.
GaussianFitter - Class in org.apache.commons.math3.optimization.fitting
Deprecated.
As of 3.1 (to be removed in 4.0).
GaussianFitter(DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.GaussianFitter
Deprecated.
Constructs an instance using the specified optimizer.
GaussianFitter.ParameterGuesser - Class in org.apache.commons.math3.fitting
Deprecated.
Guesses the parameters norm, mean, and sigma of a Gaussian.Parametric based on the specified observed points.
GaussianFitter.ParameterGuesser - Class in org.apache.commons.math3.optimization.fitting
Deprecated.
Guesses the parameters norm, mean, and sigma of a Gaussian.Parametric based on the specified observed points.
GaussianRandomGenerator - Class in org.apache.commons.math3.random
This class is a gaussian normalized random generator for scalars.
GaussianRandomGenerator(RandomGenerator) - Constructor for class org.apache.commons.math3.random.GaussianRandomGenerator
Create a new generator.
GaussIntegrator - Class in org.apache.commons.math3.analysis.integration.gauss
Class that implements the Gaussian rule for integrating a weighted function.
GaussIntegrator(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.integration.gauss.GaussIntegrator
Creates an integrator from the given points and weights.
GaussIntegrator(Pair<double[], double[]>) - Constructor for class org.apache.commons.math3.analysis.integration.gauss.GaussIntegrator
Creates an integrator from the given pair of points (first element of the pair) and weights (second element of the pair.
GaussIntegratorFactory - Class in org.apache.commons.math3.analysis.integration.gauss
Class that provides different ways to compute the nodes and weights to be used by the Gaussian integration rule.
GaussIntegratorFactory() - Constructor for class org.apache.commons.math3.analysis.integration.gauss.GaussIntegratorFactory
 
GaussNewtonOptimizer - Class in org.apache.commons.math3.fitting.leastsquares
Gauss-Newton least-squares solver.
GaussNewtonOptimizer() - Constructor for class org.apache.commons.math3.fitting.leastsquares.GaussNewtonOptimizer
Creates a Gauss Newton optimizer.
GaussNewtonOptimizer(GaussNewtonOptimizer.Decomposition) - Constructor for class org.apache.commons.math3.fitting.leastsquares.GaussNewtonOptimizer
Create a Gauss Newton optimizer that uses the given decomposition algorithm to solve the normal equations.
GaussNewtonOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector.jacobian
Deprecated.
All classes and interfaces in this package are deprecated. The optimizers that were provided here were moved to the org.apache.commons.math3.fitting.leastsquares package (cf. MATH-1008).
GaussNewtonOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.GaussNewtonOptimizer
Deprecated.
Simple constructor with default settings.
GaussNewtonOptimizer(boolean, ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.GaussNewtonOptimizer
Deprecated.
 
GaussNewtonOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated.
As of 3.1 (to be removed in 4.0).
GaussNewtonOptimizer() - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
GaussNewtonOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
Deprecated.
Simple constructor with default settings.
GaussNewtonOptimizer(boolean) - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
GaussNewtonOptimizer(boolean, ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
Deprecated.
 
GaussNewtonOptimizer.Decomposition - Enum in org.apache.commons.math3.fitting.leastsquares
The decomposition algorithm to use to solve the normal equations.
gcd(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Computes the greatest common divisor of the absolute value of two numbers, using a modified version of the "binary gcd" method.
gcd(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Gets the greatest common divisor of the absolute value of two numbers, using the "binary gcd" method which avoids division and modulo operations.
GComparative - Class in org.lsmp.djep.groupJep.function
Implements logical operations on a group.
GComparative(GroupI, int) - Constructor for class org.lsmp.djep.groupJep.function.GComparative
Constructor.
gDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math3.stat.inference.GTest
Computes a G (Log-Likelihood Ratio) two sample test statistic for independence comparing frequency counts in observed1 and observed2.
gDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
GDivide - Class in org.lsmp.djep.groupJep.function
Divide function for use with arbitary groups.
GDivide(GroupI) - Constructor for class org.lsmp.djep.groupJep.function.GDivide
 
GE - Static variable in class org.lsmp.djep.rpe.RpEval
 
GE - Static variable in class org.nfunk.jep.function.Comparative
 
ge(Object, Object) - Method in class org.nfunk.jep.function.Comparative
 
GE - Static variable in interface org.nfunk.jep.ParserConstants
 
gemm(Matrix, Matrix, double, double) - Method in class jhplot.math.kalman.jama.Matrix
Generalized linear algebraic matrix-matrix multiplication (of A); C = alpha*A x B + beta*C.
genc(Zmat, int, int, int) - Static method in class Jampack.House
Generates a Householder transformation from within the part of column c of a Zmat (altered) extending from rows r1 to r2.
genc(double, double, double, double) - Static method in class Jampack.Rot
Given the real and imaginary parts of a 2-vector, genc returns a plane rotation P such that
genc(double, double, double, double, Rot) - Static method in class Jampack.Rot
Given the real and imaginary parts of a 2-vector, genc generates a plane rotation P such that
genc(double, double) - Static method in class Jampack.Rot
Given a real 2-vector, genc returns a real plane rotation P such that
genc(double, double, Rot) - Static method in class Jampack.Rot
Given a real 2-vectc, genc generates a real plane rotation P such that
genc(Zmat, int, int, int) - Static method in class Jampack.Rot
Given a Zmat A, genc returns a plane rotation that on premultiplication into rows ii1 and ii2 annihilates A(ii2,jj).
genc(Zmat, int, int, int, Rot) - Static method in class Jampack.Rot
Given a Zmat A, genc generates a plane rotation that on premultiplication into rows ii1 and ii2 annihilates A(ii2,jj).
GENERAL - Static variable in class org.jfree.chart.event.ChartChangeEventType
GENERAL.
generate() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Generate a single event with nparts particles or nparts pairs of particles if angres is selected.
generate() - Method in interface hep.physics.event.generator.EventGenerator
 
generate(Collection<Vector2D>) - Method in interface org.apache.commons.math3.geometry.euclidean.twod.hull.ConvexHullGenerator2D
Builds the convex hull from the set of input points.
generate(Collection<P>) - Method in interface org.apache.commons.math3.geometry.hull.ConvexHullGenerator
Builds the convex hull from the set of input points.
generateAttributedSectionLabel(PieDataset, Comparable) - Method in interface org.jfree.chart.labels.PieSectionLabelGenerator
Generates an attributed label for the specified series, or null if no attributed label is available (in which case, the string returned by PieSectionLabelGenerator.generateSectionLabel(PieDataset, Comparable) will provide the fallback).
generateAttributedSectionLabel(PieDataset, Comparable) - Method in class org.jfree.chart.labels.StandardPieSectionLabelGenerator
Generates an attributed label for the specified series, or null if no attributed label is available (in which case, the string returned by StandardPieSectionLabelGenerator.generateSectionLabel(PieDataset, Comparable) will provide the fallback).
generateClipPath(Rectangle2D, ValueAxis, ValueAxis) - Method in class org.jfree.chart.ClipPath
Deprecated.
Generates the clip path.
generateColorPalette3D() - Static method in class org.jlab.groot.base.ColorPalette
 
generateColumnLabel(CategoryDataset, int) - Method in class org.jfree.chart.labels.AbstractCategoryItemLabelGenerator
Generates a label for the specified row.
generateColumnLabel(CategoryDataset, int) - Method in interface org.jfree.chart.labels.CategoryItemLabelGenerator
Generates a label for the specified row.
generateLabel(XYDataset, int, int) - Method in class org.jfree.chart.labels.BubbleXYItemLabelGenerator
Generates an item label for a particular item within a series.
generateLabel(CategoryDataset, int, int) - Method in interface org.jfree.chart.labels.CategoryItemLabelGenerator
Generates a label for the specified item.
generateLabel(CategoryDataset, int) - Method in interface org.jfree.chart.labels.CategorySeriesLabelGenerator
Generates a label for the specified series.
generateLabel(Crosshair) - Method in interface org.jfree.chart.labels.CrosshairLabelGenerator
Returns a string that can be used as the label for a crosshair.
generateLabel(XYDataset, int, int) - Method in class org.jfree.chart.labels.HighLowItemLabelGenerator
Generates a label for the specified item.
generateLabel(XYDataset, int, int) - Method in class org.jfree.chart.labels.IntervalXYItemLabelGenerator
Generates the item label text for an item in a dataset.
generateLabel(XYDataset, int) - Method in class org.jfree.chart.labels.MultipleXYSeriesLabelGenerator
Generates a label for the specified series.
generateLabel(CategoryDataset, int, int) - Method in class org.jfree.chart.labels.StandardCategoryItemLabelGenerator
Generates the label for an item in a dataset.
generateLabel(CategoryDataset, int) - Method in class org.jfree.chart.labels.StandardCategorySeriesLabelGenerator
Generates a label for the specified series.
generateLabel(Crosshair) - Method in class org.jfree.chart.labels.StandardCrosshairLabelGenerator
Returns a string that can be used as the label for a crosshair.
generateLabel(XYDataset, int, int) - Method in class org.jfree.chart.labels.StandardXYItemLabelGenerator
Generates the item label text for an item in a dataset.
generateLabel(XYDataset, int) - Method in class org.jfree.chart.labels.StandardXYSeriesLabelGenerator
Generates a label for the specified series.
generateLabel(XYDataset, int, int) - Method in class org.jfree.chart.labels.SymbolicXYItemLabelGenerator
Generates a label for the specified item.
generateLabel(XYDataset, int, int) - Method in interface org.jfree.chart.labels.XYItemLabelGenerator
Generates a label for the specified item.
generateLabel(XYDataset, int) - Method in interface org.jfree.chart.labels.XYSeriesLabelGenerator
Generates a label for the specified series.
generateLabelString(XYDataset, int, int) - Method in class org.jfree.chart.labels.AbstractXYItemLabelGenerator
Generates a label string for an item in the dataset.
generateLabelString(XYDataset, int, int) - Method in class org.jfree.chart.labels.BubbleXYItemLabelGenerator
Generates a label string for an item in the dataset.
generateLabelString(XYDataset, int, int) - Method in class org.jfree.chart.labels.StandardXYZToolTipGenerator
Generates a label string for an item in the dataset.
generateNonSingular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Modifies the given matrix square matrix A such that it is diagonally dominant by row and column, hence non-singular, hence invertible.
generateParseException() - Method in class jplot3dp.MathParser.MathParser
 
generateParseException() - Method in class org.nfunk.jep.Parser
 
generateRowLabel(CategoryDataset, int) - Method in class org.jfree.chart.labels.AbstractCategoryItemLabelGenerator
Generates a label for the specified row.
generateRowLabel(CategoryDataset, int) - Method in interface org.jfree.chart.labels.CategoryItemLabelGenerator
Generates a label for the specified row.
generateSectionLabel(PieDataset, Comparable) - Method in interface org.jfree.chart.labels.PieSectionLabelGenerator
Generates a label for a pie section.
generateSectionLabel(PieDataset, Comparable) - Method in class org.jfree.chart.labels.StandardPieSectionLabelGenerator
Generates a label for a pie section.
generateSeed() - Method in class jminhep.algorithms.KMeansAlg
Generate random seeds for initial centroids
generateToolTip(CategoryDataset, int, int) - Method in interface org.jfree.chart.labels.CategoryToolTipGenerator
Generates the tool tip text for an item in a dataset.
generateToolTip(ContourDataset, int) - Method in interface org.jfree.chart.labels.ContourToolTipGenerator
Deprecated.
Generates a tooltip text item for a particular item within a series.
generateToolTip(XYDataset, int, int) - Method in class org.jfree.chart.labels.CustomXYToolTipGenerator
Generates a tool tip text item for a particular item within a series.
generateToolTip(XYDataset, int, int) - Method in class org.jfree.chart.labels.HighLowItemLabelGenerator
Generates a tooltip text item for a particular item within a series.
generateToolTip(PieDataset, Comparable) - Method in interface org.jfree.chart.labels.PieToolTipGenerator
Generates a tool tip text item for the specified item in the dataset.
generateToolTip(CategoryDataset, int, int) - Method in class org.jfree.chart.labels.StandardCategoryToolTipGenerator
Generates the tool tip text for an item in a dataset.
generateToolTip(ContourDataset, int) - Method in class org.jfree.chart.labels.StandardContourToolTipGenerator
Deprecated.
Generates a tooltip text item for a particular item within a series.
generateToolTip(PieDataset, Comparable) - Method in class org.jfree.chart.labels.StandardPieToolTipGenerator
Generates a tool tip text item for one section in a pie chart.
generateToolTip(XYDataset, int, int) - Method in class org.jfree.chart.labels.StandardXYToolTipGenerator
Generates the tool tip text for an item in a dataset.
generateToolTip(XYZDataset, int, int) - Method in class org.jfree.chart.labels.StandardXYZToolTipGenerator
Generates a tool tip text item for a particular item within a series.
generateToolTip(XYDataset, int, int) - Method in class org.jfree.chart.labels.SymbolicXYItemLabelGenerator
Generates a tool tip text item for a particular item within a series.
generateToolTip(XYDataset, int, int) - Method in interface org.jfree.chart.labels.XYToolTipGenerator
Generates the tooltip text for the specified item.
generateToolTip(XYZDataset, int, int) - Method in interface org.jfree.chart.labels.XYZToolTipGenerator
Generates a tool tip text item for a particular item within a series.
generateToolTipFragment(String) - Method in class org.jfree.chart.imagemap.DynamicDriveToolTipTagFragmentGenerator
Generates a tooltip string to go in an HTML image map.
generateToolTipFragment(String) - Method in class org.jfree.chart.imagemap.OverLIBToolTipTagFragmentGenerator
Generates a tooltip string to go in an HTML image map.
generateToolTipFragment(String) - Method in class org.jfree.chart.imagemap.StandardToolTipTagFragmentGenerator
Generates a tooltip string to go in an HTML image map.
generateToolTipFragment(String) - Method in interface org.jfree.chart.imagemap.ToolTipTagFragmentGenerator
Generates a tooltip string to go in an HTML image map.
generateURL(CategoryDataset, int, int) - Method in interface org.jfree.chart.urls.CategoryURLGenerator
Returns a URL for one item in a dataset.
generateURL(CategoryDataset, int, int) - Method in class org.jfree.chart.urls.CustomCategoryURLGenerator
Generates a URL.
generateURL(PieDataset, Comparable, int) - Method in class org.jfree.chart.urls.CustomPieURLGenerator
Generates a URL fragment.
generateURL(XYDataset, int, int) - Method in class org.jfree.chart.urls.CustomXYURLGenerator
Generates a URL.
generateURL(PieDataset, Comparable, int) - Method in interface org.jfree.chart.urls.PieURLGenerator
Generates a URL for one item in a PieDataset.
generateURL(CategoryDataset, int, int) - Method in class org.jfree.chart.urls.StandardCategoryURLGenerator
Generates a URL for a particular item within a series.
generateURL(PieDataset, Comparable, int) - Method in class org.jfree.chart.urls.StandardPieURLGenerator
Generates a URL.
generateURL(XYDataset, int, int) - Method in class org.jfree.chart.urls.StandardXYURLGenerator
Generates a URL for a particular item within a series.
generateURL(XYZDataset, int, int) - Method in class org.jfree.chart.urls.StandardXYZURLGenerator
Generates a URL for a particular item within a series.
generateURL(XYDataset, int, int) - Method in class org.jfree.chart.urls.TimeSeriesURLGenerator
Generates a URL for a particular item within a series.
generateURL(XYDataset, int, int) - Method in interface org.jfree.chart.urls.XYURLGenerator
Generates a URL for a particular item within a series.
generateURL(XYZDataset, int, int) - Method in interface org.jfree.chart.urls.XYZURLGenerator
Generates a URL for a particular item within a series.
generateURLFragment(String) - Method in class org.jfree.chart.imagemap.StandardURLTagFragmentGenerator
Generates a URL string to go in an HTML image map.
generateURLFragment(String) - Method in interface org.jfree.chart.imagemap.URLTagFragmentGenerator
Generates a URL string to go in an HTML image map.
GENERATOR_FIELD_NUMBER - Static variable in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
GeneratorEvent - Class in hep.physics.event.generator
EventHeader for an event generator.
GeneratorEvent(int, int) - Constructor for class hep.physics.event.generator.GeneratorEvent
 
GeneratorFactory - Class in hep.physics.event.generator
A factory used for creating events and particles.
GeneratorFactory() - Constructor for class hep.physics.event.generator.GeneratorFactory
 
genericPartition(int, int, int, int, int[], IntComparator, IntComparator, IntComparator, Swapper) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it generically partitions arbitrary shaped data (for example matrices or multiple arrays) rather than int[] arrays.
GenericPermuting - Class in cern.colt
Generically reorders (permutes) arbitrary shaped data (for example, an array, three arrays, a 2-d matrix, two linked lists) using an in-place swapping algorithm.
GenericSorting - Class in cern.colt
Generically sorts arbitrary shaped data (for example multiple arrays, 1,2 or 3-d matrices, and so on) using a quicksort or mergesort.
GeneticAlgorithm - Class in org.apache.commons.math3.genetics
Implementation of a genetic algorithm.
GeneticAlgorithm(CrossoverPolicy, double, MutationPolicy, double, SelectionPolicy) - Constructor for class org.apache.commons.math3.genetics.GeneticAlgorithm
Create a new genetic algorithm.
GenevaJetFinder - Class in hep.physics.jet
 
GenevaJetFinder(double) - Constructor for class hep.physics.jet.GenevaJetFinder
 
GENJETS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent
 
GenMat - Class in org.lsmp.djep.vectorJep.function
Generate vectors and matrices.
GenMat() - Constructor for class org.lsmp.djep.vectorJep.function.GenMat
 
genr(Zmat, int, int, int) - Static method in class Jampack.House
Generates a Householder transformation from within the part of row r of a Zmat (altered) extending from columns c1 to c2.
genr(double, double, double, double) - Static method in class Jampack.Rot
Given the real and imaginary parts of a 2-vector, genr returns a plane rotation such that
genr(double, double, double, double, Rot) - Static method in class Jampack.Rot
Given the real and imaginary parts of a 2-vector, genr generates a plane rotation such that
genr(Zmat, int, int, int) - Static method in class Jampack.Rot
Given a Zmat A, genr returns a plane rotation that on postmultiplication into column jj1 and jj2 annihilates A(ii,jj2).
genr(Zmat, int, int, int, Rot) - Static method in class Jampack.Rot
Given a Zmat A, genr generates a plane rotation that on postmultiplication into column jj1 and jj2 annihilates A(ii,jj2).
genr(double, double) - Static method in class Jampack.Rot
Given a real 2-vector, genr returns a plane rotation such that
genr(double, double, Rot) - Static method in class Jampack.Rot
Given a real 2-vector, genr generates a plane rotation such that
genRange(double, double, int) - Method in class org.lsmp.djep.vectorJep.function.VRange
 
genRange(double, double, int) - Method in class org.nfunk.jep.function.Range
Generates a range [low,low+inc,...,low+inc*(steps-1)]
Geometric - Class in jhplot.math.num.pdf
The Geometric distribution.
Geometric() - Constructor for class jhplot.math.num.pdf.Geometric
Default constructor.
Geometric(double) - Constructor for class jhplot.math.num.pdf.Geometric
Create a distribution with the given probability of success.
GeometricDistribution - Class in org.apache.commons.math3.distribution
Implementation of the geometric distribution.
GeometricDistribution(double) - Constructor for class org.apache.commons.math3.distribution.GeometricDistribution
Create a geometric distribution with the given probability of success.
GeometricDistribution(RandomGenerator, double) - Constructor for class org.apache.commons.math3.distribution.GeometricDistribution
Creates a geometric distribution.
geometricMean - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.geometricMean().
geometricMean() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the geometric mean, which is Product( x[i] )1.0/size().
geometricMean(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the geometric mean of a data sequence.
geometricMean(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the geometric mean of a data sequence.
GeometricMean - Class in org.apache.commons.math3.stat.descriptive.moment
Returns the geometric mean of the available values.
GeometricMean() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Create a GeometricMean instance
GeometricMean(GeometricMean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Copy constructor, creates a new GeometricMean identical to the original
GeometricMean(SumOfLogs) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Create a GeometricMean instance using the given SumOfLogs instance
geometricMean(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the geometric mean of the entries in the input array, or Double.NaN if the array is empty.
geometricMean(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the geometric mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
geometricPdf(int, double) - Static method in class cern.jet.random.Distributions
Returns the probability distribution function of the discrete geometric distribution.
GeometricRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Geometric distribution.
GeometricRandomVariable() - Constructor for class jhplot.math.num.random.GeometricRandomVariable
Default constructor.
GeometricRandomVariable(double) - Constructor for class jhplot.math.num.random.GeometricRandomVariable
Create a random variable with the given probability of success.
GeometricRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.GeometricRandomVariable
Create a random variable with the given parameters.
Geometry - Class in jplot
Collection of geometry utility methods.
Geometry() - Constructor for class jplot.Geometry
 
get(int, int) - Method in class cern.colt.bitvector.BitMatrix
Returns from the receiver the value of the bit at the specified coordinate.
get(int) - Method in class cern.colt.bitvector.BitVector
Returns from the bitvector the value of the bit with the specified index.
get(long[], int) - Static method in class cern.colt.bitvector.QuickBitVector
Returns from the bitvector the value of the bit with the specified index.
get(int) - Method in class cern.colt.list.AbstractBooleanList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractByteList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractCharList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractDoubleList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractFloatList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractIntList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractLongList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractShortList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.adapter.DoubleListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.adapter.FloatListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.adapter.IntListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.adapter.LongListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.adapter.ObjectListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.BooleanArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.ByteArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.CharArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.DoubleArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.FloatArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.IntArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.LongArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.ObjectArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.ShortArrayList
Returns the element at the specified position in the receiver.
get(double) - Method in class cern.colt.map.AbstractDoubleIntMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.AbstractIntDoubleMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.AbstractIntIntMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.AbstractIntObjectMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.AbstractLongObjectMap
Returns the value associated with the specified key.
get(double) - Method in class cern.colt.map.OpenDoubleIntHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.OpenIntDoubleHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.OpenIntIntHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.OpenIntObjectHashMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.OpenLongObjectHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the matrix cell value at coordinate index.
get(int, int) - Method in class cern.colt.matrix.DoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
get(int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
get(int) - Method in class cern.colt.matrix.ObjectMatrix1D
Returns the matrix cell value at coordinate index.
get(int, int) - Method in class cern.colt.matrix.ObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
get(int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
get(String) - Method in class hep.physics.event.BaseEvent
 
get(String) - Method in interface hep.physics.event.HEPEvent
Get an object from the event
get(int) - Method in class hep.physics.particle.properties.DefaultParticlePropertyProvider
Get the properties for a particular particle.
get(int) - Method in interface hep.physics.particle.properties.ParticlePropertyProvider
 
get(int, int) - Method in class j4np.physics.TransMatrix
 
get(int, int) - Method in class Jama.Matrix
Get a single element.
get(int) - Method in class Jampack.Z1
Returns the ith element of a Z1 as a Z.
get(int) - Method in class Jampack.Zdiagmat
Gets the ii-th diagonal element of a Zdiagmat.
get(int, int) - Method in class Jampack.Zmat
Returns the (ii,jj)-element of a Zmat.
get(int, int, int, int) - Method in class Jampack.Zmat
Returns the submatrix (ii1:ii2, jj1:jj2).
get(int[], int, int) - Method in class Jampack.Zmat
Returns the submatrix (ii[], jj1:jj2).
get(int, int, int[]) - Method in class Jampack.Zmat
Returns the submatrix (ii1:ii2, jj[]).
get(int[], int[]) - Method in class Jampack.Zmat
Returns the submatrix (ii[], jj[]).
get() - Method in class jhplot.F1D
Get the proxy of this function used for serialization and non-graphical representations.
get() - Method in class jhplot.F2D
Get the proxy of this function used for serialization and non-graphical representations.
get() - Method in class jhplot.F3D
Get the proxy of this function used for serialization and non-graphical representations.
get() - Method in class jhplot.FND
Get the proxy of this function used for serialization and non-graphical representations.
get() - Method in class jhplot.H1D
Get JAIDA histogram
get() - Method in class jhplot.H2D
Get the JAIDA Histogram2D
get() - Method in class jhplot.HProf1D
Get JAIDA histogram
get() - Method in class jhplot.HProf2D
Get the JAIDA Profile2D
get(String) - Method in class jhplot.io.FileAida
Get object associated with the key name
get(String) - Method in class jhplot.io.FileRoot
Get object associated with the key name in the current directory.
get(String) - Method in class jhplot.io.HBook
Get an object using the key
get(String) - Method in class jhplot.io.HDataBase
Get object from the database using a key
get(int, int) - Method in class jhplot.math.kalman.jama.Matrix
Get a single element.
get(int) - Method in class jhplot.math.num.DoubleArray
Access the element at the given index.
get(int, String) - Method in class jhplot.P0D
Get P0D with values below, above or equal a specified value.
get(int, String) - Method in class jhplot.P0I
Get P0I with values below, above or equal a specified value.
get(int) - Method in class jhplot.PND
Return a specific row as array
get(int, int) - Method in class jhplot.PND
Return a specific value.
get(int) - Method in class jhplot.PNI
Return a specific row as array
get(int, int) - Method in class jhplot.PNI
Return a specific value.
get() - Method in class jhplot.security.MD5
Returns 32-character hex representation of this objects hash
get(String, String) - Static method in class jhplot.utils.FileList
Get list of files in all directories (including subdirectories).
get(String) - Static method in class jhplot.Web
Download a file to the local disk.
get(String, String) - Static method in class jhplot.Web
Download a file to the local disk.
Get - Class in jminhep.cluster
Some useful methods related to the clustering procedure
Get() - Constructor for class jminhep.cluster.Get
 
get(int) - Method in class org.apache.commons.io.ByteOrderMark
The byte at the specified position.
get() - Method in interface org.apache.commons.io.file.Counters.Counter
Gets the counter as a long.
get() - Method in interface org.apache.commons.io.function.IOSupplier
Gets a result.
get(int) - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Get the stored value associated with the given key
get(int) - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Get the stored value associated with the given key
get(int, int) - Method in class org.freehep.math.minuit.MnUserCovariance
 
get(int) - Method in class org.jfree.chart.axis.TickUnits
Returns the tickunit on the given position.
get(int) - Method in class org.jfree.chart.LegendItemCollection
Returns a legend item from the collection.
get(int) - Method in class org.jfree.data.gantt.TaskSeries
Returns a task from the series.
get(String) - Method in class org.jfree.data.gantt.TaskSeries
Returns the task in the series that has the specified description.
get(int, int) - Method in class org.jfree.data.xy.MatrixSeries
Returns the value of the specified item in this matrix series.
get(AttributeType) - Method in class org.jlab.groot.base.Attributes
 
get(String) - Method in class org.nfunk.jep.FunctionTable
returns the PostfixMathCommandI for function with name s.
get(Object) - Method in class org.nfunk.jep.FunctionTable
overrides the standard hashtable method.
get(Object) - Method in class org.nfunk.jep.SymbolTable
Deprecated.
The getValue or getVar methods should be used instead.
get0(int) - Method in class Jampack.Zdiagmat
Gets the ith diagonal of a of a Zdiagmat (0-based).
get0(int, int) - Method in class Jampack.Zmat
Returns the zero-based (i,j)-element of a Zmat.
get2D_xTranslation() - Method in class jplot3d.Projector
Gets the 2D x translation.
get2D_yTranslation() - Method in class jplot3d.Projector
Gets the 2D y translation.
get2DScaling() - Method in class jplot3d.Projector
Gets the 2D scaling factor.
get2DScaling() - Method in class jplot3d.SurfaceModelCanvas
 
get2DType() - Method in class jplot.GraphSettings
Returns the current graph type.
get2xSpin() - Method in interface hep.physics.particle.properties.ParticleType
2 x Spin
get3sProbability() - Method in class jhplot.stat.ConfidenceLevel
Get 3s probability.
get5sProbability() - Method in class jhplot.stat.ConfidenceLevel
Get 5s probability.
getA() - Method in class org.apache.commons.math3.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince54FieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince853FieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - Method in class org.apache.commons.math3.ode.nonstiff.EulerFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - Method in interface org.apache.commons.math3.ode.nonstiff.FieldButcherArrayProvider
Get the internal weights from Butcher array (without the first empty row).
getA() - Method in class org.apache.commons.math3.ode.nonstiff.GillFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - Method in class org.apache.commons.math3.ode.nonstiff.HighamHall54FieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - Method in class org.apache.commons.math3.ode.nonstiff.LutherFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - Method in class org.apache.commons.math3.ode.nonstiff.MidpointFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - Method in class org.apache.commons.math3.ode.nonstiff.ThreeEighthesFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - Method in class org.jfree.data.function.PowerFunction2D
Returns the 'a' coefficient that was specified in the constructor.
getA1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Get the axis of the first rotation.
getA2() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Get the axis of the second rotation.
getA3() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Get the axis of the second rotation.
getAbbreviatedFilename() - Method in class jplot.DataFile
Return the abbreviated filename.
getAbscissa(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get the abscissa of a point with respect to the line.
getAbsoluteAccuracy() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the absolute accuracy.
getAbsoluteAccuracy() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the absolute accuracy.
getAbsoluteAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Get the absolute accuracy of the solver.
getAbsoluteAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Get the absolute accuracy of the solver.
getAbsoluteAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BracketedRealFieldUnivariateSolver
Get the absolute accuracy of the solver.
getAbsoluteAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the absolute accuracy.
getAbsoluteAccuracy() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Deprecated.
Get the absolute accuracy.
getAbsoluteThreshold() - Method in class org.apache.commons.math3.optim.AbstractConvergenceChecker
 
getAbsoluteThreshold() - Method in class org.apache.commons.math3.optimization.AbstractConvergenceChecker
Deprecated.
 
getAclEntryList(Path) - Static method in class org.apache.commons.io.file.PathUtils
Reads the access control list from a file attribute view.
getActiveSubdetectors() - Method in interface hep.lcio.event.LCRunHeader
Returns the names of the active subdetectors used in the simulation.
getActiveSubdetectors() - Method in class hep.lcio.implementation.event.ILCRunHeader
 
getADCValues() - Method in interface hep.lcio.event.TrackerRawData
The actual FADC spectrum.
getADCValues() - Method in class hep.lcio.implementation.event.ITrackerRawData
 
getAdd() - Method in class org.nfunk.jep.OperatorSet
 
getAdditionalItemLabelGenerator() - Method in class org.jfree.chart.renderer.xy.YIntervalRenderer
Returns the generator for the item labels that appear near the lower y-value.
getAdditioner() - Method in class jplot.LinePars
Returns the additioner for this line, which is a value to be used to increase each value of the dataset before plotting.
getAdjustedRSquared() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the adjusted R-squared statistic, defined by the formula
getAdjustForBinSize() - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns a flag that controls whether or not the bin count is divided by the bin size in the SimpleHistogramDataset.getXValue(int, int) method.
getAdjustForDaylightSaving() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns the flag that controls whether or not the daylight saving adjustment is applied.
getAdvanceLinePaint() - Method in class org.jfree.chart.axis.CyclicNumberAxis
The advance line is the line drawn at the limit of the current cycle, when erasing the previous cycle.
getAdvanceLineStroke() - Method in class org.jfree.chart.axis.CyclicNumberAxis
The advance line is the line drawn at the limit of the current cycle, when erasing the previous cycle.
getAggregatedItemsKey() - Method in class org.jfree.chart.plot.MultiplePiePlot
Returns the key for aggregated items in the pie plots, if there are any.
getAggregatedItemsPaint() - Method in class org.jfree.chart.plot.MultiplePiePlot
Returns the paint used to draw the pie section representing the aggregated items.
getAgrestiCoullInterval(int, int, double) - Static method in class org.apache.commons.math3.stat.interval.IntervalUtils
Create an Agresti-Coull binomial confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, successes and confidence level.
getAlgorithmType() - Method in interface hep.lcio.event.ParticleID
Type of the algorithm/module that created this hypothesis - NOTE: must be unique within one collection.
getAlgorithmType() - Method in interface hep.lcio.event.Vertex
Type code for the algorithm that has been used to create the vertex - check/set the collection parameters AlgorithmName and AlgorithmType.
getAlgorithmType() - Method in class hep.lcio.implementation.event.IParticleID
 
getAlgorithmType() - Method in class hep.lcio.implementation.event.IVertex
 
getAlignmentY() - Method in class jplot.SmallButton
 
getAlignmentY() - Method in class jplot.SmallToggleButton
No idea why I need this method but ala.
getAll() - Method in class jhplot.io.FileAida
Get list of all objects
getAll() - Method in class jhplot.io.HBook
Get all objects as a map
getAllDerivatives() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get all partial derivatives.
getAllentries() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional int32 allentries = 11;
getAllentries() - Method in class promc.io.PBufFile.Record.H1D
optional int32 allentries = 11;
getAllentries() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional int32 allentries = 11;
getAllentries() - Method in class promc.io.PBufFile.Record.H2D.Builder
optional int32 allentries = 11;
getAllentries() - Method in class promc.io.PBufFile.Record.H2D
optional int32 allentries = 11;
getAllentries() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
optional int32 allentries = 11;
getAllH1D() - Method in class jhplot.io.CFBook
Get array with all H1D histograms.
getAllH2D() - Method in class jhplot.io.CFBook
Get array with all H2D histograms.
getAllNames(String) - Method in class jhplot.io.FileAida
Get list of all objects
getAllNames() - Method in class jhplot.io.FileAida
Get list of all objects
getAllocatedY() - Method in class org.jfree.chart.plot.PieLabelRecord
Returns the allocated y-coordinate.
getAllowAssignment() - Method in class org.nfunk.jep.JEP
Whether assignment equation y=x+1 equations are allowed.
getAllowDuplicateXValues() - Method in class org.jfree.data.ComparableObjectSeries
Returns a flag that controls whether duplicate x-values are allowed.
getAllowDuplicateXValues() - Method in class org.jfree.data.xy.XYSeries
Returns a flag that controls whether duplicate x-values are allowed.
getAllowedFunctionCharacters() - Static method in class jhplot.math.exp4j.function.Function
Deprecated.
since 0.4.5 All unicode letters are allowed to be used in function names since 0.4.3. This API Function can be safely ignored. Checks for function name validity can be done using Character.isLetter() et al.
getAllowNegativesFlag() - Method in class org.jfree.chart.axis.LogarithmicAxis
Returns the 'allowNegativesFlag' flag; true to allow negative values in data, false to be able to plot positive values arbitrarily close to zero.
getAllowUndeclared() - Method in class org.nfunk.jep.JEP
Returns the value of the allowUndeclared option.
getAllP1D() - Method in class jhplot.io.CFBook
Get array with all P1D containers.
getAllPanels() - Method in class jplot.JPlot
 
getAllTypes() - Method in class jhplot.io.FileAida
Get list of all types
getAllTypes(String) - Method in class jhplot.io.FileAida
Get list of all types
getAlpha() - Method in class jhplot.math.num.pdf.Beta
Access the alpha parameter.
getAlpha() - Method in class jhplot.math.num.pdf.Gamma
Access the alpha parameter.
getAlpha() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Access the first shape parameter, alpha.
getAlpha() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Deprecated.
as of version 3.1, GammaDistribution.getShape() should be preferred. This method will be removed in version 4.0.
getAlpha() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the azimuth of the vector.
getAlpha() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the azimuth of the vector.
getAlpha() - Method in class org.apache.commons.math3.geometry.spherical.oned.S1Point
Get the azimuthal angle \( \alpha \).
getAlpha() - Method in class org.jfree.chart.plot.Marker
Returns the alpha transparency.
getAlpha() - Method in class org.jfree.chart.renderer.GrayPaintScale
Returns the alpha transparency that was specified in the constructor.
getAlpha() - Method in class org.jfree.chart.renderer.xy.DeviationRenderer
Returns the alpha transparency for the background shading.
getAlphaQCD() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QCD = 13;
getAlphaQCD() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float Alpha_QCD = 13;
getAlphaQCD() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float Alpha_QCD = 13;
getAlphaQCD() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QCD = 13;
getAlphaQCD() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float Alpha_QCD = 13;
getAlphaQCD() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float Alpha_QCD = 13;
getAlphaQCD(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQCD = 13;
getAlphaQCD(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float AlphaQCD = 13;
getAlphaQCD(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float AlphaQCD = 13;
getAlphaQCDCount() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQCD = 13;
getAlphaQCDCount() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float AlphaQCD = 13;
getAlphaQCDCount() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float AlphaQCD = 13;
getAlphaQCDList() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQCD = 13;
getAlphaQCDList() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float AlphaQCD = 13;
getAlphaQCDList() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float AlphaQCD = 13;
getAlphaQED() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QED = 11;
getAlphaQED() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float Alpha_QED = 11;
getAlphaQED() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float Alpha_QED = 11;
getAlphaQED() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QED = 11;
getAlphaQED() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float Alpha_QED = 11;
getAlphaQED() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float Alpha_QED = 11;
getAlphaQED(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQED = 11;
getAlphaQED(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float AlphaQED = 11;
getAlphaQED(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float AlphaQED = 11;
getAlphaQEDCount() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQED = 11;
getAlphaQEDCount() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float AlphaQED = 11;
getAlphaQEDCount() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float AlphaQED = 11;
getAlphaQEDList() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQED = 11;
getAlphaQEDList() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float AlphaQED = 11;
getAlphaQEDList() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float AlphaQED = 11;
getAmplitude() - Method in interface hep.lcio.event.RawCalorimeterHit
Returns the amplitude of the hit in ADC counts.
getAmplitude() - Method in class hep.lcio.implementation.event.IRawCalorimeterHit
 
getAmpSlices() - Method in class org.jlab.groot.fitter.ParallelSliceFitter
 
getAnchor() - Method in class org.jfree.chart.ChartPanel
Returns the anchor point.
getAnchor() - Method in class org.jfree.chart.plot.CrosshairState
Returns the anchor point.
getAnchor() - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Returns the text anchor point that will be aligned to the position specified by DialTextAnnotation.getAngle() and DialTextAnnotation.getRadius().
getAnchorValue() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the anchor value.
getAnchorX() - Method in class org.jfree.chart.plot.CrosshairState
Returns the x-coordinate (in data space) for the anchor point.
getAnchorY() - Method in class org.jfree.chart.plot.CrosshairState
Returns the y-coordinate (in data space) for the anchor point.
getAnd() - Method in class org.nfunk.jep.OperatorSet
 
getAngle() - Method in class jhplot.stat.EEcentricity
Returns angle of ellipse rotation (angle of the principial axis)
getAngle() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the angle of the rotation.
getAngle() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the angle of the rotation.
getAngle() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the angle of the line.
getAngle() - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Returns the angle of the arrow.
getAngle() - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Returns the angle of the arrow.
getAngle() - Method in class org.jfree.chart.axis.CategoryLabelPosition
Returns the angle of rotation for the label.
getAngle() - Method in class org.jfree.chart.axis.Tick
Returns the angle.
getAngle() - Method in class org.jfree.chart.labels.ItemLabelPosition
Returns the angle of rotation for the label.
getAngle() - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Returns the angle used to calculate the anchor point.
getAngle() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the angle for the anchor point.
getAngle() - Method in class org.jfree.chart.plot.PieLabelRecord
Returns the angle of the middle of the section, in radians.
getAngle() - Method in class org.jfree.chart.util.DefaultShadowGenerator
Returns the shadow offset angle (in radians).
getAngle() - Method in class org.jfree.data.xy.Vector
Returns the angle of the vector.
getAngleGridlinePaint() - Method in class org.jfree.chart.plot.PolarPlot
Returns the paint for the grid lines (if any) plotted against the angular axis.
getAngleGridlineStroke() - Method in class org.jfree.chart.plot.PolarPlot
Returns the stroke for the grid-lines (if any) plotted against the angular axis.
getAngleLabelFont() - Method in class org.jfree.chart.plot.PolarPlot
Returns the font used to display the angle labels.
getAngleLabelPaint() - Method in class org.jfree.chart.plot.PolarPlot
Returns the paint used to display the angle labels.
getAngleOffset() - Method in class org.jfree.chart.plot.PolarPlot
Returns the offset that is used for all angles.
getAngles(RotationOrder) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
getAngles(RotationOrder, RotationConvention) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the Cardan or Euler angles corresponding to the instance.
getAngles(RotationOrder) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Deprecated.
getAngles(RotationOrder, RotationConvention) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the Cardan or Euler angles corresponding to the instance.
getAngleTickUnit() - Method in class org.jfree.chart.plot.PolarPlot
Returns the tick unit that controls the spacing of the angular grid lines.
getAnnotation() - Method in class org.jfree.chart.event.AnnotationChangeEvent
Returns the annotation that triggered the event.
getAnnotations() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the list of annotations.
getAnnotations() - Method in class org.jfree.chart.plot.XYPlot
Returns the list of annotations.
getAnnotations() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns a collection of the annotations that are assigned to the renderer.
getAntiAlias() - Method in class jhplot.HChart
Get antialiasing for the graphics of the current plot
getAntiAlias() - Method in class jhplot.HPlot
Get antialiasing for the graphics of the current plot
getAntiAlias() - Method in class jplot.GraphSettings
get antialiasing
getAntiAlias() - Method in class org.jfree.chart.JFreeChart
Returns a flag that indicates whether or not anti-aliasing is used when the chart is drawn.
getAppendable() - Method in class org.apache.commons.io.output.AppendableOutputStream
Return the target appendable.
getAppendable() - Method in class org.apache.commons.io.output.AppendableWriter
Return the target appendable.
getAppletInfo() - Method in class org.lsmp.djepExamples.Console
 
getArea() - Method in class jplot3dp.ModelView.ModelFunction
 
getArea() - Method in class org.jfree.chart.entity.ChartEntity
Returns the area occupied by the entity (in Java 2D space).
getArgument() - Method in class org.apache.commons.math3.complex.Complex
Compute the argument of this complex number.
getArgument() - Method in exception org.apache.commons.math3.exception.MathIllegalNumberException
 
getArity() - Method in class org.apache.commons.math3.genetics.TournamentSelection
Gets the arity (number of chromosomes drawn to the tournament).
getArrangement() - Method in class org.jfree.chart.block.BlockContainer
Returns the arrangement (layout) manager for the container.
getArray() - Method in class graph.LoadData
 
getArray() - Method in class Jama.Matrix
Access the internal two-dimensional array.
getArray() - Method in class jhplot.math.kalman.jama.Matrix
Access the internal two-dimensional array.
getArray() - Method in class jhplot.P0D
Get a double array with P0D values.
getArray() - Method in class jhplot.P0I
Get a double array with P0I values.
getArray() - Method in class jhplot.PND
Get a double array with values.
getArray() - Method in class jhplot.PNI
Get a double array with values.
getArray() - Method in class jminhep.cluster.DataHolder
Get the data in form of Array
getArray() - Method in class org.jlab.groot.data.DataVector
 
getArrayCopy() - Method in class Jama.Matrix
Copy the internal two-dimensional array.
getArrayCopy() - Method in class jhplot.math.kalman.jama.Matrix
Copy the internal two-dimensional array.
getArrayDouble() - Method in class jhplot.P0I
Get a double array with P0I values.
getArrayErr() - Method in class jhplot.P1D
Get array representing (symmetric) error on Y.
getArrayIndex(int...) - Method in class org.jlab.groot.math.MultiIndex
Gets the needed size for 1D, 2D, and 3D arrays to be stored in a 1D array
getArrayInt() - Method in class jhplot.P0D
Get an integer array with P0D values.
getArrayInt() - Method in class jhplot.P0I
Get an integer array with P0I values.
getArrayList() - Method in class jhplot.P0D
Get data in form of ArrayList
getArrayList() - Method in class jhplot.P0I
Get data in form of ArrayList
getArrayList() - Method in class jhplot.PND
Get data in form of ArrayList
getArrayList() - Method in class jhplot.PNI
Get data in form of ArrayList
getArrayList() - Method in class jminhep.cluster.DataHolder
Get all elements of the data holder in form of an ArrayList
getArraySize() - Method in class org.jlab.groot.math.MultiIndex
Gets the size of the resulting 1D array from the dimension sizes
getArrayX() - Method in class jhplot.F1D
Get array of X-values after function after evaluation using the default number of points
getArrayX() - Method in class jhplot.P1D
Get array representing X-values
getArrayX() - Method in class jhplot.P2D
Get array representing X-values
getArrayX() - Method in class jhplot.P3D
Get array representing X-values
getArrayXleft() - Method in class jhplot.P1D
Get array representing X-left errors
getArrayXleftSys() - Method in class jhplot.P1D
Get array representing X-left 2nd level errors
getArrayXright() - Method in class jhplot.P1D
Get array representing X-right errors
getArrayXrightSys() - Method in class jhplot.P1D
Get array representing X-right 2nd level errors
getArrayY() - Method in class jhplot.F1D
Get array of Y-values after function after evaluation using the default number of points
getArrayY() - Method in class jhplot.P1D
Get array representing Y-values
getArrayY() - Method in class jhplot.P2D
Get array representing Y-values
getArrayY() - Method in class jhplot.P3D
Get array representing Y-values
getArrayYlower() - Method in class jhplot.P1D
Get array representing Y lower errors
getArrayYlowerSys() - Method in class jhplot.P1D
Get array representing Y lower 2nd level errors
getArrayYupper() - Method in class jhplot.P1D
Get array representing Y upper errors
getArrayYupperSys() - Method in class jhplot.P1D
Get array representing Y upper 2nd level errors
getArrayZ() - Method in class jhplot.P2D
Get array representing Z-values
getArrayZ() - Method in class jhplot.P3D
Get array representing Z-values
getArrowLength() - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Returns the arrow length.
getArrowLength() - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Returns the arrow length.
getArrowPaint() - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Returns the paint used for the arrow.
getArrowPaint() - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Returns the paint used for the arrow.
getArrowStroke() - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Returns the stroke used to draw the arrow line.
getArrowStroke() - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Returns the stroke used to draw the arrow line.
getArrowWidth() - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Returns the arrow width.
getArrowWidth() - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Returns the arrow width.
getArtifactPaint() - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Returns the paint used to color the median and average markers.
getArtifactPaint() - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Returns the paint used to paint the various artifacts such as outliers, farout symbol, median line and the averages ellipse.
getAscent(Graphics) - Method in class graph.TextLine
 
getAsDouble(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
getAsDouble(int, int) - Method in class org.jlab.groot.io.TextFileReader
 
getAsDouble(int[]) - Method in class org.jlab.groot.io.TextFileReader
Returns specified columns as array of double
getAsDoubleList(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
getAsInt(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
getAsInt(int, int) - Method in class org.jlab.groot.io.TextFileReader
returns array of ints for given range of columns.
getAsInt(int[]) - Method in class org.jlab.groot.io.TextFileReader
returns specified columns as array of ints
getAsIntList(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
getAssign() - Method in class org.nfunk.jep.OperatorSet
 
getAssignments() - Method in class jminhep.algorithms.FuzzyCMeansAlg
Returns cluster assignments of all points.
getAssociatedParticle() - Method in interface hep.lcio.event.Vertex
Returns Reconstructed Particle associated to the Vertex
getAssociatedParticle() - Method in class hep.lcio.implementation.event.IVertex
 
getAsString(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
getAsStringList(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
getAttResizable() - Method in class jplot.GraphSettings
is attribute resizable?
getAttribute(int) - Method in class jminhep.cluster.DataPoint
Returns the attribute of data point
getAttribute() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Get the attribute associated with the instance.
getAttributedLabel() - Method in class org.jfree.chart.axis.Axis
Returns the attributed label (the returned value is a copy, so modifying it will not impact the state of the axis).
getAttributedLabel() - Method in class org.jfree.chart.axis.LogTick
Returns the attributed string for the tick label, or null if there is no label.
getAttributedLabel(int) - Method in class org.jfree.chart.labels.StandardPieSectionLabelGenerator
Returns the attributed label for a section, or null if none is defined.
getAttributedLabel() - Method in class org.jfree.chart.LegendItem
Returns the attributed label.
getAttributes() - Method in class jhplot.utils.GHFontChooser
 
getAttributes() - Method in class jplot.LinePars
Get graphical attributes in form of a string
getAttributes() - Method in class org.jlab.groot.data.GraphErrors
 
getAttributes() - Method in class org.jlab.groot.data.H1F
 
getAttributes() - Method in class org.jlab.groot.data.H2F
 
getAttributes() - Method in interface org.jlab.groot.data.IDataSet
 
getAttributes() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getAttributes() - Method in class org.jlab.groot.math.Func1D
 
getAttributes() - Method in class org.jlab.groot.ui.GraphicsAxisFrame
 
getAuthor() - Static method in class jhplot.JHPlot
Get the author
getAutomaticTicks(int) - Method in class jplot.GraphSettings
Get or not automatic tick calculations
getAutoPopulateSectionOutlinePaint() - Method in class org.jfree.chart.plot.PiePlot
Returns the flag that controls whether or not the section outline paint is auto-populated by the PiePlot.lookupSectionOutlinePaint(Comparable) method.
getAutoPopulateSectionOutlineStroke() - Method in class org.jfree.chart.plot.PiePlot
Returns the flag that controls whether or not the section outline stroke is auto-populated by the PiePlot.lookupSectionOutlinePaint(Comparable) method.
getAutoPopulateSectionPaint() - Method in class org.jfree.chart.plot.PiePlot
Returns the flag that controls whether or not the section paint is auto-populated by the PiePlot.lookupSectionPaint(Comparable) method.
getAutoPopulateSeriesFillPaint() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the flag that controls whether or not the series fill paint list is automatically populated when AbstractRenderer.lookupSeriesFillPaint(int) is called.
getAutoPopulateSeriesOutlinePaint() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the flag that controls whether or not the series outline paint list is automatically populated when AbstractRenderer.lookupSeriesOutlinePaint(int) is called.
getAutoPopulateSeriesOutlineStroke() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the flag that controls whether or not the series outline stroke list is automatically populated when AbstractRenderer.lookupSeriesOutlineStroke(int) is called.
getAutoPopulateSeriesPaint() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the flag that controls whether or not the series paint list is automatically populated when AbstractRenderer.lookupSeriesPaint(int) is called.
getAutoPopulateSeriesShape() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the flag that controls whether or not the series shape list is automatically populated when AbstractRenderer.lookupSeriesShape(int) is called.
getAutoPopulateSeriesStroke() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the flag that controls whether or not the series stroke list is automatically populated when AbstractRenderer.lookupSeriesStroke(int) is called.
getAutoRangeIncludesZero() - Method in class org.jfree.chart.axis.NumberAxis
Returns the flag that indicates whether or not the automatic axis range (if indeed it is determined automatically) is forced to include zero.
getAutoRangeMinimumSize() - Method in class org.jfree.chart.axis.ValueAxis
Returns the minimum size allowed for the axis range when it is automatically calculated.
getAutoRangeNextLogFlag() - Method in class org.jfree.chart.axis.LogarithmicAxis
Returns the 'autoRangeNextLogFlag' flag.
getAutoRangeStickyZero() - Method in class org.jfree.chart.axis.NumberAxis
Returns a flag that affects the auto-range when zero falls outside the data range but inside the margins defined for the axis.
getAutoRangeTimePeriodClass() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the class used to create the first and last time periods for the axis range when the auto-range flag is set to true.
getAutoScaleXY() - Method in class jplot3d.SurfaceModelCanvas
 
getAutoSort() - Method in class org.jfree.data.ComparableObjectSeries
Returns the flag that controls whether the items in the series are automatically sorted.
getAutoSort() - Method in class org.jfree.data.xy.XYSeries
Returns the flag that controls whether the items in the series are automatically sorted.
getAutoWidthFactor() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns the factor by which the available space automatically calculated for the candles will be multiplied to determine the actual width to use.
getAutoWidthGap() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns the amount of space to leave on the left and right of each candle when automatically calculating widths.
getAutoWidthMethod() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns the method of automatically calculating the candle width.
getAv() - Method in class jhplot.stat.FactorialMoments
Return average multiplicity as a function of bin
getAvailableLocales() - Static method in class org.apache.commons.math3.complex.ComplexFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math3.fraction.FractionFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math3.geometry.VectorFormat
Get the set of locales for which point/vector formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the set of locales for which real vectors formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math3.linear.RealVectorFormat
Get the set of locales for which real vectors formats are available.
getAverageCLs() - Method in class jhplot.stat.ConfidenceLevel
Get average CLs.
getAverageCLsb() - Method in class jhplot.stat.ConfidenceLevel
Get average CLsb.
getAveragedOutlier() - Method in class org.jfree.chart.renderer.OutlierList
Returns the averaged outlier.
getAxesArrow() - Method in class jplot.GraphSettings
Returns the axis arrow type.
getAxesAtBottom() - Method in class org.jfree.chart.axis.AxisCollection
Returns a list of the axes (if any) that need to be drawn at the bottom of the plot area.
getAxesAtLeft() - Method in class org.jfree.chart.axis.AxisCollection
Returns a list of the axes (if any) that need to be drawn at the left of the plot area.
getAxesAtRight() - Method in class org.jfree.chart.axis.AxisCollection
Returns a list of the axes (if any) that need to be drawn at the right of the plot area.
getAxesAtTop() - Method in class org.jfree.chart.axis.AxisCollection
Returns a list of the axes (if any) that need to be drawn at the top of the plot area.
getAxesColor() - Method in class jhplot.HPlot
Returns the actual color of the axes of the graph.
getAxesColor() - Method in class jplot.GraphSettings
Returns the actual color of the axes of the graph.
getAxesFontColor() - Method in class jhplot.HPlot3D
Color for tic labels
getAxesFontColor() - Method in interface jplot3d.SurfaceModel
 
getAxesFontColor() - Method in class jplot3d.SurfaceModelCanvas
 
getAxesPanel() - Method in class jplot.JPlot
 
getAxesPenTicWidth() - Method in class jplot.GraphSettings
Returns the actual pen width of the tic axes of the graph.
getAxesRatio() - Method in class jhplot.HPlot
Returns the current ratio between X- and Y-axes lengths.
getAxesRatio() - Method in class jplot.GraphSettings
Returns the current ratio between X- and Y-axes lengths.
getAxesRatioUse() - Method in class jhplot.HPlot
Says whether we should use a fixed ratio between X- and Y-axes lengths.
getAxis() - Method in class jhplot.H1D
Get histogram Axis class.
getAxis(int) - Method in class jhplot.HChart
Get the axis
getAxis() - Method in class jhplot.HProf1D
Get histogram Axis class.
getAxis() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Deprecated.
getAxis(RotationConvention) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the normalized axis of the rotation.
getAxis() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Deprecated.
as of 3.6, replaced with Rotation.getAxis(RotationConvention)
getAxis(RotationConvention) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the normalized axis of the rotation.
getAxis() - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Returns the axis.
getAxis() - Method in class org.jfree.chart.entity.AxisEntity
Returns the axis that occupies the entity area.
getAxis() - Method in class org.jfree.chart.event.AxisChangeEvent
Returns the axis that generated the event.
getAxis() - Method in class org.jfree.chart.plot.PolarPlot
Returns the primary axis for the plot.
getAxis(int) - Method in class org.jfree.chart.plot.PolarPlot
Returns an axis for the plot.
getAxis() - Method in class org.jfree.chart.title.PaintScaleLegend
Returns the axis for the paint scale.
getAxis(int) - Method in interface org.jlab.groot.base.IAxisFrame
 
getAxis() - Method in class org.jlab.groot.data.H1F
Retrieves the x-axis as an Axis object
getAxis(int) - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
getAxis(int) - Method in class org.jlab.groot.ui.GraphicsAxisFrame
returns GraphicsAxis from the array with given index.
getAxisArrow() - Method in class jhplot.HPlot
Gets axis arrows.
getAxisAttributesX() - Static method in class org.jlab.groot.base.GStyle
 
getAxisAttributesY() - Static method in class org.jlab.groot.base.GStyle
 
getAxisAttributesZ() - Static method in class org.jlab.groot.base.GStyle
 
getAxisBounds(Graphics2D) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getAxisCount() - Method in class org.jfree.chart.plot.PolarPlot
Returns the number of domain axes.
getAxisDimension() - Method in class org.jlab.groot.base.AxisAttributes
 
getAxisDivisions() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getAxisDivisions() - Method in class org.jlab.groot.ui.GraphicsAxis
 
getAxisFont() - Method in class jhplot.HPlot3D
Get font for axes
getAxisFont() - Method in interface jplot3d.SurfaceModel
 
getAxisFont() - Method in class jplot3d.SurfaceModelCanvas
 
getAxisForDataset(int) - Method in class org.jfree.chart.plot.PolarPlot
Returns the axis for a dataset.
getAxisFrame() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getAxisIndex(ValueAxis) - Method in class org.jfree.chart.plot.PolarPlot
Returns the index of the given axis.
getAxisLabelGap() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the axis label gap.
getAxisLabelPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the axis label paint.
getAxisLabels() - Method in class org.jlab.groot.ui.GraphicsAxis
 
getAxisLabelsHeight(Graphics2D) - Method in class org.jlab.groot.ui.GraphicsAxisLabels
returns combined height of all axis labels.
getAxisLabelsWidth(Graphics2D) - Method in class org.jlab.groot.ui.GraphicsAxisLabels
returns combined width of all labels.
getAxisLinePaint() - Method in class org.jfree.chart.axis.Axis
Returns the paint used to draw the axis line.
getAxisLinePaint() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the paint used to draw the axis lines.
getAxisLineStroke() - Method in class org.jfree.chart.axis.Axis
Returns the stroke used to draw the axis line.
getAxisLineStroke() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the stroke used to draw the axis lines.
getAxisLocation() - Method in class org.jfree.chart.plot.PolarPlot
Returns the location of the primary axis.
getAxisLocation(int) - Method in class org.jfree.chart.plot.PolarPlot
Returns the location for an axis.
getAxisLocation() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the axis location.
getAxisLocation() - Method in class org.jfree.chart.title.PaintScaleLegend
Returns the axis location.
getAxisMaxHeight(Graphics2D) - Method in class org.jlab.groot.ui.GraphicsAxisLabels
 
getAxisMaximum() - Method in class org.jlab.groot.base.AxisAttributes
 
getAxisMaxWidth(Graphics2D) - Method in class org.jlab.groot.ui.GraphicsAxisLabels
 
getAxisMinimum() - Method in class org.jlab.groot.base.AxisAttributes
 
getAxisMinorTicks() - Method in class org.jlab.groot.ui.GraphicsAxis
 
getAxisNamesString() - Method in class org.jlab.groot.matrix.SparseVectorGrid
returns ":" separated list of axis names
getAxisOffset() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the axis offset.
getAxisOffset() - Method in class org.jfree.chart.plot.XYPlot
Returns the axis offset.
getAxisOffset() - Method in class org.jfree.chart.StandardChartTheme
Returns the axis offsets.
getAxisOffset() - Method in class org.jfree.chart.title.PaintScaleLegend
Returns the offset between the axis and the paint strip.
getAxisPenTicWidth() - Method in class jhplot.HPlot
Get the pen width to draw tick axes
getAxisPointX(double) - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
getAxisPointY(double) - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
getAxisPointZ(double) - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
getAxisPos() - Method in class graph.Axis
Return the position of the Axis.
getAxisPosition(double) - Method in class org.jlab.groot.graphics.GraphicsAxis
returns position along the axis, the dimension of the axis has to be set.
getAxisPosition(double) - Method in class org.jlab.groot.ui.GraphicsAxis
returns position along the axis, the dimension of the axis has to be set.
getAxisTexts() - Method in class org.jlab.groot.graphics.GraphicsAxis.GraphicsAxisTicks
 
getAxisTicks() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getAxisTicks() - Method in class org.jlab.groot.graphics.GraphicsAxis.GraphicsAxisTicks
 
getAxisTicks() - Method in class org.jlab.groot.ui.GraphicsAxis
 
getAxisTitleString() - Method in class org.jlab.groot.base.AxisAttributes
 
getAxisType() - Method in class org.jlab.groot.base.AxisAttributes
 
getAxisWidth(VectorGraphics) - Method in class graph.Axis
Return the width of the axis.
getAxisWidth(Graphics2D, int, int, int, int, double, double, Boolean) - Method in class org.jlab.groot.base.ColorPalette
 
getAxisX() - Method in class jhplot.H2D
Get IAxis in X
getAxisX() - Method in class jhplot.HChart
Get X-axis
getAxisX() - Method in class jhplot.HProf2D
Get IAxis in X
getAxisX() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getAxisX() - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
getAxisY() - Method in class jhplot.H2D
Get IAxis in Y
getAxisY() - Method in class jhplot.HChart
Get Y-axis
getAxisY() - Method in class jhplot.HProf2D
Get IAxis in Y
getAxisY() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getAxisY() - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
getAxisZ() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getAxisZ() - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
getB() - Method in class org.apache.commons.math3.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince54FieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince853FieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - Method in class org.apache.commons.math3.ode.nonstiff.EulerFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - Method in interface org.apache.commons.math3.ode.nonstiff.FieldButcherArrayProvider
Get the external weights for the high order method from Butcher array.
getB() - Method in class org.apache.commons.math3.ode.nonstiff.GillFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - Method in class org.apache.commons.math3.ode.nonstiff.HighamHall54FieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - Method in class org.apache.commons.math3.ode.nonstiff.LutherFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - Method in class org.apache.commons.math3.ode.nonstiff.MidpointFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - Method in class org.apache.commons.math3.ode.nonstiff.ThreeEighthesFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - Method in class org.jfree.data.function.PowerFunction2D
Returns the 'b' coefficient that was specified in the constructor.
getBack() - Method in class jhplot.stat.limit.ExpData
Get the expected background
getBackgColor() - Method in class jhplot.HPlot
Returns the actual background color of the entire graph panel.
getBackgColorGraph() - Method in class jhplot.HPlot
Returns the background color of the current graph.
getBackground() - Method in class graph.TextLine
 
getBackground() - Method in class jhplot.stat.DataSource
Get data for background
getBackground() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the background color (the default value is Color.BLACK).
getBackground() - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the background.
getBackgroundAlpha() - Method in class org.jfree.chart.plot.Plot
Returns the alpha transparency of the plot area background.
getBackgroundColor() - Method in class jplot.GraphSettings
Returns the actual background color of the entire graph panel.
getBackgroundColor() - Method in class jplot3d.ColorModelSet
 
getBackgroundColor() - Method in interface jplot3d.SurfaceColor
 
getBackgroundColor() - Method in class org.jlab.groot.base.PadAttributes
 
getBackgroundImage() - Method in class org.jfree.chart.JFreeChart
Returns the background image for the chart, or null if there is no image.
getBackgroundImage() - Method in class org.jfree.chart.plot.Plot
Returns the background image that is used to fill the plot's background area.
getBackgroundImageAlignment() - Method in class org.jfree.chart.JFreeChart
Returns the background image alignment.
getBackgroundImageAlignment() - Method in class org.jfree.chart.plot.Plot
Returns the background image alignment.
getBackgroundImageAlpha() - Method in class org.jfree.chart.JFreeChart
Returns the alpha-transparency for the chart's background image.
getBackgroundImageAlpha() - Method in class org.jfree.chart.plot.Plot
Returns the alpha transparency used to draw the background image.
getBackgroundPaint() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the background paint for the annotation.
getBackgroundPaint() - Method in class org.jfree.chart.JFreeChart
Returns the paint used for the chart background.
getBackgroundPaint() - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Returns the background paint (never null).
getBackgroundPaint() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the background paint.
getBackgroundPaint() - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Returns the background paint.
getBackgroundPaint() - Method in class org.jfree.chart.plot.MeterInterval
Returns the background paint.
getBackgroundPaint() - Method in class org.jfree.chart.plot.Plot
Returns the background color of the plot area.
getBackgroundPaint() - Method in class org.jfree.chart.title.CompositeTitle
Returns the background paint.
getBackgroundPaint() - Method in class org.jfree.chart.title.LegendTitle
Returns the background paint.
getBackgroundPaint() - Method in class org.jfree.chart.title.PaintScaleLegend
Returns the background paint.
getBackgroundPaint() - Method in class org.jfree.chart.title.TextTitle
Returns the background paint.
getBarAlignmentFactor() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the bar alignment factor.
getBarcode() - Method in class hephysics.particle.HEParticle
Get barcode
getBarcode(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
getBarcode(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated sint32 barcode = 12 [packed = true];
getBarcode(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 barcode = 12 [packed = true];
getBarcode(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
getBarcode(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 barcode = 12 [packed = true];
getBarcode(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 barcode = 12 [packed = true];
getBarcode(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
getBarcode(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 barcode = 12 [packed = true];
getBarcode(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 barcode = 12 [packed = true];
getBarcodeCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
getBarcodeCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated sint32 barcode = 12 [packed = true];
getBarcodeCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 barcode = 12 [packed = true];
getBarcodeCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
getBarcodeCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 barcode = 12 [packed = true];
getBarcodeCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 barcode = 12 [packed = true];
getBarcodeCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
getBarcodeCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 barcode = 12 [packed = true];
getBarcodeCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 barcode = 12 [packed = true];
getBarcodeList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
getBarcodeList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated sint32 barcode = 12 [packed = true];
getBarcodeList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 barcode = 12 [packed = true];
getBarcodeList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
getBarcodeList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 barcode = 12 [packed = true];
getBarcodeList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 barcode = 12 [packed = true];
getBarcodeList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
getBarcodeList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 barcode = 12 [packed = true];
getBarcodeList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 barcode = 12 [packed = true];
getBarPainter() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the bar painter.
getBarPainter() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the bar painter.
getBarPainter() - Method in class org.jfree.chart.StandardChartTheme
Returns the bar painter.
getBarWidth() - Method in class jplot.Contour
 
getBarWidth() - Method in class org.jfree.chart.renderer.category.CategoryItemRendererState
Returns the bar width.
getBarWidth() - Method in class org.jfree.data.xy.XYBarDataset
Returns the bar width.
getBarycenter() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Get the barycenter of the interval.
getBarycenter() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Get the barycenter of the instance.
getBarycenter() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Get the barycenter of the instance.
getBarycenter() - Method in class org.apache.commons.math3.geometry.spherical.oned.Arc
Get the barycenter of the arc.
getBase() - Method in class org.jfree.chart.axis.LogAxis
Returns the base for the logarithm calculation.
getBase() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the base value for the bars.
getBase() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the base value for the bars.
getBaseCreateEntities() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base visibility for all series.
getBaseFillPaint() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base (or default) fill paint.
getBaseFormatter() - Method in class org.jfree.chart.axis.LogAxis
Returns the formatter used to format the base value of the logarithmic scale when it is displayed numerically.
getBaseIndex() - Static method in class Jampack.Parameters
Returns the base index
getBaseItemLabelFont() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base item label font (this is used when no other font setting is available).
getBaseItemLabelFont() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base item label font (this is used when no other font setting is available).
getBaseItemLabelFont() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base item label font (this is used when no other font setting is available).
getBaseItemLabelGenerator() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the base item label generator.
getBaseItemLabelGenerator() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base item label generator.
getBaseItemLabelGenerator() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the base item label generator.
getBaseItemLabelGenerator() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base item label generator.
getBaseItemLabelPaint() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base item label paint.
getBaseItemLabelPaint() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base item label paint.
getBaseItemLabelPaint() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base item label paint.
getBaseItemLabelsVisible() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base setting for item label visibility.
getBaseItemLabelsVisible() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base setting for item label visibility.
getBaseItemLabelsVisible() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base setting for item label visibility.
getBaseItemURLGenerator() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the base item URL generator.
getBaseItemURLGenerator() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base item URL generator.
getBaseLegendShape() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the default legend shape, which may be null.
getBaseLegendTextFont() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the default legend text font, which may be null.
getBaseLegendTextPaint() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the default legend text paint, which may be null.
getBaselinePaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the baseline paint.
getBaseLinesVisible() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the base 'lines visible' attribute.
getBaseLinesVisible() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns the base 'lines visible' attribute.
getBaseMillis() - Method in class org.jfree.chart.util.RelativeDateFormat
Returns the base date/time used to calculate the elapsed time for display.
getBaseName(String) - Static method in class org.apache.commons.io.FilenameUtils
Gets the base name, minus the full path and extension, from a full fileName.
getBaseNegativeItemLabelPosition() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base item label position for negative values.
getBaseNegativeItemLabelPosition() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base item label position for negative values.
getBaseNegativeItemLabelPosition() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base item label position for negative values.
getBaseOutlinePaint() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base (or default) outline paint.
getBaseOutlinePaint() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base outline paint.
getBaseOutlinePaint() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base (or default) outline paint.
getBaseOutlineStroke() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base (or default) outline stroke.
getBaseOutlineStroke() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base outline stroke.
getBaseOutlineStroke() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base outline stroke.
getBasePaint() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base paint.
getBasePaint() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base paint.
getBasePaint() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base (or default) paint.
getBasePositiveItemLabelPosition() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base positive item label position.
getBasePositiveItemLabelPosition() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base positive item label position.
getBasePositiveItemLabelPosition() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base positive item label position.
getBaseRadius() - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Returns the base radius.
getBaseRadius() - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Returns the base radius.
getBaseRing() - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
Returns the base ring of this extension.
getBaseRing() - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
getBaseSectionOutlinePaint() - Method in class org.jfree.chart.plot.PiePlot
Returns the base section paint.
getBaseSectionOutlineStroke() - Method in class org.jfree.chart.plot.PiePlot
Returns the base section stroke.
getBaseSectionPaint() - Method in class org.jfree.chart.plot.PiePlot
Returns the base section paint.
getBaseSeriesOutlinePaint() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the base series paint.
getBaseSeriesOutlineStroke() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the base series stroke.
getBaseSeriesPaint() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the base series paint.
getBaseSeriesVisible() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base visibility for all series.
getBaseSeriesVisible() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base visibility for all series.
getBaseSeriesVisible() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base visibility for all series.
getBaseSeriesVisibleInLegend() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base visibility in the legend for all series.
getBaseSeriesVisibleInLegend() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base visibility in the legend for all series.
getBaseSeriesVisibleInLegend() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base visibility in the legend for all series.
getBaseShape() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base (or default) shape.
getBaseShape() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base shape.
getBaseShape() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base shape.
getBaseShapesFilled() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the base 'shape filled' attribute.
getBaseShapesFilled() - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Returns the base 'shape filled' attribute.
getBaseShapesFilled() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns the base 'shape filled' attribute.
getBaseShapesFilled() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns the base 'shape filled' attribute.
getBaseShapesVisible() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the base 'shape visible' attribute.
getBaseShapesVisible() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns true if shapes are being plotted by the renderer.
getBaseShapesVisible() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns the base 'shape visible' attribute.
getBaseStroke() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the base (or default) stroke.
getBaseStroke() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base stroke.
getBaseStroke() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base (or default) stroke.
getBaseSymbol() - Method in class org.jfree.chart.axis.LogAxis
Returns the symbol used to represent the base of the logarithmic scale for the axis.
getBaseTimeline() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns our baseTimeline, or null if none.
getBaseToolTipGenerator() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the base tool tip generator (the "layer 2" generator).
getBaseToolTipGenerator() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the base tool tip generator (the "layer 2" generator).
getBaseToolTipGenerator() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns the default tool tip generator.
getBaseToolTipGenerator() - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Returns the base tool tip generator.
getBaseToolTipGenerator() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the base tool tip generator.
getBaseToolTipGenerator() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the base tool tip generator.
getBaseY() - Method in class org.jfree.chart.plot.PieLabelRecord
Returns the base y-coordinate.
getBeanDescriptor() - Method in class net.java.dev.colorchooser.ColorChooserBeanInfo
Gets the bean's BeanDescriptors.
getBeginColumn() - Method in class jplot3dp.MathParser.SimpleCharStream
 
getBeginColumn() - Method in class org.nfunk.jep.JavaCharStream
 
getBeginLine() - Method in class jplot3dp.MathParser.SimpleCharStream
 
getBeginLine() - Method in class org.nfunk.jep.JavaCharStream
 
getBenchmarkString() - Method in class org.jlab.groot.fitter.FitterFunction
 
getBenchmarkString() - Method in class org.jlab.groot.graphics.EmbeddedCanvas
returns benchmark string containing number of repaint operations performed as well as the time it took to repaint.
getBeta() - Method in class jhplot.math.num.pdf.Beta
Access the beta parameter.
getBeta() - Method in class jhplot.math.num.pdf.Gamma
Access the beta parameter.
getBeta() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Access the second shape parameter, beta.
getBeta() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Deprecated.
as of version 3.1, GammaDistribution.getScale() should be preferred. This method will be removed in version 4.0.
getBigInteger() - Method in interface org.apache.commons.io.file.Counters.Counter
Gets the counter as a BigInteger.
getBin(double) - Method in class org.jlab.groot.math.Axis
Finds the specified value and returns which bin it is in in array indexing format (i.e.
getBin(int[]) - Method in class org.jlab.groot.matrix.SparseVectorGrid
returns a vector for a bin, if the entry does not exist a NULL will be returned.
getBinaryInverseOp() - Method in class org.lsmp.djep.xjep.XOperator
 
getBinCenter(int) - Method in class org.jlab.groot.math.Axis
Calculates and returns the median value of the bin number entered in the parameter in array indexing format (i.e.
getBinCenters() - Method in class org.jlab.groot.math.Axis
 
getBinContent(int) - Method in class org.jlab.groot.data.H1F
Returns the content of the specified bin as a double.
getBinContent(int, int) - Method in class org.jlab.groot.data.H2F
Finds the bin content at that bin
getBinContent(int, int[]) - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
getBinCount() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Returns the number of bins.
getBinding() - Method in class org.lsmp.djep.xjep.XOperator
When parsing how is x+y+z interpreted.
getBinError(int) - Method in class org.jlab.groot.data.H1F
Returns the error of the specified bin as a double.
getBinLowValue(int, int) - Method in class jhplot.utils.SHisto
Returns the lowest inclusive pixel value of a given bin for a specific band.
getBins() - Method in class jhplot.H1D
Get the number of bins
getBins() - Method in class jhplot.HProf1D
Get the number of bins
getBins() - Method in class jhplot.utils.SHisto
Returns the array of bands of bins, each bin is the histogram for a band, i.e., the format of the returned array is int[bands][bins].
getBins(int) - Method in class jhplot.utils.SHisto
Returns the bins of the histogram for a specific band by reference.
getBins() - Method in class org.jlab.groot.matrix.SparseIndexPane
 
getBins() - Method in class promc.io.PBufFile.Record.H1D.Builder
required int32 bins = 8;
getBins() - Method in class promc.io.PBufFile.Record.H1D
required int32 bins = 8;
getBins() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
required int32 bins = 8;
getBinsByAxis(double[], int[]) - Method in class org.jlab.groot.matrix.SparseVectorGrid
fills the array of indices with bin values taken from the axis.
getBinsFirstBand() - Method in class jhplot.utils.SHisto
Returns the bins of the first band.
getBinsFirstBand(int) - Method in class jhplot.utils.SHisto
Returns the bin content of the first band.
getBinSize() - Method in class jhplot.H1D
Get bin width in case of fixed-size bins.
getBinSize(int) - Method in class jhplot.H1D
Get bin width for index i
getBinSize() - Method in class jhplot.HProf1D
Get bin width in case of fixed-size bins.
getBinSize(int, int) - Method in class jhplot.utils.SHisto
Returns the number of pixel samples found in a given bin for a specific band.
getBinsMax() - Method in class org.jlab.groot.matrix.SparseIndexPane
 
getBinsMin() - Method in class org.jlab.groot.matrix.SparseIndexPane
 
getBinsPerAxis() - Method in class org.jlab.groot.matrix.SparseIndex
 
getBinsPerAxisCopy() - Method in class org.jlab.groot.matrix.SparseIndex
 
getBinStats() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Returns a List of SummaryStatistics instances containing statistics describing the values in each of the bins.
getBinSuggestion() - Method in class org.jlab.groot.data.DataVector
 
getBinsX() - Method in class jhplot.H2D
Get the number of bins in X
getBinsX() - Method in class jhplot.HProf2D
Get the number of bins in X
getBinsY() - Method in class jhplot.H2D
Get the number of bins in Y
getBinsY() - Method in class jhplot.HProf2D
Get the number of bins in Y
getBinWidth() - Method in class jhplot.DrawOptions
get the bin width.
getBinWidth() - Method in class org.jfree.data.statistics.HistogramBin
Returns the bin width.
getBinWidth(int) - Method in class org.jlab.groot.data.DataVector
 
getBinWidth(int) - Method in class org.jlab.groot.math.Axis
Calculates and returns the width of the bin specified in the parameter in array indexing format (i.e.
getBits() - Method in class root.FakeTKey
 
getBitsPerAxis() - Method in class org.jlab.groot.matrix.SparseIndex
 
getBjets() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.BLJets bjets = 5;
getBjets() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.BLJets bjets = 5;
getBjets() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.BLJets bjets = 5;
getBjetsBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.BLJets bjets = 5;
getBjetsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.BLJets bjets = 5;
getBjetsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.BLJets bjets = 5;
getBjetsOrBuilder() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.BLJets bjets = 5;
getBlockAnchor() - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Returns the anchor point used to align a block at its (x, y) location.
getBlockHeight() - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Returns the block height, in data/axis units.
getBlocks() - Method in class org.jfree.chart.block.BlockContainer
Returns an unmodifiable list of the Block objects managed by this arrangement.
getBlockWidth() - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Returns the block width, in data/axis units.
getBOM() - Method in class org.apache.commons.io.input.BOMInputStream
Return the BOM (Byte Order Mark).
getBOMCharsetName() - Method in class org.apache.commons.io.input.BOMInputStream
Return the BOM charset Name - ByteOrderMark.getCharsetName().
getBomEncoding() - Method in exception org.apache.commons.io.input.XmlStreamReaderException
Returns the BOM encoding found in the InputStream.
getBool(String) - Method in class fitter.SEditor
 
getBoolean(String, boolean) - Method in class jplot.XMLRead
Returns the value of a boolean element (true/false).
getBooleanProperty(String) - Method in class hep.lcio.util.SIODump.Resolver
 
getBorder() - Method in class org.jfree.chart.block.AbstractBlock
Deprecated.
getBorderPaint() - Method in class org.jfree.chart.JFreeChart
Returns the paint used to draw the chart border (if visible).
getBorderStroke() - Method in class org.jfree.chart.JFreeChart
Returns the stroke used to draw the chart border (if visible).
getBottom() - Method in class org.jfree.chart.axis.AxisSpace
Returns the space reserved for axes at the bottom of the plot area.
getBottomEdge(VectorGraphics) - Method in class graph.RTextLine
Return the bottom edge of the rotated text.
getBottomEdge(VectorGraphics, int) - Method in class graph.RTextLine
Return the bottom edge of the rotated text.
getBottomMargin() - Method in class jplot.GraphSettings
Returns the distance between the bottom-border of the panel and the bottom X-axis.
getBottomMargin() - Method in class org.jlab.groot.base.PadMargins
 
getBoundaryLoops() - Method in class org.apache.commons.math3.geometry.spherical.twod.SphericalPolygonsSet
Get the boundary loops of the polygon.
getBoundarySize() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Get the size of the boundary.
getBoundarySize() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Get the size of the boundary.
getBoundIsAllowed() - Method in exception org.apache.commons.math3.exception.NumberIsTooLargeException
 
getBoundIsAllowed() - Method in exception org.apache.commons.math3.exception.NumberIsTooSmallException
 
getBounds() - Method in class org.jfree.chart.block.AbstractBlock
Returns the current bounds of the block.
getBounds() - Method in interface org.jfree.chart.block.Block
Returns the current bounds of the block.
getBounds(Graphics2D) - Method in class org.jlab.groot.ui.LatexText
 
getBounds(FontMetrics, Graphics2D) - Method in class org.jlab.groot.ui.LatexText
 
getBounds() - Method in class org.jlab.groot.ui.PaveText
 
getBoundsNumber(Graphics2D) - Method in class org.jlab.groot.ui.LatexText
 
getBoxColor() - Method in class jhplot.HPlot
Returns the color used to draw the bounding box.
getBoxColor() - Method in class jplot.GraphSettings
Returns the color used to draw the bounding box.
getBoxColor() - Method in class jplot3d.ColorModelSet
 
getBoxColor() - Method in interface jplot3d.SurfaceColor
 
getBoxFillColor() - Method in class jhplot.HPlot
Returns the fill-color of the eventual bounding box arround the graph
getBoxFillColor() - Method in class jplot.GraphSettings
Returns the fill-color of the eventual bounding box arround the graph
getBoxOffset() - Method in class jhplot.HPlot
Returns the offset of the bounding box.
getBoxOffset() - Method in class jplot.GraphSettings
Returns the offset of the bounding box.
getBoxPaint() - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Returns the paint used to fill boxes.
getBoxWidth() - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Returns the width of each box.
getBP(int) - Method in class jhplot.stat.BunchingParameters
Return results: BP as a function of number of bins.
getBracketingStep() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.BracketingStep
Deprecated.
Gets the initial step.
getBranch(String) - Method in interface org.jlab.groot.tree.ITree
 
getBranch(String) - Method in class org.jlab.groot.tree.Tree
 
getBranchData() - Method in class org.jlab.groot.tree.Tree
returns a float array containing branch data.
getBranches() - Method in class org.jlab.groot.tree.Tree
 
getBranches() - Method in class org.jlab.groot.tree.TreeCut
 
getBtag(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Btag = 5 [packed = true];
getBtag(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 Btag = 5 [packed = true];
getBtag(int) - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 Btag = 5 [packed = true];
getBtag(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Btag = 5 [packed = true];
getBtag(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 Btag = 5 [packed = true];
getBtag(int) - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 Btag = 5 [packed = true];
getBtag(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Btag = 5 [packed = true];
getBtag(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 Btag = 5 [packed = true];
getBtag(int) - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 Btag = 5 [packed = true];
getBtagCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Btag = 5 [packed = true];
getBtagCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 Btag = 5 [packed = true];
getBtagCount() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 Btag = 5 [packed = true];
getBtagCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Btag = 5 [packed = true];
getBtagCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 Btag = 5 [packed = true];
getBtagCount() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 Btag = 5 [packed = true];
getBtagCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Btag = 5 [packed = true];
getBtagCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 Btag = 5 [packed = true];
getBtagCount() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 Btag = 5 [packed = true];
getBtagList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Btag = 5 [packed = true];
getBtagList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 Btag = 5 [packed = true];
getBtagList() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 Btag = 5 [packed = true];
getBtagList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Btag = 5 [packed = true];
getBtagList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 Btag = 5 [packed = true];
getBtagList() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 Btag = 5 [packed = true];
getBtagList() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Btag = 5 [packed = true];
getBtagList() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 Btag = 5 [packed = true];
getBtagList() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 Btag = 5 [packed = true];
getBufferSize() - Method in class jhplot.io.HFile
Get current buffer size for I/O.
getBufferSize() - Method in class jhplot.io.HFileXML
Get current buffer size for I/O.
getBuilder() - Method in class org.apache.commons.io.output.StringBuilderWriter
Returns the underlying builder.
getBuildTime() - Static method in class cern.colt.Version
Returns the time this release was build; for example "Tue Apr 11 11:50:39 CEST 2000".
getBuildTime() - Static method in class jhplot.JHPlot
Get build date
getBuildVersion() - Static method in class cern.colt.Version
Returns the build version of this release.
getBuilt() - Method in class graph.BuildGraph
Get a vector of all the built Classes.
getBuiltinFunction(String) - Static method in class jhplot.math.exp4j.function.Functions
Get the builtin function for a given name
getBuiltinOperator(char, int) - Static method in class jhplot.math.exp4j.operator.Operators
 
getBulbDiameter() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the bulb diameter, which is always twice the value returned by ThermometerPlot.getBulbRadius().
getBulbRadius() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the bulb radius, in Java2D units.
getBundle(String) - Static method in class org.jfree.chart.util.ResourceBundleWrapper
Finds and returns the specified resource bundle.
getBundle(String, Locale) - Static method in class org.jfree.chart.util.ResourceBundleWrapper
Finds and returns the specified resource bundle.
getBundle(String, Locale, ClassLoader) - Static method in class org.jfree.chart.util.ResourceBundleWrapper
Maps directly to ResourceBundle.getBundle(baseName, locale, loader).
getByteCount() - Method in class org.apache.commons.io.input.CountingInputStream
The number of bytes that have passed through this stream.
getByteCount() - Method in class org.apache.commons.io.output.CountingOutputStream
The number of bytes that have passed through this stream.
getByteCount() - Method in class org.apache.commons.io.output.ThresholdingOutputStream
Returns the number of bytes that have been written to this output stream.
getByteCounter() - Method in interface org.apache.commons.io.file.Counters.PathCounters
Gets the byte counter.
getByteProperty(String) - Method in class hep.lcio.util.SIODump.Resolver
 
getBytes() - Method in class org.apache.commons.io.ByteOrderMark
Return a copy of the BOM's bytes.
getC() - Method in class org.apache.commons.math3.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince54FieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince853FieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - Method in class org.apache.commons.math3.ode.nonstiff.EulerFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - Method in interface org.apache.commons.math3.ode.nonstiff.FieldButcherArrayProvider
Get the time steps from Butcher array (without the first zero).
getC() - Method in class org.apache.commons.math3.ode.nonstiff.GillFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - Method in class org.apache.commons.math3.ode.nonstiff.HighamHall54FieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - Method in class org.apache.commons.math3.ode.nonstiff.LutherFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - Method in class org.apache.commons.math3.ode.nonstiff.MidpointFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - Method in class org.apache.commons.math3.ode.nonstiff.ThreeEighthesFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getCalcDivisions() - Method in interface jplot3d.SurfaceModel
 
getCalcDivisions() - Method in class jplot3d.SurfaceModelCanvas
 
getCalendarField() - Method in class org.jfree.chart.axis.DateTickUnit
Returns a field code that can be used with the Calendar class.
getCalendarField() - Method in class org.jfree.chart.axis.DateTickUnitType
Returns the calendar field.
getCalorimeterHits() - Method in interface hep.lcio.event.Cluster
The hits that have been combined to this cluster.
getCalorimeterHits() - Method in class hep.lcio.implementation.event.ICluster
 
getCameraPosition() - Method in class jhplot.HPlot3DP
Get camera position.
getCameraPosition() - Method in class jplot3dp.ModelView
 
getCan() - Method in class org.jlab.groot.base.AxisAttributes
 
getCandidates() - Method in class jhplot.stat.DataSource
Get data with candidates
getCandleWidth() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns the width of each candle.
getCanvas(String, int, int, int, int) - Static method in class jhplot.SHPlot
Create HPlot canvas with several plots.
getCanvas(String, int, int) - Static method in class jhplot.SHPlot
Construct a HPlot canvas with a single plot.
getCanvas(String) - Static method in class jhplot.SHPlot
Construct a HPlot canvas with a plot with the default size 600x400.
getCanvas() - Static method in class jhplot.SHPlot
Construct a HPlot canvas with a plot with the default size 600x400.
getCanvas(String, int, int, int, int) - Static method in class jhplot.SHPlot3D
Create HPlot3D canvas with several plots.
getCanvas(String, int, int) - Static method in class jhplot.SHPlot3D
Construct a HPlot3D canvas with a single plot.
getCanvas(String) - Static method in class jhplot.SHPlot3D
Construct a HPlot3D canvas with a plot with the default size 600x400.
getCanvas() - Static method in class jhplot.SHPlot3D
Construct a HPlot3D canvas with a plot with the default size 600x400.
getCanvas() - Method in class org.jlab.groot.graphics.EmbeddedCanvasTabbed
 
getCanvas(String) - Method in class org.jlab.groot.graphics.EmbeddedCanvasTabbed
 
getCanvas() - Method in class org.jlab.groot.ui.TCanvas
 
getCanvasPads() - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
getCanvasPanel() - Method in class jhplot.gui.GHPanel
get JPanel for the main panel which keeps the central panel and all 4 margins
getCap() - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the cap.
getCapacity() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Gets the currently allocated size of the internal data structure used for storing elements.
getCapLength() - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Returns the length (in Java2D units) of the cap at the end of the error bars.
getCartesian() - Method in class org.apache.commons.math3.geometry.euclidean.threed.SphericalCoordinates
Get the Cartesian coordinates.
getCartesianArray() - Method in class hep.physics.vec.SpacePoint
 
getCartesianArray() - Method in class hephysics.vec.SpacePoint
 
getCategories() - Method in class org.jfree.chart.plot.CategoryPlot
Returns a list of the categories in the plot's primary dataset.
getCategories() - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Returns an unmodifiable list of the categories contained in all the subplots.
getCategories() - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
getCategoriesForAxis(CategoryAxis) - Method in class org.jfree.chart.plot.CategoryPlot
Returns a list of the categories that should be displayed for the specified axis.
getCategoriesForAxis(CategoryAxis) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Overridden to return the categories in the subplots.
getCategory() - Method in class org.jfree.chart.annotations.CategoryTextAnnotation
Returns the category.
getCategory() - Method in class org.jfree.chart.axis.CategoryTick
Returns the category.
getCategory() - Method in class org.jfree.chart.entity.CategoryItemEntity
Deprecated.
The return type for this method should be Comparable, so it has been deprecated as of version 1.0.6 and replaced by CategoryItemEntity.getColumnKey().
getCategory1() - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Returns the category for the start of the line.
getCategory2() - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Returns the category for the end of the line.
getCategoryAnchor() - Method in class org.jfree.chart.annotations.CategoryTextAnnotation
Returns the category anchor point.
getCategoryAnchor() - Method in class org.jfree.chart.axis.CategoryLabelPosition
Returns the item label anchor.
getCategoryCount() - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the number of categories in the dataset.
getCategoryEnd(int, int, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.CategoryAxis
Returns the end coordinate for the specified category.
getCategoryIndex() - Method in class org.jfree.chart.entity.CategoryItemEntity
Deprecated.
As of 1.0.6, you can derive this information from the CategoryItemEntity.getColumnKey() method.
getCategoryIndex(Comparable) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the index for the given category.
getCategoryJava2DCoordinate(CategoryAnchor, int, int, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.CategoryAxis
Returns the Java 2D coordinate for a category.
getCategoryJava2DCoordinate(CategoryAnchor, int, int, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.CategoryAxis3D
Returns the Java 2D coordinate for a category.
getCategoryLabelPositionOffset() - Method in class org.jfree.chart.axis.CategoryAxis
Returns the offset between the axis and the category labels (before label positioning is taken into account).
getCategoryLabelPositions() - Method in class org.jfree.chart.axis.CategoryAxis
Returns the category label position specification (this contains label positioning info for all four possible axis locations).
getCategoryLabelToolTip(Comparable) - Method in class org.jfree.chart.axis.CategoryAxis
Returns the tool tip text for the label belonging to the specified category.
getCategoryLabelURL(Comparable) - Method in class org.jfree.chart.axis.CategoryAxis
Returns the URL for the label belonging to the specified category.
getCategoryMargin() - Method in class org.jfree.chart.axis.CategoryAxis
Returns the category margin.
getCategoryMiddle(int, int, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.CategoryAxis
Returns the middle coordinate for the specified category.
getCategoryMiddle(Comparable, List, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.CategoryAxis
A convenience method that returns the axis coordinate for the centre of a category.
getCategoryPlot() - Method in class org.jfree.chart.JFreeChart
Returns the plot cast as a CategoryPlot.
getCategorySeriesMiddle(Comparable, Comparable, CategoryDataset, double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.CategoryAxis
Returns the middle coordinate (in Java2D space) for a series within a category.
getCategorySeriesMiddle(int, int, int, int, double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.CategoryAxis
Returns the middle coordinate (in Java2D space) for a series within a category.
getCategoryStart(int, int, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.CategoryAxis
Returns the starting coordinate for the specified category.
getCause(int) - Method in exception org.apache.commons.io.IOExceptionList
Gets the cause exception at the given index.
getCause(int, Class<T>) - Method in exception org.apache.commons.io.IOExceptionList
Gets the cause exception at the given index.
getCause() - Method in exception org.apache.commons.io.TaggedIOException
Returns the wrapped exception.
getCauseList() - Method in exception org.apache.commons.io.IOExceptionList
Gets the cause list.
getCauseList(Class<T>) - Method in exception org.apache.commons.io.IOExceptionList
Works around Throwable and Generics, may fail at runtime depending on the argument value.
getCdX() - Method in class jhplot.gui.GHFrame
Get location of the graph in the main canvas in X
getCdY() - Method in class jhplot.gui.GHFrame
Get location of the graph on the main canvas in Y
getCeilingTickUnit(TickUnit) - Method in class org.jfree.chart.axis.NumberTickUnitSource
 
getCeilingTickUnit(double) - Method in class org.jfree.chart.axis.NumberTickUnitSource
 
getCeilingTickUnit(TickUnit) - Method in class org.jfree.chart.axis.StandardTickUnitSource
Returns the tick unit in the collection that is greater than or equal to (in size) the specified unit.
getCeilingTickUnit(double) - Method in class org.jfree.chart.axis.StandardTickUnitSource
Returns the tick unit in the collection that is greater than or equal to the specified size.
getCeilingTickUnit(TickUnit) - Method in class org.jfree.chart.axis.TickUnits
Returns the tick unit in the collection that is greater than or equal to (in size) the specified unit.
getCeilingTickUnit(double) - Method in class org.jfree.chart.axis.TickUnits
Returns the tick unit in the collection that is greater than or equal to the specified size.
getCeilingTickUnit(TickUnit) - Method in interface org.jfree.chart.axis.TickUnitSource
Returns the tick unit in the collection that is greater than or equal to (in size) the specified unit.
getCeilingTickUnit(double) - Method in interface org.jfree.chart.axis.TickUnitSource
Returns the smallest tick unit available in the source that is greater than or equal to the specified size.
getCell(Vector<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Deprecated.
as of 3.3, replaced with BSPTree.getCell(Point, double)
getCell(Point<S>, double) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Get the cell to which a point belongs.
getCellEditorValue() - Method in class jplot.panels.PanelPlot.ButtonEditor
 
getCellID() - Method in interface hep.lcio.event.SimTrackerHit
DEPRECATED: use @getCellID0()
getCellID() - Method in interface hep.lcio.event.TPCHit
Deprecated.
Returns the detector specific cell id.
getCellID() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
getCellID() - Method in class hep.lcio.implementation.event.ITPCHit
 
getCellID0() - Method in interface hep.lcio.event.CalorimeterHit
Returns the detector specific (geometrical) cell id.
getCellID0() - Method in interface hep.lcio.event.RawCalorimeterHit
Returns the detector specific (geometrical) cell id.
getCellID0() - Method in interface hep.lcio.event.SimCalorimeterHit
Returns the detector specific (geometrical) cell id.
getCellID0() - Method in interface hep.lcio.event.SimTrackerHit
Same name as in CalorimeterHit, even though there are no 'cells' in this case
getCellID0() - Method in interface hep.lcio.event.TrackerData
Returns the first detector specific (geometrical) cell id.
getCellID0() - Method in interface hep.lcio.event.TrackerHit
Same name as in CalorimeterHit, even though there are no 'cells' in this case
getCellID0() - Method in interface hep.lcio.event.TrackerHitPlane
Same name as in CalorimeterHit, even though there are no 'cells' in this case
getCellID0() - Method in interface hep.lcio.event.TrackerHitZCylinder
Same name as in CalorimeterHit, even though there are no 'cells' in this case
getCellID0() - Method in interface hep.lcio.event.TrackerPulse
Returns the first detector specific (geometrical) cell id.
getCellID0() - Method in interface hep.lcio.event.TrackerRawData
Returns the first detector specific (geometrical) cell id.
getCellID0() - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
getCellID0() - Method in class hep.lcio.implementation.event.IRawCalorimeterHit
 
getCellID0() - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
getCellID0() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
getCellID0() - Method in class hep.lcio.implementation.event.ITrackerData
 
getCellID0() - Method in class hep.lcio.implementation.event.ITrackerHit
 
getCellID0() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getCellID0() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getCellID0() - Method in class hep.lcio.implementation.event.ITrackerPulse
 
getCellID0() - Method in class hep.lcio.implementation.event.ITrackerRawData
 
getCellID1() - Method in interface hep.lcio.event.CalorimeterHit
Returns the second detector specific (geometrical) cell id.
getCellID1() - Method in interface hep.lcio.event.RawCalorimeterHit
Returns the second detector specific (geometrical) cell id.
getCellID1() - Method in interface hep.lcio.event.SimCalorimeterHit
Returns the second detector specific (geometrical) cell id.
getCellID1() - Method in interface hep.lcio.event.SimTrackerHit
Same name as in CalorimeterHit, even though there are no 'cells' in this case Optional, check/set flag(LCIO::THBIT_ID1)==1.
getCellID1() - Method in interface hep.lcio.event.TrackerData
Returns the second detector specific (geometrical) cell id.
getCellID1() - Method in interface hep.lcio.event.TrackerHit
Same name as in CalorimeterHit, even though there are no 'cells' in this case Optional, check/set flag(LCIO::RTHBIT_ID1)==1.
getCellID1() - Method in interface hep.lcio.event.TrackerHitPlane
Same name as in CalorimeterHit, even though there are no 'cells' in this case Optional, check/set flag(LCIO::RTHPBIT_ID1)==1.
getCellID1() - Method in interface hep.lcio.event.TrackerHitZCylinder
Same name as in CalorimeterHit, even though there are no 'cells' in this case Optional, check/set flag(LCIO::RTHZBIT_ID1)==1.
getCellID1() - Method in interface hep.lcio.event.TrackerPulse
Returns the second detector specific (geometrical) cell id.
getCellID1() - Method in interface hep.lcio.event.TrackerRawData
Returns the second detector specific (geometrical) cell id.
getCellID1() - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
getCellID1() - Method in class hep.lcio.implementation.event.IRawCalorimeterHit
 
getCellID1() - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
getCellID1() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
getCellID1() - Method in class hep.lcio.implementation.event.ITrackerData
 
getCellID1() - Method in class hep.lcio.implementation.event.ITrackerHit
 
getCellID1() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getCellID1() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getCellID1() - Method in class hep.lcio.implementation.event.ITrackerPulse
 
getCellID1() - Method in class hep.lcio.implementation.event.ITrackerRawData
 
getCenter() - Method in interface hep.lcio.event.TrackerHitZCylinder
Center of cylinder in RPhi-plane - given as (x,y).
getCenter() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getCenter() - Method in class org.apache.commons.math3.geometry.enclosing.EnclosingBall
Get the center of the ball.
getCenter() - Method in class org.apache.commons.math3.ml.clustering.CentroidCluster
Get the point chosen to be the center of this cluster.
getCenter() - Method in class org.apache.commons.math3.stat.clustering.Cluster
Deprecated.
Get the point chosen to be the center of this cluster.
getCenters(int) - Method in class jhplot.stat.StatShape
Get the centers in non-quadrant method.
getCenters() - Method in class jminhep.algorithms.FuzzyCMeansAlg
Returns cluster centers
getCenters() - Method in class jminhep.algorithms.HierarchicalAlg
Returns cluster centers
getCenters() - Method in class jminhep.algorithms.KMeansAlg
Returns cluster centers
getCenters() - Method in class jminhep.algorithms.KMeansExchangeAlg
Returns cluster centers
getCenters() - Method in class jminhep.cluster.Partition
Get cluster centers
getCenters() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of the centers array.
getCenterText() - Method in class org.jfree.chart.plot.RingPlot
Returns the text to display in the center of the plot when the mode is CenterTextMode.FIXED.
getCenterTextColor() - Method in class org.jfree.chart.plot.RingPlot
Returns the color for the center text.
getCenterTextFont() - Method in class org.jfree.chart.plot.RingPlot
Returns the font used to display the center text.
getCenterTextFormatter() - Method in class org.jfree.chart.plot.RingPlot
Returns the formatter used to format the center text value for the mode CenterTextMode.VALUE.
getCenterTextMode() - Method in class org.jfree.chart.plot.RingPlot
Returns the mode for displaying text in the center of the plot.
getCentralValue() - Method in class org.jfree.data.Range
Returns the central value for the range.
getCharge() - Method in interface hep.lcio.event.MCParticle
Returns the particle's charge.
getCharge() - Method in interface hep.lcio.event.ReconstructedParticle
Charge of the reconstructed particle.
getCharge() - Method in interface hep.lcio.event.TPCHit
Deprecated.
Returns the integrated charge of the hit.
getCharge() - Method in interface hep.lcio.event.TrackerPulse
The integrated charge of the pulse - arbitrary units.
getCharge() - Method in class hep.lcio.implementation.event.IMCParticle
 
getCharge() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getCharge() - Method in class hep.lcio.implementation.event.ITPCHit
 
getCharge() - Method in class hep.lcio.implementation.event.ITrackerPulse
 
getCharge() - Method in class hep.physics.particle.BasicParticle
 
getCharge() - Method in interface hep.physics.particle.Particle
Returns the particle's charge
getCharge() - Method in interface hep.physics.particle.properties.ParticleType
The charge of the particle
getCharge() - Method in class hephysics.particle.LParticle
Get charge
getCharge(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
getCharge(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated sint32 charge = 18 [packed = true];
getCharge(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 charge = 18 [packed = true];
getCharge() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
getCharge() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional sint32 charge = 6;
getCharge() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional sint32 charge = 6;
getCharge(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
getCharge(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 charge = 18 [packed = true];
getCharge(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 charge = 18 [packed = true];
getCharge() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
getCharge() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional sint32 charge = 6;
getCharge() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional sint32 charge = 6;
getCharge() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
getCharge() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional sint32 charge = 6;
getCharge() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional sint32 charge = 6;
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Charge = 7 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 Charge = 7 [packed = true];
getCharge(int) - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 Charge = 7 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint32 Charge = 4 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated sint32 Charge = 4 [packed = true];
getCharge(int) - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated sint32 Charge = 4 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Charge = 7 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 Charge = 7 [packed = true];
getCharge(int) - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 Charge = 7 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Charge = 7 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 Charge = 7 [packed = true];
getCharge(int) - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 Charge = 7 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint32 Charge = 4 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated sint32 Charge = 4 [packed = true];
getCharge(int) - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated sint32 Charge = 4 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 charge = 18 [packed = true];
getCharge(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 charge = 18 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Charge = 4 [packed = true];
getCharge(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 Charge = 4 [packed = true];
getCharge(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 Charge = 4 [packed = true];
getCharge() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
getCharge() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional sint32 charge = 6;
getCharge() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional sint32 charge = 6;
getChargeCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
getChargeCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated sint32 charge = 18 [packed = true];
getChargeCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 charge = 18 [packed = true];
getChargeCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
getChargeCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 charge = 18 [packed = true];
getChargeCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 charge = 18 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Charge = 7 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 Charge = 7 [packed = true];
getChargeCount() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 Charge = 7 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint32 Charge = 4 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated sint32 Charge = 4 [packed = true];
getChargeCount() - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated sint32 Charge = 4 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Charge = 7 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 Charge = 7 [packed = true];
getChargeCount() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 Charge = 7 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Charge = 7 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 Charge = 7 [packed = true];
getChargeCount() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 Charge = 7 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint32 Charge = 4 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated sint32 Charge = 4 [packed = true];
getChargeCount() - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated sint32 Charge = 4 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 charge = 18 [packed = true];
getChargeCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 charge = 18 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Charge = 4 [packed = true];
getChargeCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 Charge = 4 [packed = true];
getChargeCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 Charge = 4 [packed = true];
getChargeList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
getChargeList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated sint32 charge = 18 [packed = true];
getChargeList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 charge = 18 [packed = true];
getChargeList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
getChargeList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 charge = 18 [packed = true];
getChargeList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 charge = 18 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Charge = 7 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 Charge = 7 [packed = true];
getChargeList() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 Charge = 7 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint32 Charge = 4 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated sint32 Charge = 4 [packed = true];
getChargeList() - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated sint32 Charge = 4 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Charge = 7 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 Charge = 7 [packed = true];
getChargeList() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 Charge = 7 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Charge = 7 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 Charge = 7 [packed = true];
getChargeList() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 Charge = 7 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint32 Charge = 4 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated sint32 Charge = 4 [packed = true];
getChargeList() - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated sint32 Charge = 4 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 charge = 18 [packed = true];
getChargeList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 charge = 18 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Charge = 4 [packed = true];
getChargeList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 Charge = 4 [packed = true];
getChargeList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 Charge = 4 [packed = true];
getChargeParity() - Method in class hephysics.particle.HEParticle
Returns C charge conjugation parity
getChargeValues() - Method in interface hep.lcio.event.TrackerData
The corrected (calibrated) FADC spectrum.
getChargeValues() - Method in class hep.lcio.implementation.event.ITrackerData
 
getCharIterator() - Method in class jplot.GraphLabel
Returns an attributedCharacterIterator instance of the current text.
getCharsetName() - Method in class org.apache.commons.io.ByteOrderMark
Return the name of the Charset the BOM represents.
getChart() - Method in class jhplot.HChart
Returns current Chart
getChart() - Method in class jminhep.gui.Plotter
Get JFreeChart
getChart() - Method in class org.jfree.chart.ChartMouseEvent
Returns the chart that the mouse event relates to.
getChart() - Method in class org.jfree.chart.ChartPanel
Returns the chart contained in the panel.
getChart() - Method in class org.jfree.chart.entity.JFreeChartEntity
Returns the chart that occupies the entity area.
getChart() - Method in class org.jfree.chart.event.ChartChangeEvent
Returns the chart that generated the change event.
getChart() - Method in class org.jfree.chart.event.ChartProgressEvent
Returns the chart that generated the change event.
getChart() - Method in class org.jfree.chart.fx.ChartCanvas
Returns the chart that is being displayed by this node.
getChart() - Method in class org.jfree.chart.fx.ChartViewer
Returns the chart that is being displayed by this node.
getChart() - Method in class org.jfree.chart.fx.interaction.ChartMouseEventFX
Returns the chart that the mouse event relates to.
getChartArea() - Method in class org.jfree.chart.ChartRenderingInfo
Returns the area in which the chart was drawn.
getChartBackgroundPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the chart background paint.
getChartEditor(JFreeChart) - Static method in class org.jfree.chart.editor.ChartEditorManager
Returns a component that can be used to edit the given chart.
getChartEditorFactory() - Static method in class org.jfree.chart.editor.ChartEditorManager
Returns the current factory.
getChartPanel() - Method in class jhplot.HChart
Returns current Chart panel
getChartPanel() - Method in class jminhep.gui.Plotter
Get chart panel
getChartPanel() - Method in class org.jfree.chart.ChartFrame
Returns the chart panel for the frame.
getChartRenderingInfo() - Method in class org.jfree.chart.ChartPanel
Returns the chart rendering info from the most recent chart redraw.
getChartTheme() - Static method in class org.jfree.chart.ChartFactory
Returns the current chart theme used by the factory.
getCheck() - Method in class org.apache.commons.math3.linear.ConjugateGradient
Returns true if positive-definiteness should be checked for both matrix and preconditioner.
getCheck() - Method in class org.apache.commons.math3.linear.SymmLQ
Returns true if symmetry of the matrix, and symmetry as well as positive definiteness of the preconditioner should be checked.
getChi2() - Method in interface hep.lcio.event.Track
Chi^2 of the track fit.
getChi2() - Method in interface hep.lcio.event.Vertex
Chi squared of the vertex fit.
getChi2() - Method in class hep.lcio.implementation.event.ITrack
 
getChi2() - Method in class hep.lcio.implementation.event.IVertex
 
getChi2() - Method in class jhplot.stat.LinRegWeighted
Get chi2
getChi2() - Method in class jhplot.stat.StatShape
Get Chi2 of this fit
getChi2(double[], String) - Method in class org.jlab.groot.fitter.FitterFunction
 
getChild(Object, int) - Method in class root.RootHistogramTreeModel
 
getChildCount(Object) - Method in class root.RootHistogramTreeModel
 
getChildPosition(Dataset) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the child position.
getChildren() - Method in class org.apache.commons.io.monitor.FileEntry
Return the directory's files.
getChildrenAsArray(Node) - Static method in class org.lsmp.djep.xjep.TreeUtils
returns the children of a node as an array of nodes.
getChildrenList(String, List<String>, int) - Method in class org.jlab.groot.data.Directory
 
getChipColor(Number) - Method in class org.jfree.chart.renderer.WaferMapRenderer
Returns the paint for a given chip value.
getChipSpace() - Method in class org.jfree.data.general.WaferMapDataset
Returns the space to draw between chips.
getChipValue(int, int) - Method in class org.jfree.data.general.WaferMapDataset
Returns the data value for a chip.
getChipValue(Comparable, Comparable) - Method in class org.jfree.data.general.WaferMapDataset
Returns the value for a given chip x and y or null.
getChiSquare() - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Deprecated.
Get a Chi-Square-like value assuming the N residuals follow N distinct normal distributions centered on 0 and whose variances are the reciprocal of the weights.
getChiSquare() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated.
Get a Chi-Square-like value assuming the N residuals follow N distinct normal distributions centered on 0 and whose variances are the reciprocal of the weights.
getChiSquare() - Method in class org.jlab.groot.math.Func1D
 
getCHOL() - Method in class Jampack.Zmat
Returns a Cholesky decomposition if a valid one exists.
getChromosomes() - Method in class org.apache.commons.math3.genetics.ListPopulation
Returns an unmodifiable list of the chromosomes in this population.
getCI() - Method in class org.lsmp.djep.xjep.TreeUtils
 
getCircle() - Method in class org.apache.commons.math3.geometry.spherical.twod.Edge
Get the circle supporting this edge.
getCLb() - Method in class jhplot.stat.ConfidenceLevel
Get the Confidence Level for the background only.
getCLb(boolean) - Method in class jhplot.stat.ConfidenceLevel
Get the Confidence Level for the background only.
getClip() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the user clipping region.
getClipBounds() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the bounds of the user clipping region.
getClipPath() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the clipPath.
getClopperPearsonInterval(int, int, double) - Static method in class org.apache.commons.math3.stat.interval.IntervalUtils
Create a Clopper-Pearson binomial confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, successes and confidence level.
getClose(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the close-value for the specified series and item.
getClose(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the close-value for the specified series and item.
getClose() - Method in class org.jfree.data.time.ohlc.OHLC
Returns the close value.
getClose(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the close-value for an item within a series.
getClose(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the close-value for one item in a series.
getClose(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the close value.
getClose() - Method in class org.jfree.data.xy.OHLCDataItem
Returns the close value.
getClose(int, int) - Method in interface org.jfree.data.xy.OHLCDataset
Returns the y-value for the specified series and item.
getCloseCuts(Point<S>, double) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Get the cells whose cut sub-hyperplanes are close to the point.
getClosestPoint(double, double) - Method in class graph.DataSet
Return the data point that is closest to the parsed (x,y) position
getClosestTrackState(float, float, float) - Method in interface hep.lcio.event.Track
Returns track state closest to the given point.
getClosestTrackState(float, float, float) - Method in class hep.lcio.implementation.event.ITrack
 
getCloseTickPaint() - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Returns the paint used to draw the ticks for the close values.
getCloseValue(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the close-value (as a double primitive) for an item within a series.
getCloseValue(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the close-value (as a double primitive) for an item within a series.
getCloseValue() - Method in class org.jfree.data.time.ohlc.OHLCItem
Returns the close value.
getCloseValue(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the close-value for an item within a series.
getCloseValue(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the close-value (as a double primitive) for an item within a series.
getCloseValue(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the close-value (as a double primitive) for an item within a series.
getCloseValue(int, int) - Method in interface org.jfree.data.xy.OHLCDataset
Returns the close-value (as a double primitive) for an item within a series.
getCLs() - Method in class jhplot.stat.ConfidenceLevel
Get the Confidence Level defined by CLs = CLsb/CLb.
getCLs(boolean) - Method in class jhplot.stat.ConfidenceLevel
Get the Confidence Level defined by CLs = CLsb/CLb.
getCLsb() - Method in class jhplot.stat.ConfidenceLevel
Get the Confidence Level for the signal plus background hypothesis The confidence level for excluding the possibility of simultaneous presence of new particle production and background (the s + b hypothesis)
getCLsb(boolean) - Method in class jhplot.stat.ConfidenceLevel
Get the Confidence Level for the signal plus background hypothesis
getClusterer() - Method in class org.apache.commons.math3.ml.clustering.MultiKMeansPlusPlusClusterer
Returns the embedded k-means clusterer used by this instance.
getClusterEvaluator() - Method in class org.apache.commons.math3.ml.clustering.MultiKMeansPlusPlusClusterer
Returns the ClusterEvaluator used to determine the "best" clustering.
getClusterNumber() - Method in class jminhep.cluster.DataPoint
Returns the cluster to which the data point belongs
getClusters() - Method in interface hep.lcio.event.Cluster
The clusters that have been combined to this cluster.
getClusters() - Method in interface hep.lcio.event.ReconstructedParticle
The clusters that have been used for this particle.
getClusters() - Method in class hep.lcio.implementation.event.ICluster
 
getClusters() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getClusters() - Method in class jminhep.algorithms.FuzzyCMeansAlg
Get the number of clusters
getClusters() - Method in class jminhep.algorithms.HierarchicalAlg
Get number of clusters
getClusters() - Method in class jminhep.algorithms.KMeansAlg
Get number of clusters
getClusters() - Method in class jminhep.algorithms.KMeansExchangeAlg
Get number of clusters.
getClusters() - Method in class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Returns the list of clusters resulting from the last call to FuzzyKMeansClusterer.cluster(Collection).
getCMINUSI() - Method in class org.lsmp.djep.xjep.TreeUtils
 
getCMINUSONE() - Method in class org.lsmp.djep.xjep.TreeUtils
 
getCode() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
getCode() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 code = 13;
getCode() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 code = 13;
getCode() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
getCode() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 code = 13;
getCode() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 code = 13;
getCode() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
getCode() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 code = 13;
getCode() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 code = 13;
getCode() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
getCode() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 code = 13;
getCode() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 code = 13;
getCoeff(int) - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
getCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Returns a copy of the coefficients array.
getCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the coefficients array.
getCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of the coefficients array.
getCoefficients() - Method in class org.apache.commons.math3.optim.linear.LinearConstraint
Gets the coefficients of the constraint (left hand side).
getCoefficients() - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
Gets the coefficients of the linear equation being optimized.
getCoefficients() - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated.
Get the coefficients of the constraint (left hand side).
getCoefficients() - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.
Get the coefficients of the linear equation being optimized.
getCoefficients() - Method in class org.jfree.data.function.PolynomialFunction2D
Returns a copy of the coefficients array that was specified in the constructor.
getCoeffs() - Method in class org.lsmp.djep.groupJep.values.Polynomial
Returns the coefficients of polynomial.
getCollection(String) - Method in interface hep.lcio.event.LCEvent
Returns the collection for the given name.
getCollection(String) - Method in class hep.lcio.implementation.event.ILCEvent
 
getCollectionData(String) - Method in class hep.lcio.implementation.event.ILCEvent
 
getCollectionIdx(String[], String) - Static method in class hep.lcio.util.MergeUtil
Find the given name in collnames.
getCollectionNames() - Method in interface hep.lcio.event.LCEvent
Returns the names of the collections in the event.
getCollectionNames() - Method in class hep.lcio.implementation.event.ILCEvent
 
getColor() - Method in class graph.TextLine
 
getColor() - Method in class jhplot.DrawOptions
Get drawing color.
getColor() - Method in class jhplot.HKey
Get color of a label.
getColor() - Method in class jhplot.HLabel
Get color of a label.
getColor() - Method in class jhplot.HLabelEq
Get color of the label.
getColor() - Method in class jhplot.HMLabel
Get color of the label.
getColor() - Method in class jhplot.shapes.HShape
Get a color of the primitive
getColor(int) - Static method in class jhplot.utils.ColorPixel
Return color from pixel color (integer compact value representing color in the ImageJ representation).
getColor() - Method in class jplot.GraphLabel
 
getColor() - Method in class jplot.LinePars
Returns the color of the pen.
getColor() - Method in class jplot.SmallColorPreview
 
getColor(String, Color) - Method in class jplot.XMLRead
Returns the value of a color element: it must be a color.
getColor() - Method in class jplot3d.ColorDialog
 
getColor() - Method in class jplot3d.JColor
 
getColor() - Method in class net.java.dev.colorchooser.ColorChooser
Get the color currently represented by this component.
getColor() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the foreground color.
getColor(double) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns the color associated with a value.
getColor(int) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns a color.
getColor(int) - Static method in class org.jlab.groot.base.ColorPalette
 
getColor(int) - Static method in class org.jlab.groot.base.TStyle
 
getColor() - Method in class org.jlab.groot.ui.LatexText
 
getColor3D(int) - Method in class org.jlab.groot.base.ColorPalette
 
getColor3D(double, double, boolean) - Method in class org.jlab.groot.base.ColorPalette
 
getColor3DSize() - Method in class org.jlab.groot.base.ColorPalette
 
getColorAt(int, int) - Method in class net.java.dev.colorchooser.Palette
Returns the color at the specified point, or null if the point is beyond the bounds of the palette or in an area that does not indicate a color
getColorBackground() - Method in class jhplot.HLabelEq
Get color of background.
getColorBar() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the colorbar.
getColorBarLocation() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the color bar location.
getColorChooser() - Static method in class jplot.Utils
Returns a color chooser on request.
getColorErrorsFill() - Method in class jplot.LinePars
get color for fill errors
getColorErrorsFillSys() - Method in class jplot.LinePars
get color for fill errors (systematical errors)
getColorErrorsSysX() - Method in class jplot.LinePars
get color of sys errors on X
getColorErrorsSysY() - Method in class jplot.LinePars
get color of sys errors on Y
getColorErrorsX() - Method in class jplot.LinePars
get Color of errors on X
getColorErrorsY() - Method in class jplot.LinePars
get Color of errors on Y
getColorFlow() - Method in interface hep.lcio.event.MCParticle
Returns the color flow as defined by the generator.
getColorFlow() - Method in class hep.lcio.implementation.event.IMCParticle
 
getColorIndex() - Method in class jplot.GraphSettings
Returns the index of the next color of the vector of predefined colors.
getColorIndex() - Method in class jplot.LinePars
Returns the index of the color
getColorLinear(double) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns Color by mapping a given value to a linear palette.
getColorLog(double) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns Color by mapping a given value to a common log palette.
getColorMode() - Method in class jhplot.HPlot3D
Get current the color mode
getColorModel() - Method in interface jplot3d.SurfaceModel
 
getColorModel() - Method in class jplot3d.SurfaceModelCanvas
 
getColorName(Color) - Static method in class net.java.dev.colorchooser.ColorChooser
Returns the SVG or Swing constant name for the passed color, if the color exactly matches a color in the Swing UIManager constants or the SVG/X-Windows constants.
getColorPalette() - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Returns the color palette.
getColorPalette3D(int) - Static method in class org.jlab.groot.base.ColorPalette
 
getColorPallete3DSize() - Static method in class org.jlab.groot.base.ColorPalette
 
getColors() - Static method in class jplot.GraphSettings
Return colors.
getCols() - Method in class org.jlab.groot.group.DataGroupDescriptor
 
getColumn(int) - Method in class jhplot.PND
Return a specific column as an array
getColumn(int) - Method in class jhplot.PNI
Return a specific column as an array
getColumn() - Method in class jplot3dp.MathParser.SimpleCharStream
Deprecated. 
getColumn(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the entries in column number col as an array.
getColumn(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entries at the given column index as an array.
getColumn(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get the entries in column number col as an array.
getColumn(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entries at the given column index as an array.
getColumn(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the entries in column number col as an array.
getColumn() - Method in exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
 
getColumn() - Method in exception org.apache.commons.math3.linear.NonSymmetricMatrixException
 
getColumn(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entries at the given column index as an array.
getColumn() - Method in class org.apache.commons.math3.ml.neuralnet.twod.util.LocationFinder.Location
 
getColumn() - Method in class org.nfunk.jep.JavaCharStream
Deprecated. 
getColumnClass(int) - Method in class org.jfree.data.time.TimeSeriesTableModel
Returns the column class in the table model.
getColumnCopy(double[][], int) - Static method in class jhplot.math.DoubleArray
Extract one column from a matrix.
getColumnCopy(double[][][], int, int) - Static method in class jhplot.math.DoubleArray
Extract one column from a three dimensional array.
getColumnCopy(int[][], int) - Static method in class jhplot.math.IntegerArray
 
getColumnCopy(int[][][], int, int) - Static method in class jhplot.math.IntegerArray
 
getColumnCount() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the number of columns in the dataset.
getColumnCount() - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns the number of columns in the table.
getColumnCount() - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the number of categories in the dataset.
getColumnCount() - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the number of columns in the table.
getColumnCount() - Method in class org.jfree.data.DefaultKeyedValues2D
Returns the column count.
getColumnCount() - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the number of columns in the table.
getColumnCount() - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the number of column in the dataset.
getColumnCount() - Method in class org.jfree.data.KeyedObjects2D
Returns the column count.
getColumnCount() - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the number of columns in the table.
getColumnCount() - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns the number of columns in the table.
getColumnCount() - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the number of columns in the table.
getColumnCount() - Method in class org.jfree.data.time.TimeSeriesTableModel
Returns the number of columns in the table model.
getColumnCount() - Method in interface org.jfree.data.Values2D
Returns the number of columns in the table.
getColumnCount() - Method in class org.jfree.data.xy.XYDatasetTableModel
Gets the number of columns in the model.
getColumnDiameter() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the column diameter, which is always twice the value returned by ThermometerPlot.getColumnRadius().
getColumnDimension() - Method in class Jama.Matrix
Get column dimension.
getColumnDimension(double[][], int) - Static method in class jhplot.math.DoubleArray
Get the number of columns in a specified row of a matrix.
getColumnDimension(int[][], int) - Static method in class jhplot.math.IntegerArray
 
getColumnDimension() - Method in class jhplot.math.kalman.jama.Matrix
Get column dimension.
getColumnDimension() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the number of columns of this matrix.
getColumnDimension() - Method in interface org.apache.commons.math3.linear.AnyMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns the number of columns of this matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the number of columns of this matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the number of columns of this matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.JacobiPreconditioner
Returns the dimension of the domain of this operator.
getColumnDimension() - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Returns the number of columns of this matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.RealLinearOperator
Returns the dimension of the domain of this operator.
getColumnDimension() - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Returns the number of columns in the matrix.
getColumnIndex() - Method in class jplot.DataArray
Returns the column index of this data array.
getColumnIndex(Comparable) - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns the column index for a given key.
getColumnIndex(Comparable) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns a column index.
getColumnIndex(Comparable) - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the index for the specified column key.
getColumnIndex(Comparable) - Method in class org.jfree.data.DefaultKeyedValues2D
Returns the column index for a given key.
getColumnIndex(Comparable) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the index for the specified column key.
getColumnIndex(Comparable) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the column index for a column key.
getColumnIndex(Comparable) - Method in class org.jfree.data.KeyedObjects2D
Returns the column index for a given key, or -1 if the key is not recognised.
getColumnIndex(Comparable) - Method in interface org.jfree.data.KeyedValues2D
Returns the column index for a given key.
getColumnIndex(Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the column index for a given key.
getColumnIndex(Comparable) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns the column index for a given key.
getColumnIndex(Comparable) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the column index for a given key.
getColumnKey() - Method in class org.jfree.chart.entity.CategoryItemEntity
Returns the column key.
getColumnKey() - Method in class org.jfree.chart.plot.CategoryCrosshairState
Returns the column key.
getColumnKey(int) - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns a column key.
getColumnKey(int) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns a column key.
getColumnKey(int) - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the column key for a given index.
getColumnKey(int) - Method in class org.jfree.data.DefaultKeyedValues2D
Returns the key for a given column.
getColumnKey(int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the column key for a given index.
getColumnKey(int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns a column key.
getColumnKey(int) - Method in class org.jfree.data.KeyedObjects2D
Returns the key for a given column.
getColumnKey(int) - Method in interface org.jfree.data.KeyedValues2D
Returns the column key for a given index.
getColumnKey(int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns a column key.
getColumnKey(int) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns a column key.
getColumnKey(int) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns a column key.
getColumnKeys() - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns the column keys.
getColumnKeys() - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns a list of the categories in the dataset.
getColumnKeys() - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the column keys.
getColumnKeys() - Method in class org.jfree.data.DefaultKeyedValues2D
Returns the column keys in an unmodifiable list.
getColumnKeys() - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the column keys.
getColumnKeys() - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns a list of the column keys in the dataset.
getColumnKeys() - Method in class org.jfree.data.KeyedObjects2D
Returns the column keys.
getColumnKeys() - Method in interface org.jfree.data.KeyedValues2D
Returns the column keys.
getColumnKeys() - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the column keys.
getColumnKeys() - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns the column keys.
getColumnKeys() - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the column keys.
getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entries at the given column index as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entries at the given column index as a column matrix.
getColumnMatrix(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entries at the given column index as a column matrix.
getColumnName(int) - Method in class jplot.DataFile
Returns the name of one of the columns present here.
getColumnName(int) - Method in class org.jfree.data.time.TimeSeriesTableModel
Returns the name of a column
getColumnName(int) - Method in class org.jfree.data.xy.XYDatasetTableModel
Returns the column name.
getColumnP0D(int) - Method in class jhplot.PND
Return a specific column as P0D object
getColumnPackedCopy() - Method in class Jama.Matrix
Make a one-dimensional column packed copy of the internal array.
getColumnPackedCopy() - Method in class jhplot.math.kalman.jama.Matrix
Make a one-dimensional column packed copy of the internal array.
getColumnRadius() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the column radius, in Java2D units.
getColumnRenderingOrder() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the order in which the columns are rendered.
getColumns() - Method in class org.jlab.groot.group.DataGroup
 
getColumnsCopy(double[][], int...) - Static method in class jhplot.math.DoubleArray
Extract specific columns from a matrix.
getColumnsCopy(int[][], int...) - Static method in class jhplot.math.IntegerArray
 
getColumnsCount() - Method in class org.jfree.data.xy.MatrixSeries
Returns the number of columns in this matrix series.
getColumnSeparator() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format separator between components.
getColumnsRangeCopy(double[][], int, int) - Static method in class jhplot.math.DoubleArray
Extract a range of columns from a matrix.
getColumnsRangeCopy(int[][], int, int) - Static method in class jhplot.math.IntegerArray
 
getColumnVector(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entries at the given column index as a vector.
getColumnVector(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entries at the given column index as a vector.
getColumnVector(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entries at the given column index as a vector.
getCommand() - Method in class hep.lcio.util.CommandLineTool
Get the name of the currently active command.
getCommand(String) - Static method in class jminhep.utils.ResourceLoader
 
getCommand() - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
getCommand(String) - Method in class org.jlab.groot.io.ArgumentParser
 
getCommand() - Method in class org.jlab.groot.io.ArgumentParser
 
getCommand(int) - Method in class org.lsmp.djep.rpe.RpCommandList
 
getCommandHandler(String) - Method in class hep.lcio.util.CommandLineTool
Get a CommandHandler for the command.
getCompactness() - Method in class jminhep.algorithms.FuzzyCMeansAlg
This method returns the Compactness and Separation measure of cluster validity (see Fuzzy Algorithms With Applications to Image Processing and Pattern Recognition, Zheru Chi, Hong Yan, Tuan Pham, World Scientific, pp.
getCompactness() - Method in class jminhep.algorithms.HierarchicalAlg
This method returns the Compactness and Separation measure of cluster validity (see Fuzzy Algorithms With Applications to Image Processing and Pattern Recognition, Zheru Chi, Hong Yan, Tuan Pham, World Scientific, pp.
getCompactness() - Method in class jminhep.algorithms.KMeansAlg
This method returns the Compactness
getCompactness() - Method in class jminhep.algorithms.KMeansExchangeAlg
This method returns the Compactness and Separation measure of cluster validity (see Fuzzy Algorithms With Applications to Image Processing and Pattern Recognition, Zheru Chi, Hong Yan, Tuan Pham, World Scientific, pp.
getCompactness() - Method in class jminhep.cluster.Partition
Get compactness of the cluster configurations
getCompiler(int, int) - Static method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the compiler for number of free parameters and order.
getComplement(Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Get the complement of the region (exchanged interior/exterior).
getCompletePaint() - Method in class org.jfree.chart.renderer.category.GanttRenderer
Returns the paint used to show the percentage complete.
getCompleteState() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get the complete current state.
getComplexValue() - Method in class org.lsmp.djep.groupJep.GroupJep
Calcuates the value of the expression and returns the result as a complex number.
getComplexValue() - Method in class org.lsmp.djep.groupJep.values.FreeGroupElement
Returns an approximation to the complex number representing this algebraic number.
getComplexValue() - Method in interface org.lsmp.djep.groupJep.values.HasComplexValueI
 
getComplexValue() - Method in class org.nfunk.jep.JEP
Evaluates and returns the value of the expression as a complex number.
getComponent() - Method in class graph.RTextLine
 
getComponents() - Method in class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Gets the distributions that make up the mixture model.
getComponents() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
Deprecated.
Get the components array.
getComposite() - Method in class org.jfree.chart.ClipPath
Deprecated.
Returns the composite.
getComposite() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the current composite.
getCompositeObjectList(Directory) - Method in class org.jlab.groot.data.Directory
 
getConditionNumber() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Return the condition number of the matrix.
getCONE() - Method in class org.lsmp.djep.xjep.TreeUtils
 
getConfidence() - Method in class jhplot.stat.LinReg
Get confidence intervals for means
getConfidence(Color) - Method in class jhplot.stat.LinReg
Get confidence intervals for means
getConfidenceBand(Color, double) - Method in class jhplot.stat.LinReg
Calculate confidence band in form of P1D with errors.
getConfidenceBand(int, Color, double) - Method in class jhplot.stat.LinReg
Calculate confidence band in form of P1D with errors.
getConfidenceLevel() - Method in class org.apache.commons.math3.stat.interval.ConfidenceInterval
 
getConjugate() - Method in class org.apache.commons.math3.complex.Quaternion
Returns the conjugate quaternion of the instance.
getConnectFirstAndLastPoint() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns true if first and last point of a series will be connected, false otherwise.
getConstantTerm() - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
Gets the constant of the linear equation being optimized.
getConstantTerm() - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.
Get the constant of the linear equation being optimized.
getConstantValue() - Method in class org.lsmp.djep.rpe.RpCommand
 
getConstituents() - Method in class hephysics.jet.ParticleD
Get indexes of constituents, iff filled with the "add" method
getConstituentsList() - Method in class hephysics.jet.ParticleD
Get indexes of constituents, iff filled with the "add" method
getConstraints() - Method in class org.apache.commons.math3.optim.linear.LinearConstraintSet
Gets the set of linear constraints.
getContainer() - Method in class org.jfree.chart.title.CompositeTitle
Returns the container holding the titles.
getContentAlignmentPoint() - Method in class org.jfree.chart.block.LabelBlock
Returns the content alignment point.
getContentBuffer() - Method in class org.jlab.groot.data.H2F
Generates a 2D array with the content in the histogram
getContents() - Method in class org.jfree.chart.resources.JFreeChartResources
Returns the array of strings in the resource bundle.
getContents() - Method in class org.jfree.data.resources.DataPackageResources
Returns the array of strings in the resource bundle.
getContents() - Method in class org.jfree.data.resources.DataPackageResources_de
Returns the array of strings in the resource bundle.
getContents() - Method in class org.jfree.data.resources.DataPackageResources_es
Returns the array of strings in the resource bundle.
getContents() - Method in class org.jfree.data.resources.DataPackageResources_fr
Returns the array of strings in the resource bundle.
getContents() - Method in class org.jfree.data.resources.DataPackageResources_pl
Returns the array of strings in the resource bundle.
getContents() - Method in class org.jfree.data.resources.DataPackageResources_ru
Returns the array of strings in the resource bundle.
getContentTypeEncoding() - Method in exception org.apache.commons.io.input.XmlStreamReaderException
Returns the encoding in the content-type used to attempt determining the encoding.
getContentTypeMime() - Method in exception org.apache.commons.io.input.XmlStreamReaderException
Returns the MIME type in the content-type used to attempt determining the encoding.
getContentXOffset() - Method in class org.jfree.chart.block.AbstractBlock
Returns the x-offset for the content within the block.
getContentYOffset() - Method in class org.jfree.chart.block.AbstractBlock
Returns the y-offset for the content within the block.
getContext() - Method in exception org.apache.commons.math3.exception.MathArithmeticException
Gets a reference to the "rich context" data structure that allows to customize error messages and store key, value pairs in exceptions.
getContext() - Method in exception org.apache.commons.math3.exception.MathIllegalArgumentException
Gets a reference to the "rich context" data structure that allows to customize error messages and store key, value pairs in exceptions.
getContext() - Method in exception org.apache.commons.math3.exception.MathIllegalStateException
Gets a reference to the "rich context" data structure that allows to customize error messages and store key, value pairs in exceptions.
getContext() - Method in exception org.apache.commons.math3.exception.MathRuntimeException
Gets a reference to the "rich context" data structure that allows to customize error messages and store key, value pairs in exceptions.
getContext() - Method in exception org.apache.commons.math3.exception.MathUnsupportedOperationException
Gets a reference to the "rich context" data structure that allows to customize error messages and store key, value pairs in exceptions.
getContext() - Method in interface org.apache.commons.math3.exception.util.ExceptionContextProvider
Gets a reference to the "rich context" data structure that allows to customize error messages and store key, value pairs in exceptions.
getContour_bar() - Method in class jplot.GraphSettings
Show or not bars
getContour_binsX() - Method in class jplot.GraphSettings
How many bins for contours in X
getContour_binsY() - Method in class jplot.GraphSettings
How many bins for contours in Y
getContour_gray() - Method in class jplot.GraphSettings
Which color to use
getContour_levels() - Method in class jplot.GraphSettings
How many levels
getContourDataRange() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the range for the Contours.
getContourDataRange() - Method in interface org.jfree.chart.plot.ContourValuePlot
Deprecated.
Returns the range of data values to be plotted.
getContourLines() - Method in interface jplot3d.SurfaceModel
 
getContourLines() - Method in class jplot3d.SurfaceModelCanvas
 
getContractionCriteria() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
As of 3.1. Please use ResizableDoubleArray.getContractionCriterion() instead.
getContractionCriterion() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
The contraction criterion defines when the internal array will contract to store only the number of elements in the element array.
getControl_matrix() - Method in class jhplot.math.kalman.JKalman
Getter
getControlMatrix() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
Returns the control matrix.
getControlMatrix() - Method in interface org.apache.commons.math3.filter.ProcessModel
Returns the control matrix.
getConvergence() - Method in class org.apache.commons.math3.ode.events.EventState
Get the convergence threshold for event localization.
getConvergence() - Method in class org.apache.commons.math3.ode.events.FieldEventState
Get the convergence threshold for event localization.
getConvergenceChecker() - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresAdapter
Gets the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optim.AbstractOptimizationProblem
Gets the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Gets the convergence checker.
getConvergenceChecker() - Method in interface org.apache.commons.math3.optim.OptimizationProblem
Gets the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
Deprecated.
Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
Deprecated.
Get the convergence checker.
getConvergenceChecker() - Method in interface org.apache.commons.math3.optimization.BaseOptimizer
Deprecated.
Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.
Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated.
Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.
Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated.
Get the convergence checker.
getCoordinate(int, int) - Method in class jhplot.stat.PCA
Positions of the last coordinates of the projection vectors (eigenvectors)
getCoordinateType() - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Returns the coordinate type (set in the constructor).
getCopy(double[], int...) - Static method in class jhplot.math.DoubleArray
Extract specific elements from an array.
getCopy(int[], int...) - Static method in class jhplot.math.IntegerArray
 
getCopy() - Method in class jhplot.P3D
get a copy of the current holder
getCopy() - Method in class org.jlab.groot.graphics.EmbeddedPad
returns copy of embedded pad with all plotters included.
getCopy() - Method in class org.jlab.groot.math.UserParameter
 
getCopy(UserParameters) - Method in class org.jlab.groot.math.UserParameters
 
getCopyOptions() - Method in class org.apache.commons.io.file.CopyDirectoryVisitor
Gets the copy options.
getCorrelation() - Method in class jhplot.stat.LinReg
Get correlation coefficient
getCorrelation(Number[], Number[]) - Static method in class org.jfree.data.statistics.Statistics
Calculates the correlation between two datasets.
getCorrelationMatrix() - Method in class org.apache.commons.math3.stat.correlation.KendallsCorrelation
Returns the correlation matrix.
getCorrelationMatrix() - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Returns the correlation matrix.
getCorrelationMatrix() - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Calculate the Spearman Rank Correlation Matrix.
getCorrelationPValues() - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Returns a matrix of p-values associated with the (two-sided) null hypothesis that the corresponding correlation coefficient is zero.
getCorrelationStandardErrors() - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Returns a matrix of standard errors associated with the estimates in the correlation matrix.
getCorrelationStandardErrors().getEntry(i,j) is the standard error associated with getCorrelationMatrix.getEntry(i,j)
getCosElevationAngle() - Method in class jplot3d.Projector
Gets the cosine of elevation angle.
getCosRotationAngle() - Method in class jplot3d.Projector
Gets the cosine of rotation angle.
getCost() - Method in class org.apache.commons.math3.fitting.leastsquares.AbstractEvaluation
Get the cost.
getCost() - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresProblem.Evaluation
Get the cost.
getCostRelativeTolerance() - Method in class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
Gets the value of a tuning parameter.
getCount() - Method in class org.apache.commons.io.input.CountingInputStream
The number of bytes that have passed through this stream.
getCount() - Method in class org.apache.commons.io.output.CountingOutputStream
The number of bytes that have passed through this stream.
getCount(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
Returns the number of values equal to v.
getCount(int) - Method in class org.apache.commons.math3.stat.Frequency
Returns the number of values equal to v.
getCount(long) - Method in class org.apache.commons.math3.stat.Frequency
Returns the number of values equal to v.
getCount(char) - Method in class org.apache.commons.math3.stat.Frequency
Returns the number of values equal to v.
getCount() - Method in class org.apache.commons.math3.util.Incrementor
Deprecated.
Gets the current count.
getCount() - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Gets the current count.
getCount(int...) - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Convert to unidimensional counter.
getCount() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
Get the current unidimensional counter slot.
getCount(int) - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
Get the current count in the selected dimension.
getCount() - Method in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of version 1.0.13, use DateTickUnit.getMultiple().
getCount() - Method in class org.jfree.data.statistics.HistogramBin
Returns the number of items in the bin.
getCounts(int) - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Convert to multidimensional counter.
getCounts() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
Get the current multidimensional counter slots.
getCovariance() - Method in class jhplot.stat.PCA
Get covariance matrix
getCovariance() - Method in class jhplot.stat.StatShape
Get covariance matrix.
getCovariance(double) - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the n × n covariance matrix.
getCovariance(int, int) - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
Get the covariance for an individual element of the covariance matrix.
getCovariance() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the covariance matrix of the values that have been added.
getCovariance() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns the covariance of the available values.
getCovariance() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the covariance matrix of the values that have been added.
getCovarianceMatrix() - Method in class org.apache.commons.math3.stat.correlation.Covariance
Returns the covariance matrix
getCovarianceMatrix() - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
Returns the covariance matrix
getCovarianceOfParameters(int, int) - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the covariance between regression parameters i and j.
getCovariances() - Method in class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Gets the covariance matrix.
getCovariances(double) - Method in class org.apache.commons.math3.fitting.leastsquares.AbstractEvaluation
Get the covariance matrix of the optimized parameters.
getCovariances(double) - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresProblem.Evaluation
Get the covariance matrix of the optimized parameters.
getCovariances() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated.
getCovariances(double) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated.
getCovMatrix() - Method in interface hep.lcio.event.ReconstructedParticle
Covariance matrix of the reconstructed particle's 4vector (10 parameters).
getCovMatrix() - Method in interface hep.lcio.event.Track
Covariance matrix of the track parameters.
getCovMatrix() - Method in interface hep.lcio.event.TrackerHit
Covariance of the position (x,y,z), stored as lower triangle matrix.
getCovMatrix() - Method in interface hep.lcio.event.TrackerPulse
Covariance matrix of the charge (c) and time (t) measurements.
getCovMatrix() - Method in interface hep.lcio.event.TrackState
Covariance matrix of the track parameters.
getCovMatrix() - Method in interface hep.lcio.event.Vertex
Covariance matrix of the position (stored as lower triangle matrix, i.e.
getCovMatrix() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getCovMatrix() - Method in class hep.lcio.implementation.event.ITrack
 
getCovMatrix() - Method in class hep.lcio.implementation.event.ITrackerHit
 
getCovMatrix() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getCovMatrix() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getCovMatrix() - Method in class hep.lcio.implementation.event.ITrackerPulse
 
getCovMatrix() - Method in class hep.lcio.implementation.event.ITrackState
 
getCovMatrix() - Method in class hep.lcio.implementation.event.IVertex
 
getCreatedBy() - Static method in class jhplot.JHPlot
Get JAVA version used to create
getCreateEntities() - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.getSeriesCreateEntities(int) and AbstractRenderer.getBaseCreateEntities().
getCross() - Method in class org.nfunk.jep.OperatorSet
 
getCrosshairDatasetIndex() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the dataset index for the crosshair.
getCrosshairDistance() - Method in class org.jfree.chart.plot.CrosshairState
Returns the distance between the anchor point and the current crosshair point.
getCrosshairPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the crosshair paint.
getCrosshairState() - Method in class org.jfree.chart.renderer.category.CategoryItemRendererState
Returns the crosshair state, if any.
getCrosshairX() - Method in class org.jfree.chart.plot.CrosshairState
Get the x-value for the crosshair point.
getCrosshairY() - Method in class org.jfree.chart.plot.CrosshairState
Get the y-value for the crosshair point.
getCrossoverPoints() - Method in class org.apache.commons.math3.genetics.NPointCrossover
Returns the number of crossover points used by this CrossoverPolicy.
getCrossoverPolicy() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the crossover policy.
getCrossoverRate() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the crossover rate.
getCrossSection() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
getCrossSection() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double cross_section = 14;
getCrossSection() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section = 14;
getCrossSection() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
getCrossSection() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section = 2;
getCrossSection() - Method in interface proeic.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section = 2;
getCrossSection() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
getCrossSection() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double cross_section = 14;
getCrossSection() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section = 14;
getCrossSection() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
getCrossSection() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section = 2;
getCrossSection() - Method in interface promc.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section = 2;
getCrossSection() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
getCrossSection() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double cross_section = 14;
getCrossSection() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section = 14;
getCrossSection() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
getCrossSection() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section = 2;
getCrossSection() - Method in interface pronlo.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section = 2;
getCrossSection() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
getCrossSection() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double cross_section = 14;
getCrossSection() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section = 14;
getCrossSection() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
getCrossSection() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section = 2;
getCrossSection() - Method in interface proreco.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section = 2;
getCrossSectionAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
getCrossSectionAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional double cross_section_accumulated = 3;
getCrossSectionAccumulated() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_accumulated = 3;
getCrossSectionAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
getCrossSectionAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat
optional double cross_section_accumulated = 3;
getCrossSectionAccumulated() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_accumulated = 3;
getCrossSectionAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
getCrossSectionAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional double cross_section_accumulated = 3;
getCrossSectionAccumulated() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_accumulated = 3;
getCrossSectionAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
getCrossSectionAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional double cross_section_accumulated = 3;
getCrossSectionAccumulated() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_accumulated = 3;
getCrossSectionError() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
getCrossSectionError() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double cross_section_error = 15;
getCrossSectionError() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section_error = 15;
getCrossSectionError() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
getCrossSectionError() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section_error = 3;
getCrossSectionError() - Method in interface proeic.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section_error = 3;
getCrossSectionError() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
getCrossSectionError() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double cross_section_error = 15;
getCrossSectionError() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section_error = 15;
getCrossSectionError() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
getCrossSectionError() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section_error = 3;
getCrossSectionError() - Method in interface promc.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section_error = 3;
getCrossSectionError() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
getCrossSectionError() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double cross_section_error = 15;
getCrossSectionError() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section_error = 15;
getCrossSectionError() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
getCrossSectionError() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section_error = 3;
getCrossSectionError() - Method in interface pronlo.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section_error = 3;
getCrossSectionError() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
getCrossSectionError() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double cross_section_error = 15;
getCrossSectionError() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section_error = 15;
getCrossSectionError() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
getCrossSectionError() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section_error = 3;
getCrossSectionError() - Method in interface proreco.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section_error = 3;
getCrossSectionErrorAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
getCrossSectionErrorAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional double cross_section_error_accumulated = 4;
getCrossSectionErrorAccumulated() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_error_accumulated = 4;
getCrossSectionErrorAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
getCrossSectionErrorAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat
optional double cross_section_error_accumulated = 4;
getCrossSectionErrorAccumulated() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_error_accumulated = 4;
getCrossSectionErrorAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
getCrossSectionErrorAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional double cross_section_error_accumulated = 4;
getCrossSectionErrorAccumulated() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_error_accumulated = 4;
getCrossSectionErrorAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
getCrossSectionErrorAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional double cross_section_error_accumulated = 4;
getCrossSectionErrorAccumulated() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_error_accumulated = 4;
getCumFreq(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(int) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(long) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(char) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumPct(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumPct(int) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumPct(long) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumPct(char) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumulative() - Method in class org.jlab.groot.data.DataVector
Returns cumulative integral of the vector.
getCumulativePercentages(KeyedValues) - Static method in class org.jfree.data.DataUtilities
Returns a KeyedValues instance that contains the cumulative percentage values for the data in another KeyedValues instance.
getCurrent() - Static method in enum org.apache.commons.io.FileSystem
Gets the current file system.
getCurrentHandler() - Method in class org.jfree.data.xml.RootHandler
Returns the handler at the top of the stack.
getCurrentMainSetJacobian(double[][]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Get the current value of the Jacobian matrix with respect to state.
getCurrentNumberOfBytes() - Method in class org.apache.commons.io.input.buffer.CircularByteBuffer
Returns the number of bytes, that are currently present in the buffer.
getCurrentParameterJacobian(String, double[]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Get the current value of the Jacobian matrix with respect to one parameter.
getCurrentSignedStepsize() - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Get the current signed value of the integration stepsize.
getCurrentSignedStepsize() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get the current signed value of the integration stepsize.
getCurrentSignedStepsize() - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Get the current signed value of the integration stepsize.
getCurrentSignedStepsize() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get the current signed value of the integration stepsize.
getCurrentState() - Method in class org.apache.commons.math3.ode.sampling.AbstractFieldStepInterpolator
Get the state at current grid point time.
getCurrentState() - Method in interface org.apache.commons.math3.ode.sampling.FieldStepInterpolator
Get the state at current grid point time.
getCurrentStepStart() - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Get the current value of the step start time ti.
getCurrentStepStart() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get the current value of the step start time ti.
getCurrentStepStart() - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Get the current value of the step start time ti.
getCurrentStepStart() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the current value of the step start time ti.
getCurrentStepStart() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get the current value of the step start time ti.
getCurrentTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the current soft grid point time.
getCurrentTime() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the current grid point time.
getCursor() - Method in class org.jfree.chart.axis.AxisState
Returns the cursor position.
getCurve() - Method in class graph.IsoCurve
Return a contour curve.
getCut() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Get the cut sub-hyperplane.
getCut(String) - Method in class org.jlab.groot.tree.TreeSelector
 
getCuts(Tree) - Method in class org.jlab.groot.tree.TreeSelector
 
getCycle() - Method in class root.FakeTKey
 
getCycleBound() - Method in class org.jfree.chart.axis.CyclicNumberAxis
The cycle bound is defined as the higest value x such that "offset + period * i = x", with i and integer and x < range.getUpperBound() This is the value which is at both ends of the axis : x...up|low...x The values from x to up are the valued in the current cycle.
getCZERO() - Method in class org.lsmp.djep.xjep.TreeUtils
 
getD() - Method in class cern.colt.matrix.linalg.EigenvalueDecomposition
Returns the block diagonal eigenvalue matrix, D.
getD() - Method in class Jama.EigenvalueDecomposition
Return the block diagonal eigenvalue matrix
getD() - Method in class jhplot.stat.PCA
Get transpose
getD() - Method in class jplot3d.JPoint
Return the current distance to the observer
getD() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets the block diagonal matrix D of the decomposition.
getD0() - Method in interface hep.lcio.event.Track
Impact paramter of the track in (r-phi).
getD0() - Method in interface hep.lcio.event.TrackState
Impact paramter of the track in (r-phi).
getD0() - Method in class hep.lcio.implementation.event.ITrack
 
getD0() - Method in class hep.lcio.implementation.event.ITrackState
 
getDa(int) - Method in class promc.io.PEventFile.HEvent.Builder
repeated double da = 3 [packed = true];
getDa(int) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated double da = 3 [packed = true];
getDa(int) - Method in class promc.io.PEventFile.HEvent.Entry
repeated double da = 3 [packed = true];
getDa(int) - Method in interface promc.io.PEventFile.HEvent.EntryOrBuilder
repeated double da = 3 [packed = true];
getDa(int) - Method in class promc.io.PEventFile.HEvent
repeated double da = 3 [packed = true];
getDa(int) - Method in interface promc.io.PEventFile.HEventOrBuilder
repeated double da = 3 [packed = true];
getDaCount() - Method in class promc.io.PEventFile.HEvent.Builder
repeated double da = 3 [packed = true];
getDaCount() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated double da = 3 [packed = true];
getDaCount() - Method in class promc.io.PEventFile.HEvent.Entry
repeated double da = 3 [packed = true];
getDaCount() - Method in interface promc.io.PEventFile.HEvent.EntryOrBuilder
repeated double da = 3 [packed = true];
getDaCount() - Method in class promc.io.PEventFile.HEvent
repeated double da = 3 [packed = true];
getDaCount() - Method in interface promc.io.PEventFile.HEventOrBuilder
repeated double da = 3 [packed = true];
getDaList() - Method in class promc.io.PEventFile.HEvent.Builder
repeated double da = 3 [packed = true];
getDaList() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated double da = 3 [packed = true];
getDaList() - Method in class promc.io.PEventFile.HEvent.Entry
repeated double da = 3 [packed = true];
getDaList() - Method in interface promc.io.PEventFile.HEvent.EntryOrBuilder
repeated double da = 3 [packed = true];
getDaList() - Method in class promc.io.PEventFile.HEvent
repeated double da = 3 [packed = true];
getDaList() - Method in interface promc.io.PEventFile.HEventOrBuilder
repeated double da = 3 [packed = true];
getDarkerSides() - Method in class org.jfree.chart.plot.PiePlot3D
Returns a flag that controls whether or not the sides of the pie chart are rendered using a darker colour.
getDashIndex() - Method in class jplot.LinePars
Returns the array index of the current dash length
getDashLength() - Method in class jplot.LinePars
Returns the dash length of the pen
getData() - Method in class jhplot.HPlot
Get the vector which keeps all the data
getData() - Method in class jhplot.security.MD5
Get data as stream
getData() - Method in class jhplot.stat.StatShape
Get data back used for fitting (can be inverted in Y and Y for best results).
getData() - Method in class jhplot.VHolder
Return a Vector with the data (rows of the dimension obtained by calling dimen()).
getData() - Method in class jplot.DataArray
Return the data vector
getData() - Method in class jplot.DataArray2D
Return the data vector
getData() - Method in class jplot.DataArray3D
Return the data vector
getData() - Method in class jplot.XMLRead
get all lines between the attribute
getData() - Method in class org.apache.commons.io.output.DeferredFileOutputStream
Returns the data for this output stream as an array of bytes, assuming that the data has been retained in memory.
getData() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Returns vector entries as a T array.
getData() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in interface org.apache.commons.math3.linear.FieldVector
Deprecated.
as of 3.1, to be removed in 4.0. Please use the FieldVector.toArray() method instead.
getData() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated.
as of 3.1, to be removed in 4.0. Please use the SparseFieldVector.toArray() method instead.
getData() - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
Return the covariance matrix as two-dimensional array.
getData() - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Get a copy of the stored data array.
getData() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns the data array used by the plot.
getData(int, int) - Method in class org.jlab.groot.data.GraphErrors
 
getData() - Method in class org.jlab.groot.data.H1F
 
getData(int, int) - Method in class org.jlab.groot.data.H1F
 
getData(int, int) - Method in class org.jlab.groot.data.H2F
 
getData(int, int) - Method in interface org.jlab.groot.data.IDataSet
 
getData(String) - Method in class org.jlab.groot.group.DataGroup
 
getData(int) - Method in class org.jlab.groot.group.DataGroup
 
getData(int, int) - Method in class org.jlab.groot.math.Func1D
 
getData() - Method in class org.jlab.groot.tree.AbstractDescriptor
 
getDataArea() - Method in class org.jfree.chart.plot.PlotRenderingInfo
Returns the plot's data area (in Java2D space).
getDataAreaRatio() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the data area ratio.
getDataArray() - Method in class jhplot.P1D
Return a DataArray container from JPlot
getDataArray() - Method in class jhplot.P2D
Return a DataArray2D container.
getDataArray() - Method in class jhplot.P3D
Return a DataArray3D container.
getDataArray() - Method in class jplot.JPlot
 
getDataArray(int) - Method in class jplot.JPlot
 
getDataArraySelected() - Method in class jplot.JPlot
 
getDataBoundsIncludesVisibleSeriesOnly() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the flag that controls whether or not the data bounds reported by this renderer will exclude non-visible series.
getDataBufferBin(int) - Method in class org.jlab.groot.data.H2F
 
getDataBufferSize() - Method in class org.jlab.groot.data.H2F
 
getDataDescription() - Method in interface hep.lcio.event.LCGenericObject
The description string.
getDataDescription() - Method in class hep.lcio.example.CalibrationConstant
 
getDataDescription() - Method in class hep.lcio.implementation.event.ILCGenericObject
 
getDataError() - Method in class org.jlab.groot.data.H1F
 
getDataEX(int) - Method in class org.jlab.groot.data.GraphErrors
 
getDataEX(int) - Method in class org.jlab.groot.data.H1F
 
getDataEX(int) - Method in class org.jlab.groot.data.H2F
 
getDataEX(int) - Method in interface org.jlab.groot.data.IDataSet
 
getDataEX(int) - Method in class org.jlab.groot.math.Func1D
 
getDataExtractOrder() - Method in class org.jfree.chart.plot.MultiplePiePlot
Returns the data extract order (by row or by column).
getDataExtractOrder() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the data extract order (by row or by column).
getDataEY(int) - Method in class org.jlab.groot.data.GraphErrors
 
getDataEY(int) - Method in class org.jlab.groot.data.H1F
 
getDataEY(int) - Method in class org.jlab.groot.data.H2F
 
getDataEY(int) - Method in interface org.jlab.groot.data.IDataSet
 
getDataEY(int) - Method in class org.jlab.groot.math.Func1D
 
getDataFile() - Method in class jplot.panels.PanelPlot
 
getDataGroup(String) - Method in class org.jlab.groot.data.TDirectory
 
getDataItem(int) - Method in class org.jfree.data.time.ohlc.OHLCSeries
Returns the data item at the specified index.
getDataItem(int) - Method in class org.jfree.data.time.TimePeriodValues
Returns one data item for the series.
getDataItem(int) - Method in class org.jfree.data.time.TimeSeries
Returns a data item from the dataset.
getDataItem(RegularTimePeriod) - Method in class org.jfree.data.time.TimeSeries
Returns the data item for a specific period.
getDataItem(int) - Method in class org.jfree.data.xy.VectorSeries
Returns the data item at the specified index.
getDataItem(int) - Method in class org.jfree.data.xy.XIntervalSeries
Returns the data item at the specified index.
getDataItem(int) - Method in class org.jfree.data.xy.XYIntervalSeries
Returns the data item at the specified index.
getDataItem(int) - Method in class org.jfree.data.xy.XYSeries
Return the data item with the specified index.
getDataItem(int) - Method in class org.jfree.data.xy.YIntervalSeries
Returns the data item at the specified index.
getDataLength() - Method in class jhplot.io.db.RecordWriter
Returns the number of bytes in the data.
getDataLength() - Method in class jhplot.stat.LinReg
Get the size of the input data
getDataLength() - Method in class jhplot.stat.LinRegWeighted
Get the size of the input data
getDataMax() - Method in class graph.Axis
Return the maximum value of All datasets attached to the axis.
getDataMin() - Method in class graph.Axis
Return the minimum value of All datasets attached to the axis.
getDataPoints() - Method in class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Returns an unmodifiable list of the data points used in the last call to FuzzyKMeansClusterer.cluster(Collection).
getDataRange(ValueAxis) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the range of data values that will be plotted against the range axis.
getDataRange(ValueAxis) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Returns a range representing the extent of the data values in this plot (obtained from the subplots) that will be rendered against the specified axis.
getDataRange(ValueAxis) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Returns a range representing the extent of the data values in this plot (obtained from the subplots) that will be rendered against the specified axis.
getDataRange(ValueAxis) - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Returns a range representing the extent of the data values in this plot (obtained from the subplots) that will be rendered against the specified axis.
getDataRange(ValueAxis) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Returns a range representing the extent of the data values in this plot (obtained from the subplots) that will be rendered against the specified axis.
getDataRange(ValueAxis) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the range for an axis.
getDataRange(ValueAxis) - Method in class org.jfree.chart.plot.FastScatterPlot
Returns the range of data values to be plotted along the axis, or null if the specified axis isn't the domain axis or the range axis for the plot.
getDataRange(ValueAxis) - Method in class org.jfree.chart.plot.PolarPlot
Returns the range for the specified axis.
getDataRange(ValueAxis) - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the data range.
getDataRange(ValueAxis) - Method in interface org.jfree.chart.plot.ValueAxisPlot
Returns the data range that should apply for the specified axis.
getDataRange(ValueAxis) - Method in class org.jfree.chart.plot.XYPlot
Returns the range for the specified axis.
getDataRef() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Get a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Get a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Returns a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Get a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Gets a reference to the underlying data array.
getDataRegion() - Method in class org.jlab.groot.graphics.FunctionPlotter
 
getDataRegion() - Method in class org.jlab.groot.graphics.GraphErrorsPlotter
 
getDataRegion() - Method in class org.jlab.groot.graphics.Histogram2DPlotter
 
getDataRegion() - Method in class org.jlab.groot.graphics.HistogramPlotter
 
getDataRegion() - Method in interface org.jlab.groot.graphics.IDataSetPlotter
 
getDataSet() - Method in class graph.LoadData
 
getDataset() - Method in class org.jfree.chart.entity.CategoryItemEntity
Returns the dataset this entity refers to.
getDataset() - Method in class org.jfree.chart.entity.LegendItemEntity
Returns a reference to the dataset that this legend item is derived from.
getDataset() - Method in class org.jfree.chart.entity.PieSectionEntity
Returns the dataset this entity refers to.
getDataset() - Method in class org.jfree.chart.entity.XYItemEntity
Returns the dataset this entity refers to.
getDataset() - Method in class org.jfree.chart.LegendItem
Returns the dataset.
getDataset() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the primary dataset for the plot.
getDataset(int) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the dataset with the given index, or null if there is no dataset.
getDataset() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the primary dataset for the plot.
getDataset() - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the primary dataset for the plot.
getDataset(int) - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the dataset at the given index.
getDataset() - Method in class org.jfree.chart.plot.MeterPlot
Returns the dataset for the plot.
getDataset() - Method in class org.jfree.chart.plot.MultiplePiePlot
Returns the dataset used by the plot.
getDataset() - Method in class org.jfree.chart.plot.PiePlot
Returns the dataset.
getDataset() - Method in class org.jfree.chart.plot.PolarPlot
Returns the primary dataset for the plot.
getDataset(int) - Method in class org.jfree.chart.plot.PolarPlot
Returns the dataset with the specified index, if any.
getDataset() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the dataset.
getDataset() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the dataset for the plot.
getDataset() - Method in class org.jfree.chart.plot.WaferMapPlot
Returns the dataset
getDataset() - Method in class org.jfree.chart.plot.XYPlot
Returns the primary dataset for the plot.
getDataset(int) - Method in class org.jfree.chart.plot.XYPlot
Returns the dataset with the specified index, or null if there is no dataset with that index.
getDataset() - Method in class org.jfree.chart.title.LegendItemBlockContainer
Returns a reference to the dataset for the associated legend item.
getDataset() - Method in class org.jfree.data.general.DatasetChangeEvent
Returns the dataset that generated the event.
getDataset() - Method in class org.jfree.data.xml.CategoryDatasetHandler
Returns the dataset.
getDataset() - Method in class org.jfree.data.xml.PieDatasetHandler
Returns the dataset.
getDataSet() - Method in class org.jlab.groot.graphics.FunctionPlotter
 
getDataSet() - Method in class org.jlab.groot.graphics.GraphErrorsPlotter
 
getDataSet() - Method in class org.jlab.groot.graphics.Histogram2DPlotter
 
getDataSet() - Method in class org.jlab.groot.graphics.HistogramPlotter
 
getDataSet() - Method in interface org.jlab.groot.graphics.IDataSetPlotter
 
getDataSet() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getDatasetCount() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the number of datasets.
getDatasetCount() - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the number of datasets.
getDatasetCount() - Method in class org.jfree.chart.plot.PolarPlot
Returns the number of datasets.
getDatasetCount() - Method in class org.jfree.chart.plot.XYPlot
Returns the number of datasets.
getDatasetGroup() - Method in class org.jfree.chart.plot.Plot
Returns the dataset group for the plot (not currently used).
getDatasetIndex() - Method in class org.jfree.chart.LegendItem
Returns the dataset index for this legend item.
getDatasetIndex() - Method in class org.jfree.chart.plot.CrosshairState
Returns the dataset index that the crosshair values relate to.
getDatasetIndex() - Method in class org.jfree.chart.plot.dial.DialPointer
Returns the dataset index that the pointer maps to.
getDatasetIndex() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the index of the dataset from which this indicator fetches its current value.
getDatasetIndex() - Method in class org.jfree.chart.title.LegendItemBlockContainer
Deprecated.
As of 1.0.6, use the LegendItemBlockContainer.getDataset() method.
getDatasetPlotters() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getDatasetRenderingOrder() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the dataset rendering order.
getDatasetRenderingOrder() - Method in class org.jfree.chart.plot.XYPlot
Returns the dataset rendering order.
getDatasets() - Method in class org.jfree.chart.plot.CompassPlot
Returns an array of dataset references for the plot.
getDatasetType() - Method in class org.jlab.groot.base.DatasetAttributes
 
getDataSize() - Method in class jhplot.stat.limit.StatConfidence
Get number of experiments
getDataSize(int) - Method in class org.jlab.groot.data.GraphErrors
 
getDataSize(int) - Method in class org.jlab.groot.data.H1F
 
getDataSize(int) - Method in class org.jlab.groot.data.H2F
 
getDataSize(int) - Method in interface org.jlab.groot.data.IDataSet
 
getDataSize() - Method in class org.jlab.groot.io.TextFileReader
 
getDataSize(int) - Method in class org.jlab.groot.math.Func1D
 
getDataVector(String, String) - Method in class org.jlab.groot.tree.Tree
returns data vector filled with values evaluated with expression given for entries that pass the given cut
getDataVector(String, String, int) - Method in class org.jlab.groot.tree.Tree
returns data vector filled with values evaluated with expression given for entries that pass the given cut.
getDataX() - Method in class jhplot.stat.LinReg
Get an array with X data
getDataX() - Method in class jhplot.stat.LinRegWeighted
Get an array with X data
getDataX(int) - Method in class org.jlab.groot.data.GraphErrors
 
getDataX(int) - Method in class org.jlab.groot.data.H1F
 
getDataX(int) - Method in class org.jlab.groot.data.H2F
 
getDataX(int) - Method in interface org.jlab.groot.data.IDataSet
 
getDataX(int) - Method in class org.jlab.groot.math.Func1D
 
getDataY() - Method in class jhplot.stat.LinReg
Get an array with Y data
getDataY() - Method in class jhplot.stat.LinRegWeighted
Get an array with Y data
getDataY(int) - Method in class org.jlab.groot.data.GraphErrors
 
getDataY(int) - Method in class org.jlab.groot.data.H1F
 
getDataY(int) - Method in class org.jlab.groot.data.H2F
 
getDataY(int) - Method in interface org.jlab.groot.data.IDataSet
 
getDataY(int) - Method in class org.jlab.groot.math.Func1D
 
getDate() - Method in class org.jfree.chart.axis.DateTick
Returns the date.
getDate(long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Converts a millisecond value into a Date object.
getDate() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns a Date that represents the reference point for this segment.
getDate() - Method in class org.jfree.data.xy.OHLCDataItem
Returns the date that the data item relates to.
getDateFormat() - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Returns a copy of the date formatter.
getDateFormat() - Method in class org.jfree.chart.labels.AbstractCategoryItemLabelGenerator
Returns the date formatter.
getDateFormat() - Method in class org.jfree.chart.urls.TimeSeriesURLGenerator
Returns a clone of the date format assigned to this URL generator.
getDateFormatOverride() - Method in class org.jfree.chart.axis.DateAxis
Returns the date format override.
getDaughter(int) - Method in class hep.lcio.implementation.event.IMCParticle
 
getDaughter1(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1Count() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1Count() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1Count() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1Count() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1Count() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1Count() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1Count() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1Count() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1Count() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1List() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1List() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1List() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1List() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1List() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1List() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1List() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1List() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter1 = 10 [packed = true];
getDaughter1List() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter1 = 10 [packed = true];
getDaughter2(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2Count() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2Count() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2Count() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2Count() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2Count() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2Count() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2Count() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2Count() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2Count() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2List() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2List() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2List() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2List() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2List() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2List() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2List() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2List() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 daughter2 = 11 [packed = true];
getDaughter2List() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 daughter2 = 11 [packed = true];
getDaughters() - Method in interface hep.lcio.event.MCParticle
Returns the daughters of this particle.
getDaughters() - Method in class hep.lcio.implementation.event.IMCParticle
 
getDaughters() - Method in class hep.physics.particle.BasicParticle
 
getDaughters() - Method in interface hep.physics.particle.Particle
Returns a list of the decay products of this particle
getDay() - Method in class org.jfree.data.time.Hour
Returns the day in which this hour falls.
getDay() - Method in class org.jfree.data.time.Minute
Returns the day.
getDayOfMonth() - Method in class org.jfree.data.time.Day
Returns the day of the month.
getDayOfMonth() - Method in class org.jfree.data.time.Hour
Returns the day-of-the-month in which this hour falls.
getDaySuffix() - Method in class org.jfree.chart.util.RelativeDateFormat
Returns the string that is appended to the day count.
getDecomposition() - Method in class org.apache.commons.math3.fitting.leastsquares.GaussNewtonOptimizer
Get the matrix decomposition algorithm used to solve the normal equations.
getdEdx() - Method in interface hep.lcio.event.SimTrackerHit
Deprecated. 
getdEdx() - Method in interface hep.lcio.event.Track
dEdx of the track.
getdEdx() - Method in interface hep.lcio.event.TrackerHit
Deprecated. 
getdEdx() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
getdEdx() - Method in class hep.lcio.implementation.event.ITrack
 
getdEdx() - Method in class hep.lcio.implementation.event.ITrackerHit
 
getdEdx() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getdEdx() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getdEdxError() - Method in interface hep.lcio.event.Track
Error of dEdx.
getdEdxError() - Method in class hep.lcio.implementation.event.ITrack
 
getDefault(String) - Static method in class jhepsim.Options
Get default property.
getDefaultAutoRange() - Method in class org.jfree.chart.axis.ValueAxis
Returns the default auto range.
getDefaultBarPainter() - Static method in class org.jfree.chart.renderer.category.BarRenderer
Returns the default bar painter.
getDefaultBarPainter() - Static method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the default bar painter.
getDefaultDirectoryForSaveAs() - Method in class org.jfree.chart.ChartPanel
Returns the default directory for the "save as" option.
getDefaultEncoding() - Method in class org.apache.commons.io.input.XmlStreamReader
Returns the default encoding to use if none is set in HTTP content-type, XML prolog and the rules based on content-type are not adequate.
getDefaultEncoding() - Method in class org.apache.commons.io.output.XmlStreamWriter
Returns the default encoding.
getDefaultEntityRadius() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the radius of the circle used for the default entity area when no area is specified.
getDefaultEventIndex() - Method in class net.java.dev.colorchooser.ColorChooserBeanInfo
A bean may have a "default" event that is the event that will mostly commonly be used by human's when using the bean.
getDefaultFont() - Static method in class jplot.Utils
Returns a new instance of a default font.
getDefaultImageIcon(String, String) - Static method in class jminhep.utils.ResourceLoader
 
getDefaultInstance() - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
getDefaultInstance() - Static method in class proeic.io.ProMC.ProMCEvent
 
getDefaultInstance() - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
getDefaultInstance() - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
getDefaultInstance() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
getDefaultInstance() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDefaultInstance() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDefaultInstance() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDefaultInstance() - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
getDefaultInstance() - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
getDefaultInstance() - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
getDefaultInstance() - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.F1D
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.F2D
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.FND
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.FPR
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.H1D
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.H2D
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.P0D
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.P0I
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.P1D
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.PND
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.PNI
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.PXY
 
getDefaultInstance() - Static method in class promc.io.PBufFile.Record.PXYZ
 
getDefaultInstance() - Static method in class promc.io.PEventFile.HEvent.Entry
 
getDefaultInstance() - Static method in class promc.io.PEventFile.HEvent
 
getDefaultInstance() - Static method in class promc.io.PEventFile.HEvent.Group
 
getDefaultInstance() - Static method in class promc.io.ProMC.ProMCEvent.Event
 
getDefaultInstance() - Static method in class promc.io.ProMC.ProMCEvent
 
getDefaultInstance() - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
getDefaultInstance() - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
getDefaultInstance() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
getDefaultInstance() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDefaultInstance() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDefaultInstance() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDefaultInstance() - Static method in class promc.io.ProMCStatFile.ProMCStat
 
getDefaultInstance() - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
getDefaultInstance() - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
getDefaultInstance() - Static method in class pronlo.io.ProMC.ProMCEvent
 
getDefaultInstance() - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
getDefaultInstance() - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
getDefaultInstance() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
getDefaultInstance() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDefaultInstance() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDefaultInstance() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDefaultInstance() - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
getDefaultInstance() - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
getDefaultInstance() - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
getDefaultInstance() - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
getDefaultInstance() - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
getDefaultInstance() - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
getDefaultInstance() - Static method in class proreco.io.ProMC.ProMCEvent
 
getDefaultInstance() - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
getDefaultInstance() - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
getDefaultInstance() - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
getDefaultInstance() - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
getDefaultInstance() - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
getDefaultInstance() - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
getDefaultInstance() - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
getDefaultInstance() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
getDefaultInstance() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDefaultInstance() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDefaultInstance() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDefaultInstance() - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
getDefaultInstance() - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
getDefaultInstanceForType() - Method in class proeic.io.ProMC.ProMCEvent.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMC.ProMCEvent.Event
 
getDefaultInstanceForType() - Method in class proeic.io.ProMC.ProMCEvent
 
getDefaultInstanceForType() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMC.ProMCEvent.Particles
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCStatFile.ProMCStat
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDefaultInstanceForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.F1D.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.F1D
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.F2D.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.F2D
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.FND.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.FND
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.FPR.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.FPR
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.H1D.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.H1D
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.H2D.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.H2D
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.P0D.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.P0D
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.P0I.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.P0I
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.P1D.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.P1D
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.PND.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.PND
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.PNI.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.PNI
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.PXY.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.PXY
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PBufFile.Record.PXYZ
 
getDefaultInstanceForType() - Method in class promc.io.PEventFile.HEvent.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PEventFile.HEvent.Entry
 
getDefaultInstanceForType() - Method in class promc.io.PEventFile.HEvent
 
getDefaultInstanceForType() - Method in class promc.io.PEventFile.HEvent.Group.Builder
 
getDefaultInstanceForType() - Method in class promc.io.PEventFile.HEvent.Group
 
getDefaultInstanceForType() - Method in class promc.io.ProMC.ProMCEvent.Builder
 
getDefaultInstanceForType() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
 
getDefaultInstanceForType() - Method in class promc.io.ProMC.ProMCEvent.Event
 
getDefaultInstanceForType() - Method in class promc.io.ProMC.ProMCEvent
 
getDefaultInstanceForType() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
 
getDefaultInstanceForType() - Method in class promc.io.ProMC.ProMCEvent.Particles
 
getDefaultInstanceForType() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDefaultInstanceForType() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
getDefaultInstanceForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDefaultInstanceForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
 
getDefaultInstanceForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDefaultInstanceForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDefaultInstanceForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDefaultInstanceForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDefaultInstanceForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDefaultInstanceForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDefaultInstanceForType() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
 
getDefaultInstanceForType() - Method in class promc.io.ProMCStatFile.ProMCStat
 
getDefaultInstanceForType() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDefaultInstanceForType() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMC.ProMCEvent.Event
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMC.ProMCEvent
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCStatFile.ProMCStat
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDefaultInstanceForType() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Event
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Jets
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.MissingET
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Muons
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Particles
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Photons
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCStatFile.ProMCStat
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDefaultInstanceForType() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
getDefaultNumberFormat() - Static method in class org.apache.commons.math3.util.CompositeFormat
Create a default number format.
getDefaultNumberFormat(Locale) - Static method in class org.apache.commons.math3.util.CompositeFormat
Create a default number format.
getDefaultPaint() - Method in class org.jfree.chart.renderer.LookupPaintScale
Returns the default paint (never null).
getDefaultPalettes(boolean) - Static method in class net.java.dev.colorchooser.Palette
Get the default set of 8 palettes used by the color chooser.
getDefaultPropertyIndex() - Method in class net.java.dev.colorchooser.ColorChooserBeanInfo
A bean may have a "default" property that is the property that will mostly commonly be initially chosen for update by human's who are customizing the bean.
getDefaultShadowsVisible() - Static method in class org.jfree.chart.renderer.category.BarRenderer
Returns the default value for the shadowsVisible flag.
getDefaultShadowsVisible() - Static method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the default value for the shadowsVisible flag.
getDefaultValue() - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
getDefinition() - Method in class fitter.BFunc
get definition
getDefinition() - Method in class promc.io.PBufFile.Record.F1D.Builder
required string definition = 2;
getDefinition() - Method in class promc.io.PBufFile.Record.F1D
required string definition = 2;
getDefinition() - Method in interface promc.io.PBufFile.Record.F1DOrBuilder
required string definition = 2;
getDefinition() - Method in class promc.io.PBufFile.Record.F2D.Builder
required string definition = 2;
getDefinition() - Method in class promc.io.PBufFile.Record.F2D
required string definition = 2;
getDefinition() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
required string definition = 2;
getDefinition() - Method in class promc.io.PBufFile.Record.FND.Builder
required string definition = 2;
getDefinition() - Method in class promc.io.PBufFile.Record.FND
required string definition = 2;
getDefinition() - Method in interface promc.io.PBufFile.Record.FNDOrBuilder
required string definition = 2;
getDefinition() - Method in class promc.io.PBufFile.Record.FPR.Builder
required string definition = 2;
getDefinition() - Method in class promc.io.PBufFile.Record.FPR
required string definition = 2;
getDefinition() - Method in interface promc.io.PBufFile.Record.FPROrBuilder
required string definition = 2;
getDefinitionBytes() - Method in class promc.io.PBufFile.Record.F1D.Builder
required string definition = 2;
getDefinitionBytes() - Method in class promc.io.PBufFile.Record.F1D
required string definition = 2;
getDefinitionBytes() - Method in interface promc.io.PBufFile.Record.F1DOrBuilder
required string definition = 2;
getDefinitionBytes() - Method in class promc.io.PBufFile.Record.F2D.Builder
required string definition = 2;
getDefinitionBytes() - Method in class promc.io.PBufFile.Record.F2D
required string definition = 2;
getDefinitionBytes() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
required string definition = 2;
getDefinitionBytes() - Method in class promc.io.PBufFile.Record.FND.Builder
required string definition = 2;
getDefinitionBytes() - Method in class promc.io.PBufFile.Record.FND
required string definition = 2;
getDefinitionBytes() - Method in interface promc.io.PBufFile.Record.FNDOrBuilder
required string definition = 2;
getDefinitionBytes() - Method in class promc.io.PBufFile.Record.FPR.Builder
required string definition = 2;
getDefinitionBytes() - Method in class promc.io.PBufFile.Record.FPR
required string definition = 2;
getDefinitionBytes() - Method in interface promc.io.PBufFile.Record.FPROrBuilder
required string definition = 2;
getDegree() - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
getDegreesOfFreedom() - Method in class jhplot.math.num.pdf.ChiSquared
Access the degrees of freedom.
getDegreesOfFreedom() - Method in class jhplot.math.num.pdf.TDistribution
Access the degrees of freedom.
getDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Access the number of degrees of freedom.
getDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.TDistribution
Access the degrees of freedom.
getDelay() - Method in class org.apache.commons.io.input.Tailer
Return the delay in milliseconds.
getDeleteFailures() - Method in class org.apache.commons.io.FileCleaningTracker
Return the file paths that failed to delete.
getDelta() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the elevation of the vector.
getDelta() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the elevation of the vector.
getDeltaEta(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEta(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEta(int) - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEta(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEta(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEta(int) - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEta(int) - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaCount() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaCount() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaCount() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaList() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaList() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaEtaList() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint32 DeltaEta = 8 [packed = true];
getDeltaPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint32 DeltaPhi = 9 [packed = true];
getDeltaPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint32 DeltaPhi = 9 [packed = true];
getDenominator() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the denominator as a BigInteger.
getDenominator() - Method in class org.apache.commons.math3.fraction.Fraction
Access the denominator.
getDenominator() - Method in class org.lsmp.djep.groupJep.values.Rational
* Returns the bottom half of the rational.
getDenominatorAsInt() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the denominator as a int.
getDenominatorAsLong() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the denominator as a long.
getDenominatorDegreesOfFreedom() - Method in class jhplot.math.num.pdf.FDistribution
Access the denominator degrees of freedom.
getDenominatorDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.FDistribution
Access the denominator degrees of freedom.
getDenominatorFormat() - Method in class org.apache.commons.math3.fraction.AbstractFormat
Access the denominator format.
getDensity() - Method in class jhplot.H1D
Get a density distribution dividing each bin of the histogram by the bin width and the total number of heights for all bins.
getDensity() - Method in class jhplot.H2D
Get a density distribution dividing each bin of the histogram by the bin width and the total number of heights for all bins.
getDepth() - Method in exception org.apache.commons.io.DirectoryWalker.CancelException
Returns the depth when the operation was cancelled.
getDepthFactor() - Method in class org.jfree.chart.plot.PiePlot3D
Returns the depth factor for the chart.
getDerivative() - Method in class jhplot.math.num.root.NewtonRootFinder
Access the derivative of the target function.
getDerivative(int) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Get the derivative with respect to a particular index variable.
getDerivative() - Method in class org.apache.commons.math3.ode.FieldODEStateAndDerivative
Get derivative of the main state at time.
getDescDataset() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getDescent(Graphics) - Method in class graph.TextLine
 
getDescName() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getDescription() - Method in interface hep.lcio.event.LCRunHeader
Description of the simulation, physics channels etc.
getDescription() - Method in class hep.lcio.implementation.event.ILCRunHeader
 
getDescription() - Method in class hep.lcio.util.CommandHandler
Get the description of this command.
getDescription() - Method in class jhplot.utils.ExtensionFileFilter
 
getDescription() - Method in class org.jfree.chart.LegendItem
Returns the description for the legend item.
getDescription() - Method in class org.jfree.data.gantt.Task
Returns the task description.
getDescription() - Method in class org.jfree.data.general.Series
Returns a description of the series.
getDescription() - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
getDescription() - Method in class org.jlab.groot.tree.Branch
 
getDescription() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
getDescription() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
getDescription() - Method in interface proeic.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
getDescription() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
getDescription() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
getDescription() - Method in interface promc.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
getDescription() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
getDescription() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
getDescription() - Method in interface pronlo.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
getDescription() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
getDescription() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
getDescription() - Method in interface proreco.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
getDescriptionBytes() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
getDescriptionBytes() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
getDescriptionBytes() - Method in interface proeic.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
getDescriptionBytes() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
getDescriptionBytes() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
getDescriptionBytes() - Method in interface promc.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
getDescriptionBytes() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
getDescriptionBytes() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
getDescriptionBytes() - Method in interface pronlo.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
getDescriptionBytes() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
getDescriptionBytes() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
getDescriptionBytes() - Method in interface proreco.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
getDescriptionString(int, boolean) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
getDescriptor() - Static method in class proeic.io.ProMC
 
getDescriptor() - Static method in class proeic.io.ProMC.ProMCEvent.Builder
 
getDescriptor() - Static method in class proeic.io.ProMC.ProMCEvent.Event.Builder
 
getDescriptor() - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
getDescriptor() - Static method in class proeic.io.ProMC.ProMCEvent
 
getDescriptor() - Static method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
 
getDescriptor() - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
getDescriptor() - Static method in class proeic.io.ProMCDescriptionFile
 
getDescriptor() - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDescriptor() - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
getDescriptor() - Static method in class proeic.io.ProMCHeaderFile
 
getDescriptor() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDescriptor() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
getDescriptor() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDescriptor() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDescriptor() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDescriptor() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDescriptor() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDescriptor() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDescriptor() - Static method in class proeic.io.ProMCStatFile
 
getDescriptor() - Static method in class proeic.io.ProMCStatFile.ProMCStat.Builder
 
getDescriptor() - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
getDescriptor() - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
 
getDescriptor() - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
getDescriptor() - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
 
getDescriptor() - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
getDescriptor() - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDescriptor() - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
getDescriptor() - Static method in class promc.io.PBufFile
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.F1D.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.F1D
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.F2D.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.F2D
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.FND.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.FND
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.FPR.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.FPR
 
getDescriptor() - Static method in class promc.io.PBufFile.Record
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.H1D.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.H1D
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.H2D.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.H2D
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.P0D.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.P0D
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.P0I.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.P0I
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.P1D.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.P1D
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.PND.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.PND
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.PNI.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.PNI
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.PXY.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.PXY
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.PXYZ.Builder
 
getDescriptor() - Static method in class promc.io.PBufFile.Record.PXYZ
 
getDescriptor() - Static method in class promc.io.PEventFile
 
getDescriptor() - Static method in class promc.io.PEventFile.HEvent.Builder
 
getDescriptor() - Static method in class promc.io.PEventFile.HEvent.Entry.Builder
 
getDescriptor() - Static method in class promc.io.PEventFile.HEvent.Entry
 
getDescriptor() - Static method in class promc.io.PEventFile.HEvent
 
getDescriptor() - Static method in class promc.io.PEventFile.HEvent.Group.Builder
 
getDescriptor() - Static method in class promc.io.PEventFile.HEvent.Group
 
getDescriptor() - Static method in class promc.io.ProMC
 
getDescriptor() - Static method in class promc.io.ProMC.ProMCEvent.Builder
 
getDescriptor() - Static method in class promc.io.ProMC.ProMCEvent.Event.Builder
 
getDescriptor() - Static method in class promc.io.ProMC.ProMCEvent.Event
 
getDescriptor() - Static method in class promc.io.ProMC.ProMCEvent
 
getDescriptor() - Static method in class promc.io.ProMC.ProMCEvent.Particles.Builder
 
getDescriptor() - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
getDescriptor() - Static method in class promc.io.ProMCDescriptionFile
 
getDescriptor() - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDescriptor() - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
getDescriptor() - Static method in class promc.io.ProMCHeaderFile
 
getDescriptor() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDescriptor() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
getDescriptor() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDescriptor() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDescriptor() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDescriptor() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDescriptor() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDescriptor() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDescriptor() - Static method in class promc.io.ProMCStatFile
 
getDescriptor() - Static method in class promc.io.ProMCStatFile.ProMCStat.Builder
 
getDescriptor() - Static method in class promc.io.ProMCStatFile.ProMCStat
 
getDescriptor() - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDescriptor() - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
getDescriptor() - Static method in class pronlo.io.ProMC
 
getDescriptor() - Static method in class pronlo.io.ProMC.ProMCEvent.Builder
 
getDescriptor() - Static method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
 
getDescriptor() - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
getDescriptor() - Static method in class pronlo.io.ProMC.ProMCEvent
 
getDescriptor() - Static method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
 
getDescriptor() - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
getDescriptor() - Static method in class pronlo.io.ProMCDescriptionFile
 
getDescriptor() - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDescriptor() - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
getDescriptor() - Static method in class pronlo.io.ProMCHeaderFile
 
getDescriptor() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDescriptor() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
getDescriptor() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDescriptor() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDescriptor() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDescriptor() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDescriptor() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDescriptor() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDescriptor() - Static method in class pronlo.io.ProMCStatFile
 
getDescriptor() - Static method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
 
getDescriptor() - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
getDescriptor() - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDescriptor() - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
getDescriptor() - Static method in class proreco.io.ProMC
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Builder
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Event.Builder
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
 
getDescriptor() - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
getDescriptor() - Static method in class proreco.io.ProMCDescriptionFile
 
getDescriptor() - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDescriptor() - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
getDescriptor() - Static method in class proreco.io.ProMCHeaderFile
 
getDescriptor() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDescriptor() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
getDescriptor() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDescriptor() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getDescriptor() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDescriptor() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getDescriptor() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDescriptor() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getDescriptor() - Static method in class proreco.io.ProMCStatFile
 
getDescriptor() - Static method in class proreco.io.ProMCStatFile.ProMCStat.Builder
 
getDescriptor() - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
getDescriptor() - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDescriptor() - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
getDescriptorForType() - Method in class proeic.io.ProMC.ProMCEvent.Builder
 
getDescriptorForType() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
 
getDescriptorForType() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
 
getDescriptorForType() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDescriptorForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDescriptorForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDescriptorForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDescriptorForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDescriptorForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
 
getDescriptorForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
 
getDescriptorForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
 
getDescriptorForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.F1D.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.F2D.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.FND.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.FPR.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.H1D.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.H2D.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.P0D.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.P0I.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.P1D.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.PND.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.PNI.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.PXY.Builder
 
getDescriptorForType() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
 
getDescriptorForType() - Method in class promc.io.PEventFile.HEvent.Builder
 
getDescriptorForType() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
 
getDescriptorForType() - Method in class promc.io.PEventFile.HEvent.Group.Builder
 
getDescriptorForType() - Method in class promc.io.ProMC.ProMCEvent.Builder
 
getDescriptorForType() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
 
getDescriptorForType() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
 
getDescriptorForType() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDescriptorForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDescriptorForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDescriptorForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDescriptorForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDescriptorForType() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
 
getDescriptorForType() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDescriptorForType() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
 
getDescriptorForType() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
 
getDescriptorForType() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
 
getDescriptorForType() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDescriptorForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDescriptorForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDescriptorForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDescriptorForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDescriptorForType() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
 
getDescriptorForType() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMC.ProMCEvent.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
 
getDescriptorForType() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
getDescriptors() - Method in class org.jlab.groot.tree.TreeAnalyzer
 
getDescriptorType() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getDetectorName() - Method in interface hep.lcio.event.LCEvent
Returns the name of the detector setup used in the simulation.
getDetectorName() - Method in interface hep.lcio.event.LCRunHeader
Returns the name of the detector setup used in the simulation.
getDetectorName() - Method in class hep.lcio.implementation.event.ILCEvent
 
getDetectorName() - Method in class hep.lcio.implementation.event.ILCRunHeader
 
getDeterminant() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
Return the determinant of the matrix
getDeterminant() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Computes the determinant of the matrix.
getDeterminant() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Return the determinant of the matrix.
getDeterminant() - Method in class org.apache.commons.math3.linear.LUDecomposition
Return the determinant of the matrix
getDeviancePart(double, double) - Static method in class jhplot.math.num.pdf.SaddlePoint
A part of the deviance portion of the saddle point approximation.
getDeviceConfiguration() - Method in class org.jfree.chart.fx.FXGraphics2D
This method is not implemented yet.
getDiagonal(double[][], int) - Static method in class jhplot.math.DoubleArray
Extract diagonal from a matrix.
GetDiagonal - Class in org.lsmp.djep.vectorJep.function
Extracts diagonal from a square matrix.
GetDiagonal() - Constructor for class org.lsmp.djep.vectorJep.function.GetDiagonal
 
getDiagonalOfHatMatrix(double[]) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Gets the diagonal of the Hat matrix also known as the leverage matrix.
getDialBackgroundPaint() - Method in class org.jfree.chart.plot.MeterPlot
Returns the paint for the dial background.
getDialFrame() - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the dial's frame.
getDialLayer() - Method in class org.jfree.chart.plot.dial.DialLayerChangeEvent
Returns the layer that generated the event.
getDialOutlinePaint() - Method in class org.jfree.chart.plot.MeterPlot
Returns the dial outline paint.
getDialShape() - Method in class org.jfree.chart.plot.MeterPlot
Returns the dial shape.
getDifferentationVisitor() - Method in class org.lsmp.djep.djep.DJep
Returns the visitor used for differentiation.
getDim() - Method in class fitter.BFunc
get dimention
getDim() - Method in class graph.Contour
return the dimensions of the grid
getDim() - Method in class jplot.Contour
return the dimensions of the grid
getDim() - Method in class org.lsmp.djep.matrixJep.nodeTypes.ASTMConstant
 
getDim() - Method in class org.lsmp.djep.matrixJep.nodeTypes.ASTMFunNode
 
getDim() - Method in class org.lsmp.djep.matrixJep.nodeTypes.ASTMVarNode
 
getDim() - Method in interface org.lsmp.djep.matrixJep.nodeTypes.MatrixNodeI
 
getDim() - Method in class org.lsmp.djep.vectorJep.values.Matrix
 
getDim() - Method in interface org.lsmp.djep.vectorJep.values.MatrixValueI
Returns the dimension of this object.
getDim() - Method in class org.lsmp.djep.vectorJep.values.MVector
 
getDim() - Method in class org.lsmp.djep.vectorJep.values.Scaler
 
getDim() - Method in class org.lsmp.djep.vectorJep.values.Tensor
 
getDimension() - Method in class jhplot.P1D
Returns the dimension of this P1D holder.
getDimension() - Method in class jhplot.PND
Get last dimension of the data (or number of columns).
getDimension() - Method in class jhplot.PNI
Get last dimension of the data (or number of columns).
getDimension() - Method in class jminhep.cluster.DataPoint
Get dimension of the point
getDimension() - Method in class jplot.DataArray
Return the dimension of this data
getDimension(String, Dimension) - Method in class jplot.XMLRead
Returns the value of a specific element, which must be a dimension.
getDimension() - Method in class org.apache.commons.math3.analysis.interpolation.InterpolatingMicrosphere
Get the space dimensionality.
getDimension() - Method in class org.apache.commons.math3.distribution.AbstractMultivariateRealDistribution
Gets the number of random variables of the distribution.
getDimension() - Method in interface org.apache.commons.math3.distribution.MultivariateRealDistribution
Gets the number of random variables of the distribution.
getDimension() - Method in exception org.apache.commons.math3.exception.DimensionMismatchException
 
getDimension() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D
Get the dimension of the space.
getDimension() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Euclidean3D
Get the dimension of the space.
getDimension() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Euclidean2D
Get the dimension of the space.
getDimension() - Method in interface org.apache.commons.math3.geometry.Space
Get the dimension of the space.
getDimension() - Method in class org.apache.commons.math3.geometry.spherical.oned.Sphere1D
Get the dimension of the space.
getDimension() - Method in class org.apache.commons.math3.geometry.spherical.twod.Sphere2D
Get the dimension of the space.
getDimension() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Returns the size of the vector.
getDimension() - Method in interface org.apache.commons.math3.linear.FieldVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math3.linear.RealVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math3.ode.EquationsMapper
Get the dimension of the secondary state parameters.
getDimension() - Method in interface org.apache.commons.math3.ode.FieldSecondaryEquations
Get the dimension of the secondary state parameters.
getDimension() - Method in class org.apache.commons.math3.ode.FirstOrderConverter
Get the dimension of the problem.
getDimension() - Method in interface org.apache.commons.math3.ode.FirstOrderDifferentialEquations
Get the dimension of the problem.
getDimension() - Method in interface org.apache.commons.math3.ode.FirstOrderFieldDifferentialEquations
Get the dimension of the problem.
getDimension() - Method in interface org.apache.commons.math3.ode.SecondaryEquations
Get the dimension of the secondary state parameters.
getDimension() - Method in interface org.apache.commons.math3.ode.SecondOrderDifferentialEquations
Get the dimension of the problem.
getDimension() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get simplex dimension.
getDimension() - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated.
Get simplex dimension.
getDimension() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the dimension of the data
getDimension() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns the dimension of the data
getDimension() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the dimension of the data
getDimension() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Get the number of dimensions of the multidimensional counter.
getDimension() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getDimension(int) - Method in class org.jlab.groot.math.Dimension2D
 
getDimension(int) - Method in class org.jlab.groot.math.Dimension3D
 
getDimension() - Method in class org.jlab.groot.ui.GraphicsAxis
 
getDimension() - Method in class org.jlab.groot.ui.GraphicsAxisFrame
 
getDimension() - Method in class promc.io.PBufFile.Record.PND.Builder
required int32 dimension = 3;
getDimension() - Method in class promc.io.PBufFile.Record.PND
required int32 dimension = 3;
getDimension() - Method in interface promc.io.PBufFile.Record.PNDOrBuilder
required int32 dimension = 3;
getDimension() - Method in class promc.io.PBufFile.Record.PNI.Builder
required int32 dimension = 3;
getDimension() - Method in class promc.io.PBufFile.Record.PNI
required int32 dimension = 3;
getDimension() - Method in interface promc.io.PBufFile.Record.PNIOrBuilder
required int32 dimension = 3;
getDimensions() - Method in class jhplot.PND
Get the numbers of columns.
getDimensions() - Method in class jhplot.PNI
Get the numbers of columns.
getDimensions() - Method in class org.lsmp.djep.matrixJep.MatrixPartialDerivative
 
getDimensions() - Method in class org.lsmp.djep.matrixJep.MatrixVariable
 
getDimensions() - Method in interface org.lsmp.djep.matrixJep.MatrixVariableI
The dimension of the variable.
getDimensionTicks(int) - Method in class org.jlab.groot.math.Dimension1D
returns an array of nice numbers to represent the dimension as axis.
getDimensionTicksLog(int) - Method in class org.jlab.groot.math.Dimension1D
 
getDimention() - Method in class jminhep.cluster.DataHolder
Get the dimension of the data
getDims() - Method in class org.lsmp.djep.mrpe.MRpRes
The Dimension of the object
getDir() - Method in class org.jlab.groot.data.Directory
 
getDir(String) - Method in class org.jlab.groot.data.Directory
 
getDirection() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
 
getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get the normalized direction vector.
getDirection() - Method in class org.jfree.chart.plot.PiePlot
Returns the direction in which the pie sections are drawn (clockwise or anti-clockwise).
getDirection() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the direction in which the radar axes are drawn (clockwise or anti-clockwise).
getDirectionCode(double) - Method in class org.jfree.chart.axis.CompassFormat
Returns a string representing the direction.
getDirectionError() - Method in interface hep.lcio.event.Cluster
Covariance matrix of the direction (3 Parameters).
getDirectionError() - Method in class hep.lcio.implementation.event.ICluster
 
getDirectory() - Method in class org.apache.commons.io.monitor.FileAlterationObserver
Returns the directory being observed.
getDirectoryByPath(String) - Method in class org.jlab.groot.data.Directory
 
getDirectoryCounter() - Method in interface org.apache.commons.io.file.Counters.PathCounters
Gets the directory counter.
getDirectoryList() - Method in class org.jlab.groot.data.Directory
 
getDirectoryMap() - Method in class org.jlab.groot.data.Directory
returns map of subdirectories.
getDirectoryPath(Directory) - Method in class org.jlab.groot.data.Directory
returns list of
getDirectoryPath() - Method in class org.jlab.groot.data.Directory
return a String representing full path to current directory.
getDirList() - Method in class org.apache.commons.io.file.AccumulatorPathVisitor
Gets the list of visited directories.
getDismissDelay() - Method in class org.jfree.chart.ChartPanel
Returns the dismissal tooltip delay value used inside this chart panel.
getDispDivisions() - Method in interface jplot3d.SurfaceModel
 
getDispDivisions() - Method in class jplot3d.SurfaceModelCanvas
 
getDisplay(String) - Static method in class jminhep.utils.ResourceLoader
 
getDisplayEnd() - Method in class org.jfree.chart.axis.ModuloAxis
Returns the display end value.
getDisplayName() - Method in class net.java.dev.colorchooser.Palette
 
getDisplayStart() - Method in class org.jfree.chart.axis.ModuloAxis
Returns the display start value.
getDisplayXY() - Method in class jplot3d.SurfaceModelCanvas
 
getDisplayZ() - Method in class jplot3d.SurfaceModelCanvas
 
getDistance(ParticleF, ParticleF) - Method in class hephysics.jet.KTjet
Calculate R distance in eta-phi.
getDistance(ParticleD, ParticleD) - Method in class hephysics.jet.SCJet
Calculate R distance in y-phi.
getDistance() - Method in class jhplot.HPlot3D
Get the distance
getDistance() - Method in class jplot3d.Projector
Gets the projector distance.
getDistance() - Method in class jplot3d.SurfaceModelCanvas
 
getDistance(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Distance between two vectors.
getDistance(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Optimized method to compute distance.
getDistance(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Distance between two vectors.
getDistance(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Distance between two vectors.
getDistance() - Method in class org.jfree.chart.util.DefaultShadowGenerator
Returns the shadow offset distance.
getDistanceMeasure() - Method in class org.apache.commons.math3.ml.clustering.Clusterer
Returns the DistanceMeasure instance used by this clusterer.
getDivide() - Method in class org.nfunk.jep.OperatorSet
 
getDividedByBinWidth() - Method in class jhplot.H1D
Divide heights of each bin by the bin width.
getDividerPaint() - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Returns the paint used to draw the dividers.
getDividerStroke() - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Returns the stroke used to draw the dividers.
getDivU() - Method in class jhplot.FPR
Get number of divisions for U
getDivU() - Method in class promc.io.PBufFile.Record.FPR.Builder
required int32 divU = 3;
getDivU() - Method in class promc.io.PBufFile.Record.FPR
required int32 divU = 3;
getDivU() - Method in interface promc.io.PBufFile.Record.FPROrBuilder
required int32 divU = 3;
getDivV() - Method in class jhplot.FPR
Get number of divisions for V
getDivV() - Method in class promc.io.PBufFile.Record.FPR.Builder
required int32 divV = 4;
getDivV() - Method in class promc.io.PBufFile.Record.FPR
required int32 divV = 4;
getDivV() - Method in interface promc.io.PBufFile.Record.FPROrBuilder
required int32 divV = 4;
getDnames() - Method in class org.lsmp.djep.djep.PartialDerivative
 
getDOF1() - Method in class jhplot.stat.Anova
The first degree of freedom is equal to the number of sample groups, minus 1.
getDOF2() - Method in class jhplot.stat.Anova
The second degree of freedom is equal to the total number of data points, minus the number of samples.
getDomainAxis() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the domain axis for the plot.
getDomainAxis(int) - Method in class org.jfree.chart.plot.CategoryPlot
Returns a domain axis.
getDomainAxis() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the domain axis for the plot.
getDomainAxis() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns the domain axis for the plot.
getDomainAxis() - Method in class org.jfree.chart.plot.XYPlot
Returns the domain axis with index 0.
getDomainAxis(int) - Method in class org.jfree.chart.plot.XYPlot
Returns the domain axis with the specified index, or null if there is no axis with that index.
getDomainAxisCount() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the number of domain axes.
getDomainAxisCount() - Method in class org.jfree.chart.plot.XYPlot
Returns the number of domain axes.
getDomainAxisEdge() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the domain axis edge.
getDomainAxisEdge(int) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the edge for a domain axis.
getDomainAxisEdge() - Method in class org.jfree.chart.plot.XYPlot
Returns the edge for the primary domain axis (taking into account the plot's orientation).
getDomainAxisEdge(int) - Method in class org.jfree.chart.plot.XYPlot
Returns the edge for a domain axis.
getDomainAxisForDataset(int) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the domain axis for a dataset.
getDomainAxisForDataset(int) - Method in class org.jfree.chart.plot.XYPlot
Returns the domain axis for a dataset.
getDomainAxisIndex(CategoryAxis) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the index of the specified axis, or -1 if the axis is not assigned to the plot.
getDomainAxisIndex() - Method in class org.jfree.chart.plot.CrosshairState
Deprecated.
As of version 1.0.11, the domain axis should be determined using the dataset index.
getDomainAxisIndex(ValueAxis) - Method in class org.jfree.chart.plot.XYPlot
Returns the index of the given domain axis.
getDomainAxisLocation() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the domain axis location for the primary domain axis.
getDomainAxisLocation(int) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the location for a domain axis.
getDomainAxisLocation() - Method in class org.jfree.chart.plot.XYPlot
Returns the location of the primary domain axis.
getDomainAxisLocation(int) - Method in class org.jfree.chart.plot.XYPlot
Returns the location for a domain axis.
getDomainBounds(boolean) - Method in interface org.jfree.data.DomainInfo
Returns the range of the values in this dataset's domain.
getDomainBounds(boolean) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the range of the values in this dataset's domain.
getDomainBounds(boolean) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the range of the values in this dataset's domain.
getDomainBounds(boolean) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the range of the values in this dataset's domain.
getDomainBounds(List, boolean) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the bounds of the domain values for the specified series.
getDomainBounds(boolean) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the range of the values in this dataset's domain.
getDomainBounds(boolean) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the range of the values in this dataset's domain.
getDomainBounds(boolean) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the range of the values in this dataset's domain.
getDomainBounds(boolean) - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns the range of the values in the dataset's domain, including or excluding the interval around each x-value as specified.
getDomainBounds(List, boolean) - Method in interface org.jfree.data.xy.XYDomainInfo
Returns the range of the values in this dataset's domain.
getDomainBounds(boolean) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the range of the values in this dataset's domain.
getDomainCrosshairColumnKey() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the column key for the domain crosshair.
getDomainCrosshairPaint() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the paint used to draw the domain crosshair.
getDomainCrosshairPaint() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the domain crosshair color.
getDomainCrosshairPaint() - Method in class org.jfree.chart.plot.XYPlot
Returns the domain crosshair paint.
getDomainCrosshairRowKey() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the row key for the domain crosshair.
getDomainCrosshairs() - Method in class org.jfree.chart.panel.CrosshairOverlay
Returns a new list containing the domain crosshairs for this overlay.
getDomainCrosshairStroke() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the stroke used to draw the domain crosshair.
getDomainCrosshairStroke() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the Stroke used to draw the crosshair (if visible).
getDomainCrosshairStroke() - Method in class org.jfree.chart.plot.XYPlot
Returns the Stroke used to draw the crosshair (if visible).
getDomainCrosshairValue() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the domain crosshair value.
getDomainCrosshairValue() - Method in class org.jfree.chart.plot.XYPlot
Returns the domain crosshair value.
getDomainDescription() - Method in class org.jfree.data.time.TimePeriodValues
Returns the domain description.
getDomainDescription() - Method in class org.jfree.data.time.TimeSeries
Returns the domain description.
getDomainGridlinePaint() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the paint used to draw grid-lines against the domain axis.
getDomainGridlinePaint() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns the paint for the grid lines (if any) plotted against the domain axis.
getDomainGridlinePaint() - Method in class org.jfree.chart.plot.XYPlot
Returns the paint for the grid lines (if any) plotted against the domain axis.
getDomainGridlinePaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the domain grid line paint.
getDomainGridlinePosition() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the position used for the domain gridlines.
getDomainGridlineStroke() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the stroke used to draw grid-lines against the domain axis.
getDomainGridlineStroke() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns the stroke for the grid-lines (if any) plotted against the domain axis.
getDomainGridlineStroke() - Method in class org.jfree.chart.plot.XYPlot
Returns the stroke for the grid-lines (if any) plotted against the domain axis.
getDomainIsPointsInTime() - Method in class org.jfree.data.time.TimePeriodValuesCollection
Deprecated.
This flag is no longer used by JFreeChart (as of version 1.0.3).
getDomainIsPointsInTime() - Method in class org.jfree.data.time.TimeSeriesCollection
Deprecated.
This flag is no longer used (as of 1.0.1).
getDomainIsPointsInTime() - Method in class org.jfree.data.time.TimeTableXYDataset
Returns a flag that controls whether the domain is treated as 'points in time'.
getDomainLowerBound(boolean) - Method in interface org.jfree.data.DomainInfo
Returns the minimum x-value in the dataset.
getDomainLowerBound(boolean) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the minimum x-value in the dataset.
getDomainLowerBound(boolean) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the minimum x-value in the dataset.
getDomainLowerBound(boolean) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the minimum x-value in the dataset.
getDomainLowerBound(boolean) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the minimum x-value in the dataset.
getDomainLowerBound(boolean) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the minimum x-value in the dataset.
getDomainLowerBound(boolean) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the minimum x-value in the dataset.
getDomainLowerBound(boolean) - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns the minimum x-value in the dataset.
getDomainLowerBound(boolean) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the minimum x-value in the dataset.
getDomainMarkers(Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the list of domain markers (read only) for the specified layer.
getDomainMarkers(int, Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Returns a collection of domain markers for a particular renderer and layer.
getDomainMarkers(Layer) - Method in class org.jfree.chart.plot.XYPlot
Returns the list of domain markers (read only) for the specified layer.
getDomainMarkers(int, Layer) - Method in class org.jfree.chart.plot.XYPlot
Returns a collection of domain markers for a particular renderer and layer.
getDomainMinorGridlinePaint() - Method in class org.jfree.chart.plot.XYPlot
Returns the paint for the minor grid lines (if any) plotted against the domain axis.
getDomainMinorGridlineStroke() - Method in class org.jfree.chart.plot.XYPlot
Returns the stroke for the minor grid-lines (if any) plotted against the domain axis.
getDomainOrder() - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the order of the domain (or X) values returned by the dataset.
getDomainOrder() - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the order of the domain values in this dataset.
getDomainOrder() - Method in class org.jfree.data.xy.AbstractXYDataset
Returns the order of the domain (X) values.
getDomainOrder() - Method in class org.jfree.data.xy.DefaultXYDataset
Returns the order of the domain (x-) values in the dataset.
getDomainOrder() - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns the order of the domain (x-) values in the dataset.
getDomainOrder() - Method in interface org.jfree.data.xy.XYDataset
Returns the order of the domain (or X) values returned by the dataset.
getDomainOrder() - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the order of the domain (X) values, if this is known.
getDomainTickBandPaint() - Method in class org.jfree.chart.plot.XYPlot
Returns the paint used for the domain tick bands.
getDomainUpperBound(boolean) - Method in interface org.jfree.data.DomainInfo
Returns the maximum x-value in the dataset.
getDomainUpperBound(boolean) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the maximum x-value in the dataset.
getDomainUpperBound(boolean) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the maximum x-value in the dataset.
getDomainUpperBound(boolean) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the maximum x-value in the dataset.
getDomainUpperBound(boolean) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the maximum x-value in the dataset.
getDomainUpperBound(boolean) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the maximum x-value in the dataset.
getDomainUpperBound(boolean) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the maximum x-value in the dataset.
getDomainUpperBound(boolean) - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns the maximum x-value in the dataset.
getDomainUpperBound(boolean) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the maximum x-value in the dataset.
getDomainZeroBaselinePaint() - Method in class org.jfree.chart.plot.XYPlot
Returns the paint for the zero baseline (if any) plotted against the domain axis.
getDomainZeroBaselineStroke() - Method in class org.jfree.chart.plot.XYPlot
Returns the stroke used for the zero baseline against the domain axis.
getDot() - Method in class org.nfunk.jep.OperatorSet
 
getDotHeight() - Method in class org.jfree.chart.renderer.xy.XYDotRenderer
Returns the dot height (the default value is 1).
getDotWidth() - Method in class org.jfree.chart.renderer.xy.XYDotRenderer
Returns the dot width (the default value is 1).
getDouble(String) - Method in class fitter.SEditor
 
getDouble(int) - Method in class graph.Axis
Return the data value equivalent of the passed pixel position.
getDouble(String, double) - Method in class jplot.XMLRead
Returns the value of a number (double) element.
getDouble() - Method in class org.jlab.groot.ui.DoubleSpinner
Returns the current value as a Double
getDoublePivot() - Method in class Jama.LUDecomposition
Return pivot permutation vector as a one-dimensional double array
getDoublePivot() - Method in class jhplot.math.kalman.jama.LUDecomposition
Return pivot permutation vector as a one-dimensional double array
getDoubleProperty(String) - Method in class hep.lcio.util.SIODump.Resolver
 
getDoubleVal(int) - Method in interface hep.lcio.event.LCGenericObject
Returns the double value for the given index.
getDoubleVal(int) - Method in class hep.lcio.example.CalibrationConstant
 
getDoubleVal(int) - Method in class hep.lcio.implementation.event.ILCGenericObject
 
getDownArrow() - Method in class org.jfree.chart.axis.ValueAxis
Returns a shape that can be displayed as an arrow pointing downwards at the end of an axis line.
getDownPaint() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns the paint used to fill candles when the price moves down from open to close.
getDrawAsLine() - Method in class org.jfree.chart.plot.CategoryMarker
Returns the flag that controls whether the marker is drawn as a region or a line.
getDrawBorder() - Method in class org.jfree.chart.plot.CompassPlot
Returns a flag that controls whether or not a border is drawn.
getDrawBorder() - Method in class org.jfree.chart.plot.MeterPlot
Returns a flag that controls whether or not a rectangular border is drawn around the plot area.
getDrawCloseTicks() - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Returns the flag that controls whether close ticks are drawn.
getDrawDividers() - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Returns a flag that controls whether or not dividers are drawn.
getDrawingSupplier() - Method in class org.jfree.chart.plot.Plot
Returns the drawing supplier for the plot.
getDrawingSupplier() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the drawing supplier from the plot.
getDrawingSupplier() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the drawing supplier from the plot.
getDrawingSupplier() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns the drawing supplier from the plot.
getDrawingSupplier() - Method in class org.jfree.chart.renderer.WaferMapRenderer
Returns the drawing supplier from the plot.
getDrawingSupplier() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the drawing supplier from the plot.
getDrawingSupplier() - Method in class org.jfree.chart.StandardChartTheme
Returns a clone of the drawing supplier for this theme.
getDrawOpenTicks() - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Returns the flag that controls whether open ticks are drawn.
getDrawOption() - Method in class jhplot.DrawOptions
Get the drawing attributes
getDrawOptions() - Method in class jhplot.DrawOptions
Get all drawing options in form of a string
getDrawOptions() - Method in class org.jlab.groot.base.DatasetAttributes
 
getDrawOutlines() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns true if outlines should be drawn for shapes, and false otherwise.
getDrawOutlines() - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Returns true if outlines should be drawn for shapes, and false otherwise.
getDrawOutlines() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns true if outlines should be drawn for shapes, and false otherwise.
getDrawOutlines() - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Returns true if outlines should be drawn for shapes, and false otherwise.
getDrawOutlineWhenFilled() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns true if the renderer will draw an outline around a filled polygon, false otherwise.
getDrawPaint() - Method in class org.jfree.chart.ClipPath
Deprecated.
Returns the drawPaint.
getDrawSeriesLineAsPath() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns a flag that controls whether or not each series is drawn as a single path.
getDrawSeriesLineAsPath() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns a flag that controls whether or not each series is drawn as a single path.
getDrawSharedDomainAxis() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the flag that controls whether or not the shared domain axis is drawn for each subplot.
getDrawStroke() - Method in class org.jfree.chart.ClipPath
Deprecated.
Returns the drawStroke.
getDrawVolume() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns a flag indicating whether or not volume bars are drawn on the chart.
getDrawXError() - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Returns the flag that controls whether or not the renderer draws error bars for the x-values.
getDrawYError() - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Returns the flag that controls whether or not the renderer draws error bars for the y-values.
getdRPhi() - Method in interface hep.lcio.event.TrackerHitZCylinder
Measurement error along RPhi
getdRPhi() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getdU() - Method in interface hep.lcio.event.TrackerHitPlane
Measurement error along u
getdU() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getDuration() - Method in class org.jfree.data.gantt.Task
Returns the duration (actual or estimated) of the task.
getdV() - Method in interface hep.lcio.event.TrackerHitPlane
Measurement error along v
getdV() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getDX(int) - Method in class jhplot.P3D
Return a specific dX-value.
getDX(int) - Method in class jplot.DataArray3D
Return a specific DX-value.
getDX() - Method in class jplot.PlotPoint3D
Return the current dX-value.
getDX() - Method in class jplot3d.JPoint
Return the current DX-value.
getDY(int) - Method in class jhplot.P3D
Return a specific dY-value.
getDY(int) - Method in class jplot.DataArray3D
Return a specific DY-value.
getDY() - Method in class jplot.PlotPoint3D
Return the current dY-value.
getDY() - Method in class jplot3d.JPoint
Return the current DY-value.
getDynamicTree() - Method in class org.jlab.groot.tree.Tree
 
getdZ() - Method in interface hep.lcio.event.TrackerHitZCylinder
Measurement error along z
getdZ() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getDZ(int) - Method in class jhplot.P3D
Return a specific dZ-value.
getDZ(int) - Method in class jplot.DataArray3D
Return a specific DZ-value.
getDZ() - Method in class jplot.PlotPoint3D
Return the current dZ-value.
getDZ() - Method in class jplot3d.JPoint
Return the current DZ-value.
getE() - Method in class hephysics.vec.HepLorentzVector
Get energy (as e())
getE() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant e.
getEccentricity() - Method in class jhplot.stat.EEcentricity
Get eccentricity, defined as 1-VarianceMin / VarianceMax.
getECM() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
getECM() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double eCM = 10;
getECM() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double eCM = 10;
getECM() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
getECM() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double eCM = 10;
getECM() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double eCM = 10;
getECM() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
getECM() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double eCM = 10;
getECM() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double eCM = 10;
getECM() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
getECM() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double eCM = 10;
getECM() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double eCM = 10;
getEDep() - Method in interface hep.lcio.event.SimTrackerHit
The energy deposited on the hit [GeV]
getEDep() - Method in interface hep.lcio.event.TrackerHit
The energy deposited on the hit [GeV]
getEDep() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
getEDep() - Method in class hep.lcio.implementation.event.ITrackerHit
 
getEDep() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getEDep() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getEDepError() - Method in interface hep.lcio.event.TrackerHit
The error measured on EDep [GeV]
getEDepError() - Method in class hep.lcio.implementation.event.ITrackerHit
 
getEDepError() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getEDepError() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getEdges(int) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double edges = 7 [packed = true];
getEdges(int) - Method in class promc.io.PBufFile.Record.H1D
repeated double edges = 7 [packed = true];
getEdges(int) - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double edges = 7 [packed = true];
getEdgesCount() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double edges = 7 [packed = true];
getEdgesCount() - Method in class promc.io.PBufFile.Record.H1D
repeated double edges = 7 [packed = true];
getEdgesCount() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double edges = 7 [packed = true];
getEdgesList() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double edges = 7 [packed = true];
getEdgesList() - Method in class promc.io.PBufFile.Record.H1D
repeated double edges = 7 [packed = true];
getEdgesList() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double edges = 7 [packed = true];
getEditor() - Method in class jhepsim.mainGUI
Return editor
getEigenvalue(int) - Method in class jhplot.math.pca.PCA
Get selected eigenvalue
getEigenvalue(int) - Method in class jhplot.stat.PCA
Information about eigenvalues
getEigenvalueTot(int) - Method in class jhplot.stat.PCA
Express eigenvalues as percentage of total
getEigenvector(int) - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets a copy of the ith eigenvector of the original matrix.
getEigenvectorsMatrix() - Method in class jhplot.math.pca.PCA
 
getEle(int) - Method in class org.lsmp.djep.vectorJep.values.Matrix
 
getEle(int, int) - Method in class org.lsmp.djep.vectorJep.values.Matrix
 
getEle(int) - Method in interface org.lsmp.djep.vectorJep.values.MatrixValueI
gets the i-th element, treats data a a linear array.
getEle(int) - Method in class org.lsmp.djep.vectorJep.values.MVector
 
getEle(int) - Method in class org.lsmp.djep.vectorJep.values.Scaler
 
getEle(int) - Method in class org.lsmp.djep.vectorJep.values.Tensor
 
getElectrons() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Electrons electrons = 6;
getElectrons() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Electrons electrons = 6;
getElectrons() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Electrons electrons = 6;
getElectronsBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Electrons electrons = 6;
getElectronsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Electrons electrons = 6;
getElectronsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Electrons electrons = 6;
getElectronsOrBuilder() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Electrons electrons = 6;
getElement(int) - Method in class jminhep.cluster.DataHolder
Get array of elements at position n of the data holder
getElement() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
Deprecated.
Get the contained element.
getElement(int) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the element at the specified index
getElement(int) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the element at the specified index
getElement(int) - Method in interface org.apache.commons.math3.util.DoubleArray
Returns the element at the specified index.
getElement(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns the element at the specified index
getElement() - Method in class org.nfunk.jep.OperatorSet
 
getElementAt(int) - Method in interface hep.lcio.event.LCCollection
Returns pointer to element at index - no range check, use getNumberOfEntries().
getElementAt(int) - Method in class hep.lcio.implementation.event.ILCCollection
 
getElements() - Method in interface org.apache.commons.math3.util.DoubleArray
Returns a double[] array containing the elements of this DoubleArray.
getElements() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns a double array containing the elements of this ResizableArray.
getEles() - Method in class org.lsmp.djep.vectorJep.values.Matrix
 
getEles() - Method in class org.lsmp.djep.vectorJep.values.MVector
 
getElevationAngle() - Method in class jhplot.HPlot3D
Get the angle
getElevationAngle() - Method in class jplot3d.Projector
Gets current elevation angle.
getElevationAngle() - Method in class jplot3d.SurfaceModelCanvas
 
getElitismRate() - Method in class org.apache.commons.math3.genetics.ElitisticListPopulation
Access the elitism rate.
getEmpiricalDistribution() - Method in class org.apache.commons.math3.random.ValueServer
Returns the EmpiricalDistribution used when operating in 0.
getEmptyClusterStrategy() - Method in class org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer
Returns the KMeansPlusPlusClusterer.EmptyClusterStrategy used by this instance.
getEnclosingCap() - Method in class org.apache.commons.math3.geometry.spherical.twod.SphericalPolygonsSet
Get a spherical cap enclosing the polygon.
getEncodedString(int) - Method in class org.jlab.groot.group.DataGroupDescriptor
 
getEncoding() - Method in class org.apache.commons.io.input.XmlStreamReader
Returns the charset encoding of the XmlStreamReader.
getEncoding() - Method in class org.apache.commons.io.output.XmlStreamWriter
Returns the detected encoding.
getEnd() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Segment
Get the end point of the segment.
getEnd() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Segment
Get the end point of the segment.
getEnd() - Method in class org.apache.commons.math3.geometry.spherical.twod.Edge
Get end vertex.
getEnd() - Method in class org.jfree.data.time.RegularTimePeriod
Returns the date/time that marks the end of the time period.
getEnd() - Method in class org.jfree.data.time.SimpleTimePeriod
Returns the end date/time.
getEnd() - Method in interface org.jfree.data.time.TimePeriod
Returns the end date/time.
getEndBoundary() - Method in class org.jfree.data.statistics.HistogramBin
Returns the end boundary.
getEndColor() - Method in class jplot.LinePars
Returns the end color of the pen.
getEndColumn() - Method in class jplot3dp.MathParser.SimpleCharStream
 
getEndColumn() - Method in class org.nfunk.jep.JavaCharStream
 
getEndLength() - Method in class jhplot.shapes.Arrow
Get length of the ends
getEndLine() - Method in class jplot3dp.MathParser.SimpleCharStream
 
getEndLine() - Method in class org.nfunk.jep.JavaCharStream
 
getEndMillis() - Method in class org.jfree.data.time.SimpleTimePeriod
Returns the end date/time in milliseconds.
getEndPercent() - Method in class org.jfree.chart.renderer.category.GanttRenderer
Returns the position of the end of the progress indicator, as a percentage of the bar width.
getEndpoint() - Method in interface hep.lcio.event.MCParticle
Returns the endpoint of the particle in [mm] if the endpoint has been set explicetly.
getEndpoint() - Method in class hep.lcio.implementation.event.IMCParticle
 
getEndType() - Method in class org.jfree.chart.renderer.category.AreaRenderer
Returns a token that controls how the renderer draws the end points.
getEndValue() - Method in class org.jfree.chart.plot.IntervalMarker
Returns the end value for the interval.
getEndValue(Comparable, Comparable) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the end data value for one category in a series.
getEndValue(int, int) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the end data value for one category in a series.
getEndValue(int, int) - Method in interface org.jfree.data.category.IntervalCategoryDataset
Returns the end value for the interval for a given series and category.
getEndValue(Comparable, Comparable) - Method in interface org.jfree.data.category.IntervalCategoryDataset
Returns the end value for the interval for a given series and category.
getEndValue(int, int, int) - Method in interface org.jfree.data.gantt.GanttCategoryDataset
Returns the end value of a sub-interval for a given item.
getEndValue(Comparable, Comparable, int) - Method in interface org.jfree.data.gantt.GanttCategoryDataset
Returns the end value of a sub-interval for a given item.
getEndValue(Comparable, Comparable, int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the end value of a sub-interval for a given item.
getEndValue(int, int, int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the end value of a sub-interval for a given item.
getEndValue(Comparable, Comparable) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the end value for the interval for a given series and category.
getEndValue(int, int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the end value for the interval for a given series and category.
getEndValue(Comparable, Comparable) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the end value for a task.
getEndValue(int, int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the end value for a task.
getEndValue(int, int, int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the end value of a sub-interval for a given item.
getEndValue(Comparable, Comparable, int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the end value of a sub-interval for a given item.
getEndVertex() - Method in interface hep.lcio.event.ReconstructedParticle
The vertex where the particle decays This method actually returns the start vertex from the first daughter particle found
getEndVertex() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getEndWidth() - Method in class jhplot.shapes.Arrow
Get widths of the ends
getEndX(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the ending date/time for the specified item (task) in the given series, measured in milliseconds since 1-Jan-1970 (as in java.util.Date).
getEndX(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the ending X value for the specified series and item.
getEndX(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the ending X value for the specified series and item.
getEndX(int, int) - Method in class org.jfree.data.statistics.HistogramDataset
Returns the end value for a bin.
getEndX(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the ending X value for the specified series and item.
getEndX(int, int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the end x-value.
getEndX(int, int) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the ending X value for the specified series and item.
getEndX(int, int) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the ending X value for the specified series and item.
getEndX(int, int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the ending X value for the specified series and item.
getEndX(int, int) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the ending X value for the specified series and item.
getEndX(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the ending x-value for an item within a series.
getEndX(int, int) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the ending X value for the specified series and item.
getEndX(int, int) - Method in interface org.jfree.data.xy.IntervalXYDataset
Returns the upper bound of the x-interval for the specified series and item.
getEndX(int, int) - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns the end value of the x-interval for an item within a series.
getEndX(int, int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the end x-value for an item within a series.
getEndX(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the ending X value for the specified series and item.
getEndX(int, int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the end x-value for an item within a series.
getEndX(int, int) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the ending X value for the specified series and item.
getEndX(int, int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the end x-value for an item within a series.
getEndXValue(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the ending date/time for the specified item (task) in the given series, measured in milliseconds since 1-Jan-1970 (as in java.util.Date).
getEndXValue(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the end x-value (as a double primitive) for an item within a series.
getEndXValue(int, int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the end x-value (as a double primitive) for an item within a series.
getEndXValue(int, int) - Method in class org.jfree.data.xy.AbstractIntervalXYDataset
Returns the end x-value (as a double primitive) for an item within a series.
getEndXValue(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the ending x-value for an item within a series.
getEndXValue(int, int) - Method in interface org.jfree.data.xy.IntervalXYDataset
Returns the upper bound of the x-interval (as a double primitive) for the specified series and item.
getEndXValue(int, int) - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns the end value of the x-interval for an item within a series.
getEndXValue(int, int) - Method in interface org.jfree.data.xy.IntervalXYZDataset
Returns the ending X value for the specified series and item.
getEndXValue(int, int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the end x-value (as a double primitive) for an item within a series.
getEndXValue(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the ending x-value (as a double primitive) for an item within a series.
getEndXValue(int, int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the end x-value (as a double primitive) for an item within a series.
getEndY(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the ending value of the y-interval for an item in the given series.
getEndY(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the ending Y value for the specified series and item.
getEndY(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the ending Y value for the specified series and item.
getEndY(int, int) - Method in class org.jfree.data.statistics.HistogramDataset
Returns the end y-value for a bin (which is the same as the y-value, this method exists only to support the general form of the IntervalXYDataset interface).
getEndY(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the ending Y value for the specified series and item.
getEndY(int, int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the end y-value.
getEndY(int, int) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the ending Y value for the specified series and item.
getEndY(int, int) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the ending Y value for the specified series and item.
getEndY(int, int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the ending Y value for the specified series and item.
getEndY(int, int) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the ending Y value for the specified series and item.
getEndY(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the ending y-value for an item within a series.
getEndY(int, int) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the ending Y value for the specified series and item.
getEndY(int, int) - Method in interface org.jfree.data.xy.IntervalXYDataset
Returns the upper bound of the y-interval for the specified series and item.
getEndY(int, int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the end y-value for an item within a series.
getEndY(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the ending Y value for the specified series and item.
getEndY(int, int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the end y-value for an item within a series.
getEndY(int, int) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the ending Y value for the specified series and item.
getEndY(int, int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the end y-value for an item within a series.
getEndYValue(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the ending value of the y-interval for an item in the given series.
getEndYValue(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the end y-value (as a double primitive) for an item within a series.
getEndYValue(int, int) - Method in class org.jfree.data.xy.AbstractIntervalXYDataset
Returns the end y-value (as a double primitive) for an item within a series.
getEndYValue(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the ending y-value for an item within a series.
getEndYValue(int, int) - Method in interface org.jfree.data.xy.IntervalXYDataset
Returns the upper bound of the y-interval (as a double primitive) for the specified series and item.
getEndYValue(int, int) - Method in interface org.jfree.data.xy.IntervalXYZDataset
Returns the ending Y value for the specified series and item.
getEndYValue(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the ending y-value (as a double primitive) for an item within a series.
getEndYValue(int, int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the end y-value (as a double primitive) for an item within a series.
getEndYValue(int, int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the end y-value (as a double primitive) for an item within a series.
getEndZValue(int, int) - Method in interface org.jfree.data.xy.IntervalXYZDataset
Returns the ending Z value for the specified series and item.
getEnergy() - Method in interface hep.lcio.event.CalorimeterHit
Returns the energy of the hit in [GeV].
getEnergy() - Method in interface hep.lcio.event.Cluster
Energy of the cluster.
getEnergy() - Method in interface hep.lcio.event.MCParticle
Returns the energy of the particle (at the vertex) in [GeV] computed from the particle's momentum and mass - only float used in files.
getEnergy() - Method in interface hep.lcio.event.ReconstructedParticle
Energy of the reconstructed particle - only float used in files.
getEnergy() - Method in interface hep.lcio.event.SimCalorimeterHit
Returns the energy of the hit in [GeV].
getEnergy() - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
getEnergy() - Method in class hep.lcio.implementation.event.ICluster
 
getEnergy() - Method in class hep.lcio.implementation.event.IMCParticle
 
getEnergy() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getEnergy() - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
getEnergy() - Method in class hep.physics.particle.BasicParticle
 
getEnergy() - Method in interface hep.physics.particle.Particle
Energy
getEnergy(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float energy = 19 [packed = true];
getEnergy(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float energy = 19 [packed = true];
getEnergy(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float energy = 19 [packed = true];
getEnergy(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 energy = 19 [packed = true];
getEnergy(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 energy = 19 [packed = true];
getEnergy(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 energy = 19 [packed = true];
getEnergy(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Energy = 3 [packed = true];
getEnergy(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Energy = 3 [packed = true];
getEnergy(int) - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Energy = 3 [packed = true];
getEnergy(int) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Energy = 4 [packed = true];
getEnergy(int) - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated sint64 Energy = 4 [packed = true];
getEnergy(int) - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated sint64 Energy = 4 [packed = true];
getEnergyCont(int) - Method in interface hep.lcio.event.SimCalorimeterHit
Returns the energy in [GeV] of the i-th contribution to the hit.
getEnergyCont(int) - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
getEnergyCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float energy = 19 [packed = true];
getEnergyCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float energy = 19 [packed = true];
getEnergyCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float energy = 19 [packed = true];
getEnergyCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 energy = 19 [packed = true];
getEnergyCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 energy = 19 [packed = true];
getEnergyCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 energy = 19 [packed = true];
getEnergyCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Energy = 3 [packed = true];
getEnergyCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Energy = 3 [packed = true];
getEnergyCount() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Energy = 3 [packed = true];
getEnergyCount() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Energy = 4 [packed = true];
getEnergyCount() - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated sint64 Energy = 4 [packed = true];
getEnergyCount() - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated sint64 Energy = 4 [packed = true];
getEnergyError() - Method in interface hep.lcio.event.CalorimeterHit
Returns the error of the hit energy in [GeV].
getEnergyError() - Method in interface hep.lcio.event.Cluster
Returns the error on the energy of the cluster.
getEnergyError() - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
getEnergyError() - Method in class hep.lcio.implementation.event.ICluster
 
getEnergyList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float energy = 19 [packed = true];
getEnergyList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float energy = 19 [packed = true];
getEnergyList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float energy = 19 [packed = true];
getEnergyList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 energy = 19 [packed = true];
getEnergyList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 energy = 19 [packed = true];
getEnergyList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 energy = 19 [packed = true];
getEnergyList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Energy = 3 [packed = true];
getEnergyList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Energy = 3 [packed = true];
getEnergyList() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Energy = 3 [packed = true];
getEnergyList() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Energy = 4 [packed = true];
getEnergyList() - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated sint64 Energy = 4 [packed = true];
getEnergyList() - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated sint64 Energy = 4 [packed = true];
getEntities() - Method in interface org.jfree.chart.entity.EntityCollection
Returns the entities in an unmodifiable collection.
getEntities() - Method in class org.jfree.chart.entity.StandardEntityCollection
Returns the entities in an unmodifiable collection.
getEntity() - Method in class org.jfree.chart.ChartMouseEvent
Returns the chart entity (if any) under the mouse point.
getEntity(double, double) - Method in interface org.jfree.chart.entity.EntityCollection
Returns an entity whose area contains the specified point.
getEntity(int) - Method in interface org.jfree.chart.entity.EntityCollection
Returns an entity from the collection.
getEntity(int) - Method in class org.jfree.chart.entity.StandardEntityCollection
Returns a chart entity from the collection.
getEntity(double, double) - Method in class org.jfree.chart.entity.StandardEntityCollection
Returns the last entity in the list with an area that encloses the specified coordinates, or null if there is no such entity.
getEntity() - Method in class org.jfree.chart.fx.interaction.ChartMouseEventFX
Returns the chart entity (if any) under the mouse point.
getEntityCollection() - Method in class org.jfree.chart.block.BlockResult
Returns the collection of entities from the block.
getEntityCollection() - Method in interface org.jfree.chart.block.EntityBlockResult
Returns the entity collection.
getEntityCollection() - Method in class org.jfree.chart.ChartRenderingInfo
Returns the collection of entities maintained by this instance.
getEntityCollection() - Method in class org.jfree.chart.renderer.RendererState
A convenience method that returns a reference to the entity collection (may be null) being used to record chart entities.
getEntityCount() - Method in interface org.jfree.chart.entity.EntityCollection
Returns the entity count.
getEntityCount() - Method in class org.jfree.chart.entity.StandardEntityCollection
Returns the number of entities in the collection.
getEntityForPoint(int, int) - Method in class org.jfree.chart.ChartPanel
Returns the chart entity at a given point.
getEntries() - Method in class jhplot.io.HFile
Return processed number of entries.
getEntries() - Method in class jhplot.io.HFileXML
Get number of processed entries
getEntries() - Method in class jhplot.io.PFile
Return file entries (ID,name,size).
getEntries() - Method in class org.jlab.groot.data.H1F
 
getEntries() - Method in interface org.jlab.groot.tree.ITree
 
getEntries() - Method in class org.jlab.groot.tree.Tree
 
getEntries() - Method in class org.jlab.groot.tree.TreeTextFile
 
getEntries(int) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated int32 entries = 6 [packed = true];
getEntries(int) - Method in class promc.io.PBufFile.Record.H1D
repeated int32 entries = 6 [packed = true];
getEntries(int) - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated int32 entries = 6 [packed = true];
getEntries(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated int32 entries = 6 [packed = true];
getEntries(int) - Method in class promc.io.PBufFile.Record.H2D
repeated int32 entries = 6 [packed = true];
getEntries(int) - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated int32 entries = 6 [packed = true];
getEntriesCount() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated int32 entries = 6 [packed = true];
getEntriesCount() - Method in class promc.io.PBufFile.Record.H1D
repeated int32 entries = 6 [packed = true];
getEntriesCount() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated int32 entries = 6 [packed = true];
getEntriesCount() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated int32 entries = 6 [packed = true];
getEntriesCount() - Method in class promc.io.PBufFile.Record.H2D
repeated int32 entries = 6 [packed = true];
getEntriesCount() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated int32 entries = 6 [packed = true];
getEntriesList() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated int32 entries = 6 [packed = true];
getEntriesList() - Method in class promc.io.PBufFile.Record.H1D
repeated int32 entries = 6 [packed = true];
getEntriesList() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated int32 entries = 6 [packed = true];
getEntriesList() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated int32 entries = 6 [packed = true];
getEntriesList() - Method in class promc.io.PBufFile.Record.H2D
repeated int32 entries = 6 [packed = true];
getEntriesList() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated int32 entries = 6 [packed = true];
getEntropy() - Method in class jhplot.H1D
Returns the entropy of the histogram.
getEntropy() - Method in class jhplot.HProf1D
Returns the entropy of the histogram.
getEntropy() - Method in class jhplot.utils.SHisto
Returns the entropy of the histogram.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Get the entry in the specified row and column.
getEntry(int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Returns the entry in the specified index.
getEntry(int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Return the entry at the specified index.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Get the entry in the specified row and column.
getEntry(int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the entry in the specified row and column.
getEntry(int) - Method in interface org.apache.commons.math3.linear.FieldVector
Returns the entry in the specified index.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Get the entry in the specified row and column.
getEntry(int) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Return the entry at the specified index.
getEntry(int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entry in the specified row and column.
getEntry(int) - Method in class org.apache.commons.math3.linear.RealVector
Return the entry at the specified index.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Returns the entry in the specified row and column.
getEntry(int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Returns the entry in the specified index.
getEntry(int) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
getEntry(int) - Method in class promc.io.PEventFile.HEvent.Group
repeated .promc.HEvent.Entry entry = 2;
getEntry(int) - Method in interface promc.io.PEventFile.HEvent.GroupOrBuilder
repeated .promc.HEvent.Entry entry = 2;
getEntryBuilder(int) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
getEntryBuilderList() - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
getEntryCount() - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
getEntryCount() - Method in class promc.io.PEventFile.HEvent.Group
repeated .promc.HEvent.Entry entry = 2;
getEntryCount() - Method in interface promc.io.PEventFile.HEvent.GroupOrBuilder
repeated .promc.HEvent.Entry entry = 2;
getEntryList() - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
getEntryList() - Method in class promc.io.PEventFile.HEvent.Group
repeated .promc.HEvent.Entry entry = 2;
getEntryList() - Method in interface promc.io.PEventFile.HEvent.GroupOrBuilder
repeated .promc.HEvent.Entry entry = 2;
getEntryOrBuilder(int) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
getEntryOrBuilder(int) - Method in class promc.io.PEventFile.HEvent.Group
repeated .promc.HEvent.Entry entry = 2;
getEntryOrBuilder(int) - Method in interface promc.io.PEventFile.HEvent.GroupOrBuilder
repeated .promc.HEvent.Entry entry = 2;
getEntryOrBuilderList() - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
getEntryOrBuilderList() - Method in class promc.io.PEventFile.HEvent.Group
repeated .promc.HEvent.Entry entry = 2;
getEntryOrBuilderList() - Method in interface promc.io.PEventFile.HEvent.GroupOrBuilder
repeated .promc.HEvent.Entry entry = 2;
getEps() - Method in class org.apache.commons.math3.ml.clustering.DBSCANClusterer
Returns the maximum radius of the neighborhood to be considered.
getEps() - Method in class org.apache.commons.math3.stat.clustering.DBSCANClusterer
Deprecated.
Returns the maximum radius of the neighborhood to be considered.
getEpsilon() - Method in class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Returns the convergence criteria used by this instance.
getEQ() - Method in class org.nfunk.jep.OperatorSet
 
getEquation() - Method in interface org.lsmp.djep.matrixJep.MatrixVariableI
The equation represented by this variable.
getEquation() - Method in class org.lsmp.djep.xjep.XVariable
get the equation
getErr() - Method in class jhplot.math.ValueErr
Get current error
getErr(int) - Method in class jhplot.P1D
Return (symmetric) error on Y-value.
getErrBack() - Method in class jhplot.stat.limit.ExpData
Get error on background
getErrFraction() - Method in class jhplot.stat.limit.ExpData
Get error on efficiency.
getError(int) - Method in class jhplot.P1D
Return error (uncertainty) on the Y value.
getError(int) - Method in class jhplot.stat.DataKeeper
Get error at index
getError() - Method in class jminhep.algorithms.FuzzyCMeansAlg
Get error code.
getError() - Method in class jminhep.algorithms.HierarchicalAlg
Get error: 0 looks OK
getError() - Method in class jminhep.algorithms.KMeansAlg
Return error
getError() - Method in class jminhep.algorithms.KMeansExchangeAlg
 
getError() - Method in class org.lsmp.djep.xjep.ErrorCatchingVisitor
Returns the Exception or null if no error.
getError_cov_post() - Method in class jhplot.math.kalman.JKalman
Getter
getError_cov_pre() - Method in class jhplot.math.kalman.JKalman
Getter
getErrorBuffer() - Method in class org.jlab.groot.data.H2F
Creates an error buffer with each element being 0.0
getErrorCovariance() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns the current error covariance matrix.
getErrorCovarianceMatrix() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns a copy of the current error covariance matrix.
getErrorFillColorTransp() - Method in class jplot.LinePars
get transparancy for the color used to fill an area with errors.
getErrorFillColorTranspSys() - Method in class jplot.LinePars
get transparancy for the color used to fill an area with system errors.
getErrorIndicatorPaint() - Method in class org.jfree.chart.renderer.category.StatisticalBarRenderer
Returns the paint used for the error indicators.
getErrorIndicatorPaint() - Method in class org.jfree.chart.renderer.category.StatisticalLineAndShapeRenderer
Returns the paint used for the error indicators.
getErrorIndicatorPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the error indicator paint.
getErrorIndicatorStroke() - Method in class org.jfree.chart.renderer.category.StatisticalBarRenderer
Returns the stroke used to draw the error indicators.
getErrorIndicatorStroke() - Method in class org.jfree.chart.renderer.category.StatisticalLineAndShapeRenderer
Returns the stroke used for the error indicators.
getErrorInfo() - Method in class org.nfunk.jep.JEP
Reports information on the errors that occurred during the most recent action.
getErrorInfo() - Method in exception org.nfunk.jep.ParseException
getErrorInfo() was added to the parser generated code to provide clean output instead of the standard format of Exception.toString().
getErrorNames() - Method in class jhplot.stat.DataSource
Get names of the errors
getErrorOnBackground() - Method in class jhplot.stat.DataSource
Get systematics on background for all channels
getErrorOnData() - Method in class jhplot.stat.DataSource
Get systematics on data for all channels
getErrorOnSignal() - Method in class jhplot.stat.DataSource
Get errors on signal on all channels
getErrorPaint() - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Returns the paint used to draw the error bars.
getErrors() - Method in class jhplot.math.exp4j.ValidationResult
Get the list of errors describing the issues while validating the expression
getErrors() - Method in class jhplot.stat.DataKeeper
 
getErrors() - Method in class jhplot.stat.Moments
Get errors on the moment calculations
getErrors() - Method in class jhplot.stat.MomentsFac
Get errors on the moment calculations.
getErrors() - Method in class jhplot.stat.MomentsNorm
Get errors on the factorial moment calculations.
getErrors(int) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double errors = 3 [packed = true];
getErrors(int) - Method in class promc.io.PBufFile.Record.H1D
repeated double errors = 3 [packed = true];
getErrors(int) - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double errors = 3 [packed = true];
getErrors(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double errors = 3 [packed = true];
getErrors(int) - Method in class promc.io.PBufFile.Record.H2D
repeated double errors = 3 [packed = true];
getErrors(int) - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double errors = 3 [packed = true];
getErrorsCount() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double errors = 3 [packed = true];
getErrorsCount() - Method in class promc.io.PBufFile.Record.H1D
repeated double errors = 3 [packed = true];
getErrorsCount() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double errors = 3 [packed = true];
getErrorsCount() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double errors = 3 [packed = true];
getErrorsCount() - Method in class promc.io.PBufFile.Record.H2D
repeated double errors = 3 [packed = true];
getErrorsCount() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double errors = 3 [packed = true];
getErrorsFill() - Method in class jplot.LinePars
get fill area between lower and upper error
getErrorsFillSys() - Method in class jplot.LinePars
get Fill area between lower and upper error for system errors.
getErrorsList() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double errors = 3 [packed = true];
getErrorsList() - Method in class promc.io.PBufFile.Record.H1D
repeated double errors = 3 [packed = true];
getErrorsList() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double errors = 3 [packed = true];
getErrorsList() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double errors = 3 [packed = true];
getErrorsList() - Method in class promc.io.PBufFile.Record.H2D
repeated double errors = 3 [packed = true];
getErrorsList() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double errors = 3 [packed = true];
getErrorsMessage() - Method in class org.lsmp.djep.xjep.ErrorCatchingVisitor
Returns the error messages.
getErrorsSysX() - Method in class jplot.LinePars
get systematical errors on X
getErrorsSysY() - Method in class jplot.LinePars
get systematical errors on Y
getErrorStroke() - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Returns the stroke used to draw the error bars.
getErrorSumSquares() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the sum of squared errors (SSE) associated with the regression model.
getErrorsX() - Method in class jplot.LinePars
get errors on X
getErrorsY() - Method in class jplot.LinePars
get errors on Y
getErrTicSize() - Method in class jplot.LinePars
Return the size of small tic marked end of errors
getESplit() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant e split in two pieces.
getEstimationType() - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Get the estimation type used for computation.
getEt() - Method in class hephysics.jet.ParticleF
 
getEt2() - Method in class hephysics.jet.ParticleF
 
getEta() - Method in class hephysics.jet.ParticleF
 
getEta() - Method in class hephysics.vec.Hep3Vector
 
getEta() - Method in class hephysics.vec.HepLorentzVector
Get a pseudorapidity: eta=-ln (tan (theta/2)) )
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Eta = 20 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Eta = 20 [packed = true];
getEta(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Eta = 20 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint64 Eta = 2 [packed = true];
getEta(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Eta = 20 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Eta = 20 [packed = true];
getEtaCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Eta = 20 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint64 Eta = 2 [packed = true];
getEtaCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Eta = 20 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Eta = 20 [packed = true];
getEtaList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Eta = 20 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint64 Eta = 2 [packed = true];
getEtaList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint64 Eta = 2 [packed = true];
getEtaOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 EtaOuter = 11 [packed = true];
getEtaOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 EtaOuter = 11 [packed = true];
getEtaOuter(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 EtaOuter = 11 [packed = true];
getEtaOuterCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 EtaOuter = 11 [packed = true];
getEtaOuterCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 EtaOuter = 11 [packed = true];
getEtaOuterCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 EtaOuter = 11 [packed = true];
getEtaOuterList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 EtaOuter = 11 [packed = true];
getEtaOuterList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 EtaOuter = 11 [packed = true];
getEtaOuterList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 EtaOuter = 11 [packed = true];
getEvaluationCounter() - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresAdapter
Get a independent Incrementor that counts up to the maximum number of evaluations and then throws an exception.
getEvaluationCounter() - Method in class org.apache.commons.math3.optim.AbstractOptimizationProblem
Get a independent Incrementor that counts up to the maximum number of evaluations and then throws an exception.
getEvaluationCounter() - Method in interface org.apache.commons.math3.optim.OptimizationProblem
Get a independent Incrementor that counts up to the maximum number of evaluations and then throws an exception.
getEvaluations() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the number of function evaluations of the last run of the integrator.
getEvaluations() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the number of function evaluations of the last run of the integrator.
getEvaluations() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Get the number of evaluations of the objective function.
getEvaluations() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Get the number of evaluations of the objective function.
getEvaluations() - Method in interface org.apache.commons.math3.analysis.solvers.BracketedRealFieldUnivariateSolver
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the number of evaluations of the objective function.
getEvaluations() - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresOptimizer.Optimum
Get the number of times the model was evaluated in order to produce this optimum.
getEvaluations() - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - Method in class org.apache.commons.math3.optim.BaseMultiStartMultivariateOptimizer
Gets the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Gets the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
 
getEvaluations() - Method in class org.apache.commons.math3.optim.univariate.MultiStartUnivariateOptimizer
Gets the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
Deprecated.
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
Deprecated.
Get the number of evaluations of the objective function.
getEvaluations() - Method in interface org.apache.commons.math3.optimization.BaseOptimizer
Deprecated.
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated.
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.
 
getEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated.
Get the number of evaluations of the objective function.
getEvaluatorVisitor() - Method in class org.nfunk.jep.JEP
Returns the EvaluatorVisitor
getEvent() - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEvent() - Method in class proeic.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
getEvent() - Method in interface proeic.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
getEvent() - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEvent() - Method in class promc.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
getEvent() - Method in interface promc.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
getEvent() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEvent() - Method in class pronlo.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
getEvent() - Method in interface pronlo.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
getEvent() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEvent() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
getEvent() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
getEventBuilder() - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEventBuilder() - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEventBuilder() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEventBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEventHandler() - Method in class org.apache.commons.math3.ode.events.EventState
Get the underlying event handler.
getEventHandler() - Method in class org.apache.commons.math3.ode.events.FieldEventState
Get the underlying event handler.
getEventHandlers() - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Get all the event handlers that have been added to the integrator.
getEventHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get all the event handlers that have been added to the integrator.
getEventHandlers() - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Get all the event handlers that have been added to the integrator.
getEventHandlers() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get all the event handlers that have been added to the integrator.
getEventNumber() - Method in interface hep.lcio.event.LCEvent
Returns this event's number .
getEventNumber() - Method in class hep.lcio.implementation.event.ILCEvent
 
getEventNumber() - Method in class hep.physics.event.BaseEvent
 
getEventNumber() - Method in interface hep.physics.event.HEPEvent
 
getEventOrBuilder() - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEventOrBuilder() - Method in class proeic.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
getEventOrBuilder() - Method in interface proeic.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
getEventOrBuilder() - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEventOrBuilder() - Method in class promc.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
getEventOrBuilder() - Method in interface promc.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
getEventOrBuilder() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEventOrBuilder() - Method in class pronlo.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
getEventOrBuilder() - Method in interface pronlo.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
getEventOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
getEventOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
getEventOrBuilder() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
getEvents() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
getEvents() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
required uint64 events = 2;
getEvents() - Method in interface proeic.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 events = 2;
getEvents() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
getEvents() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
required uint64 events = 2;
getEvents() - Method in interface promc.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 events = 2;
getEvents() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
getEvents() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
required uint64 events = 2;
getEvents() - Method in interface pronlo.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 events = 2;
getEvents() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
getEvents() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
required uint64 events = 2;
getEvents() - Method in interface proreco.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 events = 2;
getEventSetDescriptors() - Method in class net.java.dev.colorchooser.ColorChooserBeanInfo
Gets the bean's EventSetDescriptors.
getEventTime() - Method in class org.apache.commons.math3.ode.events.EventState
Get the occurrence time of the event triggered in the current step.
getEventTime() - Method in class org.apache.commons.math3.ode.events.FieldEventState
Get the occurrence time of the event triggered in the current step.
getException() - Method in class jhplot.F1D
If error occurs at some step, this is the way to retrieve it.
getException() - Method in class jhplot.F2D
If error occurs at some step, this is the way to retrieve it.
getExceptionSegmentCount(long, long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns the number of exception segments wholly contained in the (fromDomainValue, toDomainValue) interval.
getExceptionSegments() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns a list of all the exception segments.
getExpandToFitSpace() - Method in class org.jfree.chart.title.TextTitle
Returns the flag that controls whether or not the title expands to fit the available space.
getExpansionFactor() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
As of 3.1. Return type will be changed to "double" in 4.0.
getExpansionMode() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
As of 3.1. Return value to be changed to ResizableDoubleArray.ExpansionMode in 4.0.
getExpData() - Method in class jhplot.stat.limit.StatConfidence
Get experimental data
getExpectedCLb_b(int) - Method in class jhplot.stat.ConfidenceLevel
Get the expected Confidence Level for the background only if there is only background.
getExpectedCLb_b() - Method in class jhplot.stat.ConfidenceLevel
Get the expected Confidence Level for the background only if there is only background.These are indications of how well an experiment would do on average in excluding a signal if the signal truly is not present, and are the important figures of merit when optimizing an analysis for exclusion.
getExpectedCLb_sb(int) - Method in class jhplot.stat.ConfidenceLevel
Get the expected Confidence Level for the background only if there is signal and background.
getExpectedCLb_sb() - Method in class jhplot.stat.ConfidenceLevel
Get the expected Confidence Level for the background only if there is signal and background.
getExpectedCLs_b(int) - Method in class jhplot.stat.ConfidenceLevel
Get getExpectedCLsb_b/getExpectedCLb_b
getExpectedCLs_b() - Method in class jhplot.stat.ConfidenceLevel
Get getExpectedCLsb_b/getExpectedCLb_b.
getExpectedCLsb_b(int) - Method in class jhplot.stat.ConfidenceLevel
Get the expected Confidence Level for the signal plus background hypothesis if there is only background.
getExpectedCLsb_b() - Method in class jhplot.stat.ConfidenceLevel
Get the expected Confidence Level for the signal plus background hypothesis if there is only background.
getExpectedColumnDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
 
getExpectedDimension(int) - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
 
getExpectedDimensions() - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
 
getExpectedRowDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
 
getExpectedStatistic_b(int) - Method in class jhplot.stat.ConfidenceLevel
Get the expected statistic value in the background only hypothesis
getExpectedStatistic_b() - Method in class jhplot.stat.ConfidenceLevel
 
getExpectedStatistic_sb(int) - Method in class jhplot.stat.ConfidenceLevel
Get the expected statistic value in the signal plus background hypothesis
getExplodedPieArea() - Method in class org.jfree.chart.plot.PiePlotState
Returns the exploded pie area.
getExplodePercent(Comparable) - Method in class org.jfree.chart.plot.PiePlot
Returns the amount that the section with the specified key should be exploded.
getExplodePercent(int) - Method in class org.jfree.chart.plot.PiePlot
Deprecated.
getExponent(float) - Static method in class net.jafama.FastMath
 
getExponent(double) - Static method in class net.jafama.FastMath
 
getExponent(float) - Static method in class net.jafama.StrictFastMath
 
getExponent(double) - Static method in class net.jafama.StrictFastMath
 
getExponent() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Return the exponent of the instance value, removing the bias.
getExponent() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Get the exponent characterizing the distribution.
getExponent(double) - Static method in class org.apache.commons.math3.util.FastMath
Return the exponent of a double number, removing the bias.
getExponent(float) - Static method in class org.apache.commons.math3.util.FastMath
Return the exponent of a float number, removing the bias.
getExponentFormat() - Method in class org.jfree.chart.util.LogFormat
Returns the number format used for the exponent.
getExpression() - Method in class org.jlab.groot.math.F1D
 
getExpression() - Method in class org.jlab.groot.math.Func1D
 
getExpression() - Method in class org.jlab.groot.tree.TreeCut
 
getExpressionX() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getExpressionXerr() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getExpressionY() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getExpressionYerr() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getExpTickLabelsFlag() - Method in class org.jfree.chart.axis.LogarithmicAxis
Returns the 'expTickLabelsFlag' flag.
getExtension() - Method in enum jhplot.io.images.ImageType
Returns the extension.
getExtension(String) - Static method in class org.apache.commons.io.FilenameUtils
Gets the extension of a fileName.
getExtent() - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Returns the extent.
getExtent() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the extent.
getExtractIndex() - Method in class org.jfree.data.category.CategoryToPieDataset
Returns the index of the row or column from which to extract the data.
getExtractType() - Method in class org.jfree.data.category.CategoryToPieDataset
Returns the extract type, which determines whether data is read from one row or one column of the underlying dataset.
getExtraLargeFont() - Method in class org.jfree.chart.StandardChartTheme
Returns the largest font for this theme.
getEyePosition() - Method in class jhplot.HPlot3DP
Get a vector with eye position
getEyePosition() - Method in class jplot3dp.ModelView
Get eye position
getF() - Method in class jhplot.stat.Anova
Returns the F-value for your data.
getF1D() - Method in class jhplot.FNon
If dimension is 1, you can return F1D for plotting.
getF1D(String) - Method in class org.jlab.groot.group.DataGroup
 
getF1D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F1D f1D = 9;
getF1D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.F1D f1D = 9;
getF1D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.F1D f1D = 9;
getF1DBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F1D f1D = 9;
getF1DOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F1D f1D = 9;
getF1DOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.F1D f1D = 9;
getF1DOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.F1D f1D = 9;
getF2D() - Method in class jhplot.FNon
If dimension is 2, you can return F2D for plotting
getF2D() - Method in class jplot3d.JSurfacePanel
 
getF2D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F2D f2D = 10;
getF2D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.F2D f2D = 10;
getF2D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.F2D f2D = 10;
getF2DBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F2D f2D = 10;
getF2DOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F2D f2D = 10;
getF2DOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.F2D f2D = 10;
getF2DOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.F2D f2D = 10;
getFactorX() - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
getFactorX() - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
getFactorY() - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
getFactorY() - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
getFactorZ() - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
getFactorZ() - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
getFaroutCoefficient() - Method in interface org.jfree.data.statistics.BoxAndWhiskerXYDataset
Returns the value used as the farout coefficient.
getFaroutCoefficient() - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the value used as the farout coefficient.
getFast() - Method in class hep.physics.jet.EventShape
 
getFD() - Method in class jhplot.math.io.LERandomAccessFile
 
getFdata(int) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 17;
getFdata(int) - Method in class proeic.io.ProMC.ProMCEvent.Event
repeated float fdata = 17;
getFdata(int) - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
repeated float fdata = 17;
getFdata(int) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated double fdata = 15 [packed = true];
getFdata(int) - Method in class promc.io.ProMC.ProMCEvent.Event
repeated double fdata = 15 [packed = true];
getFdata(int) - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
repeated double fdata = 15 [packed = true];
getFdata(int) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 3;
getFdata(int) - Method in class pronlo.io.ProMC.ProMCEvent.Event
repeated float fdata = 3;
getFdata(int) - Method in interface pronlo.io.ProMC.ProMCEvent.EventOrBuilder
repeated float fdata = 3;
getFdataCount() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 17;
getFdataCount() - Method in class proeic.io.ProMC.ProMCEvent.Event
repeated float fdata = 17;
getFdataCount() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
repeated float fdata = 17;
getFdataCount() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated double fdata = 15 [packed = true];
getFdataCount() - Method in class promc.io.ProMC.ProMCEvent.Event
repeated double fdata = 15 [packed = true];
getFdataCount() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
repeated double fdata = 15 [packed = true];
getFdataCount() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 3;
getFdataCount() - Method in class pronlo.io.ProMC.ProMCEvent.Event
repeated float fdata = 3;
getFdataCount() - Method in interface pronlo.io.ProMC.ProMCEvent.EventOrBuilder
repeated float fdata = 3;
getFdataList() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 17;
getFdataList() - Method in class proeic.io.ProMC.ProMCEvent.Event
repeated float fdata = 17;
getFdataList() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
repeated float fdata = 17;
getFdataList() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated double fdata = 15 [packed = true];
getFdataList() - Method in class promc.io.ProMC.ProMCEvent.Event
repeated double fdata = 15 [packed = true];
getFdataList() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
repeated double fdata = 15 [packed = true];
getFdataList() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 3;
getFdataList() - Method in class pronlo.io.ProMC.ProMCEvent.Event
repeated float fdata = 3;
getFdataList() - Method in interface pronlo.io.ProMC.ProMCEvent.EventOrBuilder
repeated float fdata = 3;
getFeatures() - Method in class org.apache.commons.math3.ml.neuralnet.Neuron
Gets the neuron's features.
getFeatures(int) - Method in class org.apache.commons.math3.ml.neuralnet.oned.NeuronString
Retrieves the features set from the neuron at location i in the map.
getFeaturesSize() - Method in class org.apache.commons.math3.ml.neuralnet.Network
Gets the size of the neurons' features set.
getFHi() - Method in exception org.apache.commons.math3.exception.NoBracketingException
Get the value at the higher end of the interval.
getFHi() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
Get function value at BracketFinder.getHi().
getFHi() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.
Get function value at BracketFinder.getHi().
getField() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.complex.Complex
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.dfp.Dfp
Get the Field (really a DfpField) to which the instance belongs.
getField() - Method in interface org.apache.commons.math3.FieldElement
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.fraction.BigFraction
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.fraction.Fraction
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the type of field elements of the matrix.
getField() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Get the type of field elements of the vector.
getField() - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the type of field elements of the matrix.
getField() - Method in interface org.apache.commons.math3.linear.FieldVector
Get the type of field elements of the vector.
getField() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Get the type of field elements of the vector.
getField() - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Get the field to which state vector elements belong.
getField() - Method in class org.apache.commons.math3.util.BigReal
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.util.Decimal64
Get the Field to which the instance belongs.
getFile() - Method in class jplot.DataFile
Return the file
getFile() - Method in class jplot.GraphLabel
 
getFile() - Method in exception org.apache.commons.io.DirectoryWalker.CancelException
Returns the file when the operation was cancelled.
getFile(File, String...) - Static method in class org.apache.commons.io.FileUtils
Construct a file from the set of name elements.
getFile(String...) - Static method in class org.apache.commons.io.FileUtils
Construct a file from the set of name elements.
getFile() - Method in class org.apache.commons.io.input.Tailer
Return the file.
getFile() - Method in class org.apache.commons.io.monitor.FileEntry
Return the file being monitored.
getFile() - Method in class org.apache.commons.io.output.DeferredFileOutputStream
Returns either the output file specified in the constructor or the temporary file created or null.
getFileCounter() - Method in interface org.apache.commons.io.file.Counters.PathCounters
Gets the file counter.
getFileFilter() - Method in class org.apache.commons.io.monitor.FileAlterationObserver
Returns the fileFilter.
getFileFilters() - Method in class org.apache.commons.io.filefilter.AndFileFilter
Returns this conditional file filter's list of file filters.
getFileFilters() - Method in interface org.apache.commons.io.filefilter.ConditionalFileFilter
Returns this conditional file filter's list of file filters.
getFileFilters() - Method in class org.apache.commons.io.filefilter.OrFileFilter
Returns this conditional file filter's list of file filters.
getFileIndex() - Method in class jplot.DataArray
Returns the file index of this data array.
getFileList() - Method in class org.apache.commons.io.file.AccumulatorPathVisitor
Gets the list of visited files.
getFilenameWithoutPath() - Method in class jplot.DataFile
Return the filename with the preceeding path stripped off.
getFilePointer() - Method in class jhplot.math.io.LERandomAccessFile
 
getFill() - Method in class jhplot.shapes.HShape
Is this primitive filled?
getFillBox() - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Returns the flag that controls whether or not the box is filled.
getFillBox() - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Returns the flag that controls whether or not the box is filled.
getFillColor() - Method in class jhplot.DrawOptions
Get color of a drawing object.
getFillColor() - Method in class jhplot.FPR
Get color used to fill.
getFillColor() - Method in class jplot.LinePars
Returns the color used to fill an area with.
getFillColor() - Method in class jplot3d.ColorModelSet
 
getFillColor() - Method in interface jplot3d.SurfaceColor
 
getFillColor() - Method in class org.jlab.groot.base.DatasetAttributes
 
getFillColor() - Method in class org.jlab.groot.data.H1F
 
getFillColorTransparency() - Method in class jplot.LinePars
Returns the transparancy color used to fill an area with.
getFillComposite() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Get the composite that is used for filling.
getFillPaint() - Method in class org.jfree.chart.annotations.XYPolygonAnnotation
Returns the fill paint.
getFillPaint() - Method in class org.jfree.chart.ClipPath
Deprecated.
Returns the fillPaint.
getFillPaint() - Method in class org.jfree.chart.LegendItem
Returns the fill paint.
getFillPaint() - Method in class org.jfree.chart.needle.MeterNeedle
Returns the fill paint.
getFillPaint() - Method in class org.jfree.chart.plot.dial.DialCap
Returns the paint used to fill the cap.
getFillPaint() - Method in class org.jfree.chart.plot.dial.DialPointer.Pointer
Returns the fill paint.
getFillPaint() - Method in class org.jfree.chart.title.LegendGraphic
Returns the paint used to fill the shape.
getFillPaintTransformer() - Method in class org.jfree.chart.LegendItem
Returns the transformer used when the fill paint is an instance of GradientPaint.
getFillPaintTransformer() - Method in class org.jfree.chart.title.LegendGraphic
Returns the transformer used when the fill paint is an instance of GradientPaint.
getFillStyle() - Method in class org.jlab.groot.base.DatasetAttributes
 
getFillType() - Method in class org.jfree.chart.renderer.xy.XYSplineRenderer
Returns the type of fill that the renderer draws beneath the curve.
getFillZoomRectangle() - Method in class org.jfree.chart.ChartPanel
Returns the flag that controls whether or not the zoom rectangle is filled when drawn.
getFinalTime() - Method in class org.apache.commons.math3.ode.ContinuousOutputFieldModel
Get the final integration time.
getFinalTime() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Get the final integration time.
getFirst() - Method in class org.apache.commons.math3.genetics.ChromosomePair
Access the first chromosome.
getFirst() - Method in class org.apache.commons.math3.util.Pair
Get the first element of the pair.
getFirst() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the first time period in the axis range.
getFirstBarPaint() - Method in class org.jfree.chart.renderer.category.WaterfallBarRenderer
Returns the paint used to draw the first bar.
getFirstCategoryIndex() - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the index of the first visible category.
getFirstCategoryIndex() - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the index of the first visible category.
getFirstDim() - Method in class org.lsmp.djep.vectorJep.Dimensions
get the first dimension, 1 for numbers, or the length of a vector.
getFirstIndex() - Method in class org.apache.commons.math3.ode.EquationsMapper
Get the index of the first equation element in complete state arrays.
getFirstItemIndex() - Method in class org.jfree.chart.renderer.xy.XYItemRendererState
Returns the first item index (this is updated with each call to XYItemRendererState.startSeriesPass(XYDataset, int, int, int, int, int).
getFirstMillisecond() - Method in class org.jfree.data.time.Day
Returns the first millisecond of the day.
getFirstMillisecond(Calendar) - Method in class org.jfree.data.time.Day
Returns the first millisecond of the day, evaluated using the supplied calendar (which determines the time zone).
getFirstMillisecond() - Method in class org.jfree.data.time.FixedMillisecond
Returns the first millisecond of the time period.
getFirstMillisecond(Calendar) - Method in class org.jfree.data.time.FixedMillisecond
Returns the first millisecond of the time period.
getFirstMillisecond() - Method in class org.jfree.data.time.Hour
Returns the first millisecond of the hour.
getFirstMillisecond(Calendar) - Method in class org.jfree.data.time.Hour
Returns the first millisecond of the hour.
getFirstMillisecond() - Method in class org.jfree.data.time.Millisecond
Returns the first millisecond of the second.
getFirstMillisecond(Calendar) - Method in class org.jfree.data.time.Millisecond
Returns the first millisecond of the time period.
getFirstMillisecond() - Method in class org.jfree.data.time.Minute
Returns the first millisecond of the minute.
getFirstMillisecond(Calendar) - Method in class org.jfree.data.time.Minute
Returns the first millisecond of the minute.
getFirstMillisecond() - Method in class org.jfree.data.time.Month
Returns the first millisecond of the month.
getFirstMillisecond(Calendar) - Method in class org.jfree.data.time.Month
Returns the first millisecond of the month, evaluated using the supplied calendar (which determines the time zone).
getFirstMillisecond() - Method in class org.jfree.data.time.Quarter
Returns the first millisecond of the quarter.
getFirstMillisecond(Calendar) - Method in class org.jfree.data.time.Quarter
Returns the first millisecond in the Quarter, evaluated using the supplied calendar (which determines the time zone).
getFirstMillisecond() - Method in class org.jfree.data.time.RegularTimePeriod
Returns the first millisecond of the time period.
getFirstMillisecond(TimeZone) - Method in class org.jfree.data.time.RegularTimePeriod
Deprecated.
As of 1.0.3, you should avoid using this method (it creates a new Calendar instance every time it is called). You are advised to call RegularTimePeriod.getFirstMillisecond(Calendar) instead.
getFirstMillisecond(Calendar) - Method in class org.jfree.data.time.RegularTimePeriod
Returns the first millisecond of the time period, evaluated using the supplied calendar (which incorporates a timezone).
getFirstMillisecond() - Method in class org.jfree.data.time.Second
Returns the first millisecond of the second.
getFirstMillisecond(Calendar) - Method in class org.jfree.data.time.Second
Returns the first millisecond of the minute.
getFirstMillisecond() - Method in class org.jfree.data.time.Week
Returns the first millisecond of the week.
getFirstMillisecond(Calendar) - Method in class org.jfree.data.time.Week
Returns the first millisecond of the week, evaluated using the supplied calendar (which determines the time zone).
getFirstMillisecond() - Method in class org.jfree.data.time.Year
Returns the first millisecond of the year.
getFirstMillisecond(Calendar) - Method in class org.jfree.data.time.Year
Returns the first millisecond of the year, evaluated using the supplied calendar (which determines the time zone).
getFirstPolygonColor(float) - Method in class jplot3d.ColorModelSet
 
getFirstPolygonColor(float) - Method in interface jplot3d.SurfaceColor
 
getFirstTickLabelVisible() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns a flag that controls whether or not the first tick label is visible.
getFitEngines() - Method in class jhplot.HFitter
Return available fit engines.
getFitFunction() - Method in class jhplot.stat.StatShape
Get a fit function after the linear regression (major axis).
getFitFunctionPerp() - Method in class jhplot.stat.StatShape
Get a fit function perpendicular to the linear regression line (minor axis).
getFitFunctionQuadrants() - Method in class jhplot.stat.StatShape
Get linear functions after rotation of major and minor axes by 45 deg to define the quadrants.
getFitMethod() - Method in class jhplot.HFitter
Returns the current fit method.
getFitMethods() - Method in class jhplot.HFitter
Return available fit methods.
getFitness() - Method in class org.apache.commons.math3.genetics.Chromosome
Access the fitness of this chromosome.
getFitParameters() - Method in class jhplot.stat.StatShape
Get fit parameters, the intercept (0) and the slope (1)
getFitParametersPerp() - Method in class jhplot.stat.StatShape
Get fit parameters of a function perpendicular (minor) axis to the linear regression line the intercept (0) and the slope (1)
getFitParametersRotate() - Method in class jhplot.stat.StatShape
Parameters after rotation of major and minor axes by 45deg.
getFittedFunc() - Method in class jhplot.HFitter
Get results of the fit in form of function
getFittedModel() - Method in class org.apache.commons.math3.distribution.fitting.MultivariateNormalMixtureExpectationMaximization
Gets the fitted model.
getFitter() - Method in class jhplot.HFitter
Return Jaida fitter
getFittestChromosome() - Method in class org.apache.commons.math3.genetics.ListPopulation
Access the fittest chromosome in this population.
getFittestChromosome() - Method in interface org.apache.commons.math3.genetics.Population
Access the fittest chromosome in this population.
getFixedAutoRange() - Method in class org.jfree.chart.axis.ValueAxis
Returns the fixed auto range.
getFixedDimension() - Method in class org.jfree.chart.axis.Axis
Returns the fixed dimension for the axis.
getFixedDomainAxisSpace() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the fixed domain axis space.
getFixedDomainAxisSpace() - Method in class org.jfree.chart.plot.XYPlot
Returns the fixed domain axis space.
getFixedIntervalWidth() - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns the fixed interval width.
getFixedLegendItems() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the fixed legend items, if any.
getFixedLegendItems() - Method in class org.jfree.chart.plot.PolarPlot
Returns the fixed legend items, if any.
getFixedLegendItems() - Method in class org.jfree.chart.plot.XYPlot
Returns the fixed legend items, if any.
getFixedRangeAxisSpace() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the fixed range axis space.
getFixedRangeAxisSpace() - Method in class org.jfree.chart.plot.XYPlot
Returns the fixed range axis space.
getFixedVars() - Method in class jhplot.FND
String with fixed variables
getFlag() - Method in interface hep.lcio.event.LCCollection
Returns flag word for collection.
getFlag() - Method in interface hep.lcio.event.LCFlag
Returns the flag word.
getFlag() - Method in class hep.lcio.implementation.event.ILCCollection
 
getFLo() - Method in exception org.apache.commons.math3.exception.NoBracketingException
Get the value at the lower end of the interval.
getFLo() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
Get function value at BracketFinder.getLo().
getFLo() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.
Get function value at BracketFinder.getLo().
getFloat(String, float) - Method in class jplot.XMLRead
Returns the value of a number (float) element.
getFloatKeys() - Method in interface hep.lcio.event.LCParameters
Returns a list of all keys of float parameters.
getFloatKeys() - Method in class hep.lcio.implementation.event.ILCParameters
 
getFloatProperty(String) - Method in class hep.lcio.util.SIODump.Resolver
 
getFloatVal(int) - Method in interface hep.lcio.event.LCGenericObject
Returns the float value for the given index.
getFloatVal(String) - Method in interface hep.lcio.event.LCParameters
Returns the first float value for the given key.
getFloatVal(int) - Method in class hep.lcio.example.CalibrationConstant
 
getFloatVal(int) - Method in class hep.lcio.implementation.event.ILCGenericObject
 
getFloatVal(String) - Method in class hep.lcio.implementation.event.ILCParameters
 
getFloatVals(String) - Method in interface hep.lcio.event.LCParameters
Returns values for the given key.
getFloatVals(String) - Method in class hep.lcio.implementation.event.ILCParameters
 
getFM(Graphics) - Method in class graph.TextLine
 
getFM(int) - Method in class jhplot.stat.FactorialMoments
Return factorial moments (without normalization): log(FM) as a function of number of bins.
getFMid() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
Get function value at BracketFinder.getMid().
getFMid() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.
Get function value at BracketFinder.getMid().
getFND() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FND fND = 11;
getFND() - Method in class promc.io.PBufFile.Record
optional .promc.Record.FND fND = 11;
getFND() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.FND fND = 11;
getFNDBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FND fND = 11;
getFNDOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FND fND = 11;
getFNDOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.FND fND = 11;
getFNDOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.FND fND = 11;
getFocusedComponent() - Method in class jplot3d.JSurface
 
getFollowDataInSubranges() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns a flag that controls whether or not the thermometer axis zooms to display the subrange within which the data value falls.
getFont() - Method in class graph.TextLine
 
getFont() - Method in class jhepsim.FontChooser
Returns the currently selected Font.
getFont() - Method in class jhplot.HKey
Get the font of the label text.
getFont() - Method in class jhplot.HLabel
Get the font of the label text.
getFont() - Method in class jhplot.HMLabel
Get the text font.
getFont() - Method in class jhplot.shapes.Text
Get the font
getFont() - Method in class jminhep.gui.FontChooser
Returns the currently selected Font.
getFont() - Method in class jplot.GraphLabel
Sets the font to a specific value
getFont(String, Font) - Method in class jplot.XMLRead
Returns the value of a font element: it must be a font.
getFont() - Method in class org.jfree.chart.annotations.TextAnnotation
Returns the font for the annotation.
getFont() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the font for the annotation.
getFont() - Method in class org.jfree.chart.block.LabelBlock
Returns the font.
getFont() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the current font used for drawing text.
getFont() - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Returns the font used to display the label.
getFont() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the font.
getFont() - Method in class org.jfree.chart.title.TextTitle
Returns the font used to display the title string.
getFontColorLabel() - Method in interface jplot3d.SurfaceModel
 
getFontColorLabel() - Method in class jplot3d.SurfaceModelCanvas
 
getFontMetrics(Font) - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the font metrics for the specified font.
getFontName() - Method in class graph.TextLine
 
getFontName() - Method in class org.jlab.groot.base.FontProperties
 
getFontRenderContext() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the font render context.
getFontSize() - Method in class graph.TextLine
 
getFontSize() - Method in class jhplot.HLabelEq
Get the font size of the equation.
getFontSize() - Method in class org.jlab.groot.base.FontProperties
 
getFontSizeArray() - Static method in class org.jlab.groot.base.FontProperties
 
getFontStyle() - Method in class graph.TextLine
 
getForegroundAlpha() - Method in class org.jfree.chart.plot.Plot
Returns the alpha-transparency for the plot foreground.
getForegroundPaint() - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Returns the foreground paint.
getForegroundPaint() - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Returns the foreground paint.
getFormat() - Method in class org.apache.commons.math3.geometry.VectorFormat
Get the components format.
getFormat() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the components format.
getFormat() - Method in class org.apache.commons.math3.linear.RealVectorFormat
Get the components format.
getFormatString() - Method in class org.jfree.chart.labels.AbstractXYItemLabelGenerator
Returns the format string (this controls the overall structure of the label).
getFov() - Method in class jhplot.HPlot3DP
Get field of vision
getFov() - Method in class jplot3d.OptionsDialog
 
getFov() - Method in class jplot3dp.MainComponent
 
getFov() - Method in class jplot3dp.ModelView
 
getFPR() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FPR fPR = 12;
getFPR() - Method in class promc.io.PBufFile.Record
optional .promc.Record.FPR fPR = 12;
getFPR() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.FPR fPR = 12;
getFPRBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FPR fPR = 12;
getFPROrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FPR fPR = 12;
getFPROrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.FPR fPR = 12;
getFPROrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.FPR fPR = 12;
getFraction() - Method in class jhplot.stat.limit.ExpData
Get efficiency.
getFraction(double) - Method in class org.jlab.groot.math.Dimension1D
 
getFrame() - Method in class jhplot.gui.GHFrame
Get the main frame which keeps the components
getFrame() - Method in class jplot.DataChangeListener
 
getFrame() - Method in class jplot3d.OptionsDialog
 
getFrame() - Method in class org.jfree.chart.block.AbstractBlock
Returns the current frame (border).
getFrame() - Method in class org.jlab.groot.studio.GROOTStudio
 
getFrameAnchor() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the frame anchor.
getFrameColor() - Method in class jhplot.HPlot3D
Get color of the frame
getFrameDimensions() - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
getFrameMargins() - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
getFrameScale() - Method in interface jplot3d.SurfaceModel
 
getFrameScale() - Method in class jplot3d.SurfaceModelCanvas
 
getFreeParameters() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the number of free parameters.
getFreeParameters() - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the number of free parameters.
getFrobeniusNorm() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the Frobenius norm of the matrix.
getFrobeniusNorm() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the Frobenius norm of the matrix.
getFrobeniusNorm() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the Frobenius norm of the matrix.
getFrom() - Method in interface hep.lcio.event.LCRelation
The 'from' object of the given relation.
getFrom() - Method in class hep.lcio.implementation.event.ILCRelation
 
getFullBarWidth() - Method in class jplot.Contour
Get full bar width including the space and the text width
getFullPath(String) - Static method in class org.apache.commons.io.FilenameUtils
Gets the full path from a full fileName, which is the prefix + path.
getFullPathNoEndSeparator(String) - Static method in class org.apache.commons.io.FilenameUtils
Gets the full path from a full fileName, which is the prefix + path, and also excluding the final directory separator.
getFunc() - Method in class jhplot.HFitter
Return function
getFuncCatalog() - Method in class jhplot.HFitter
Return list of available functions
getFunction() - Method in class jhplot.math.exp4j.tokenizer.FunctionToken
 
getFunction() - Method in class jhplot.math.num.integration.AdaptiveIntegrator
Access the target function.
getFunction() - Method in class jhplot.math.num.integration.RombergIntegrator
Access the target function.
getFunction() - Method in class jhplot.math.num.integration.SimpsonsIntegrator
Access the target function.
getFunction() - Method in class jhplot.math.num.integration.TrapezoidalIntegrator
Access the target function.
getFunction() - Method in class jhplot.math.num.root.BisectionRootFinder
Access the target function.
getFunction() - Method in class jhplot.math.num.root.Bracket
Access the target function.
getFunction() - Method in class jhplot.math.num.root.BrentRootFinder
Access the target function.
getFunction() - Method in class jhplot.math.num.root.FalsePositionRootFinder
Access the target function.
getFunction() - Method in class jhplot.math.num.root.NewtonRootFinder
Access the target function.
getFunction() - Method in class jhplot.math.num.root.SecantRootFinder
Access the target function.
getFunction(int) - Method in class jplot3dp.ModelView.FunctionsList
 
getFunction() - Method in class org.jlab.groot.data.GraphErrors
 
getFunction() - Method in class org.jlab.groot.data.H1F
 
getFunction() - Method in class org.jlab.groot.fitter.FitterFunction
 
getFunction() - Method in class org.lsmp.djep.rpe.RpCommand
 
getFunction(short) - Method in class org.lsmp.djep.rpe.RpEval
 
getFunctionAttributes() - Static method in class org.jlab.groot.base.GStyle
 
getFunctions() - Method in class jplot3d.OptionsDialog
Get all functions from GUI
getFunctionTable() - Method in class org.nfunk.jep.JEP
Returns the function table (the list of all functions that the parser recognizes).
getFunctionValueAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Get the function value accuracy of the solver.
getFunctionValueAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Get the function value accuracy of the solver.
getFunctionValueAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BracketedRealFieldUnivariateSolver
Get the function value accuracy of the solver.
getFunctionValueAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the function accuracy.
getFunctionValueAccuracy() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Deprecated.
Get the function accuracy.
getFuzziness() - Method in class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Returns the fuzziness factor used by this instance.
getGain() - Method in class jhplot.math.kalman.JKalman
Getter
getGap() - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Returns the space between subplots.
getGap() - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Returns the gap between subplots, measured in Java2D units.
getGap() - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Returns the space between subplots.
getGap() - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Returns the space between subplots.
getGap() - Method in class org.jfree.chart.plot.PieLabelRecord
Returns the gap.
getGap() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the gap, in Java2D units, between the two outlines that represent the thermometer.
getGapThreshold() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns the gap threshold for discontinuous lines.
getGapThresholdType() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns the gap threshold type (relative or absolute).
getGaussianSmoothed(double) - Method in class jhplot.utils.SHisto
Computes a Gaussian smoothed version of the histogram.
getGBackground() - Method in class jhplot.gui.GHMargin
Get the color of background
getGColor() - Method in class jhplot.gui.GHMargin
Get the color of this panel
getGE() - Method in class org.nfunk.jep.OperatorSet
 
getGenerateEntities() - Method in class org.jfree.chart.block.BlockParams
Returns the flag that controls whether or not chart entities are generated.
getGenerateEntities() - Method in interface org.jfree.chart.block.EntityBlockParams
Returns a flag that controls whether or not the block should return entities for the items it draws.
getGenerationsEvolved() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the number of generations evolved to reach StoppingCondition in the last run.
getGenerator() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Get the underlying normalized components generator.
getGenerator() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
optional int32 generator = 5;
getGenerator() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
optional int32 generator = 5;
getGenerator() - Method in interface proeic.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
optional int32 generator = 5;
getGeneratorStatus() - Method in interface hep.lcio.event.MCParticle
Returns the status for particles as defined by the generator, typically
0 empty line
1 undecayed particle, stable in the generator
2 particle decayed in the generator
3 documentation line
getGeneratorStatus() - Method in class hep.lcio.implementation.event.IMCParticle
 
getGeneratorStatus() - Method in class hep.physics.particle.BasicParticle
 
getGeneratorStatus() - Method in interface hep.physics.particle.Particle
Status code, one of FINALSTATE, INTERMEDIATE or DOCUMENTATION
getGeneratorUpperBounds() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Returns a fresh copy of the array of upper bounds of the subintervals of [0,1] used in generating data from the empirical distribution.
getGenjets() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.GenJets genjets = 4;
getGenjets() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.GenJets genjets = 4;
getGenjets() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.GenJets genjets = 4;
getGenjetsBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.GenJets genjets = 4;
getGenjetsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.GenJets genjets = 4;
getGenjetsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.GenJets genjets = 4;
getGenjetsOrBuilder() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.GenJets genjets = 4;
getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured geometric mean implementation
getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured geometric mean implementation
getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured geometric mean implementation
getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured geometric mean implementation
getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the geometric mean of all the aggregated data.
getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the geometric mean of the available values.
getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the geometric mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getGeometricMean() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the geometric mean of the ith entries of the arrays that correspond to each multivariate sample
getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the geometric mean of the values that have been added.
getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the geometric mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the geometric mean of the values that have been added.
getGeometricMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured geometric mean implementation.
getGFont() - Method in class jhplot.gui.GHMargin
Get the font of the text
getGlobalCurrentState() - Method in class org.apache.commons.math3.ode.sampling.AbstractFieldStepInterpolator
Get the current global grid point state.
getGlobalCurrentTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the current global grid point time.
getGlobalOptions() - Method in class hep.lcio.util.CommandLineTool
Get the global options.
getGlobalPreviousState() - Method in class org.apache.commons.math3.ode.sampling.AbstractFieldStepInterpolator
Get the previous global grid point state.
getGlobalPreviousTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the previous global grid point time.
getGoalType() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateOptimizer
 
getGoalType() - Method in class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
 
getGoalType() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.
 
getGoalType() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.
 
getGoodnessOfPID() - Method in interface hep.lcio.event.ReconstructedParticle
The overall goodness of the PID on a scale of [0;1].
getGoodnessOfPID() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getGradientPaintTransformer() - Method in class org.jfree.chart.plot.dial.DialBackground
Returns the transformer used to adjust the coordinates of any GradientPaint instance used for the background paint.
getGradientPaintTransformer() - Method in class org.jfree.chart.plot.IntervalMarker
Returns the gradient paint transformer.
getGradientPaintTransformer() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the gradient paint transformer (an object used to transform gradient paint objects to fit each bar).
getGradientPaintTransformer() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the gradient paint transformer (an object used to transform gradient paint objects to fit each bar).
getGradientPaintTransformer() - Method in class org.jfree.chart.renderer.xy.XYSplineRenderer
Returns the gradient paint transformer, or null.
getGradientTransformer() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Returns the gradient paint transformer.
getGraph() - Method in class graph.BuildGraph
Get the Graph object that has been built!
getGraph() - Method in class jplot.JPlot
 
getGraph() - Method in class org.jlab.groot.data.H1F
Retrieves a graph of the histogram
getGraph(String) - Method in class org.jlab.groot.group.DataGroup
 
getGraph() - Method in class org.jlab.groot.math.RandomFunc
 
getGraphBackgroundColor() - Method in class jplot.GraphSettings
Returns the background color of the graph.
getGraphErrors() - Method in class org.jlab.groot.data.DataParser
 
getGraphErrorsAttributes() - Static method in class org.jlab.groot.base.GStyle
 
getGraphicsFrameLineWidth() - Static method in class org.jlab.groot.base.GStyle
 
getGraphLabel() - Method in class jhplot.HKey
Get a label with default attributes
getGraphLabel() - Method in class jhplot.HLabel
Get a label with default attributes
getGraphLabel() - Method in class jhplot.HMLabel
Get a label with default attributes
getGraphLabel() - Method in class jplot.LabelProperties
 
getGraphSettings(int, int) - Method in class jhplot.HPlot
Get graph settings
getGraphSettings() - Method in class jhplot.HPlot
Get graph settings for current plot
getGraphSettings() - Method in class jplot.JPlot
 
getGraphStyle() - Method in class jplot.LinePars
Returns the current graph style.
getGraphTitle() - Method in class graph.BuildGraph
Get the title of the Graph
getGraphType() - Method in class jplot.DataFile
 
getGraphType() - Method in class jplot.GraphSettings
Returns the current graph type.
getGrid() - Method in class graph.Contour
Return the grid
getGrid() - Method in class jplot.Contour
Return the grid
getGrid() - Method in class org.jlab.groot.base.AxisAttributes
 
getGrid() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getGrid() - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
getGridBandAlternatePaint() - Method in class org.jfree.chart.axis.SymbolAxis
Returns the paint used for alternate grid bands.
getGridBandAlternatePaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the grid band alternate paint (used for a SymbolAxis).
getGridBandPaint() - Method in class org.jfree.chart.axis.SymbolAxis
Returns the paint used to color the grid bands.
getGridBandPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the grid band paint.
getGridColor() - Method in class jhplot.HPlot
Sets the color of the overall grid.
getGridColor() - Method in class jplot.GraphSettings
Sets the color of the overall grid.
getGroup() - Method in class org.jfree.data.general.AbstractDataset
Returns the dataset group for the dataset.
getGroup() - Method in interface org.jfree.data.general.Dataset
Returns the dataset group.
getGroup(Comparable) - Method in class org.jfree.data.KeyToGroupMap
Returns the group that a key is mapped to.
getGroup() - Method in class org.lsmp.djep.groupJep.GroupJep
 
getGroup(int) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
getGroup(int) - Method in class promc.io.PEventFile.HEvent
repeated .promc.HEvent.Group group = 5;
getGroup(int) - Method in interface promc.io.PEventFile.HEventOrBuilder
repeated .promc.HEvent.Group group = 5;
getGroupBuilder(int) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
getGroupBuilderList() - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
getGroupCount() - Method in class org.jfree.data.KeyToGroupMap
Returns the number of groups in the map.
getGroupCount() - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
getGroupCount() - Method in class promc.io.PEventFile.HEvent
repeated .promc.HEvent.Group group = 5;
getGroupCount() - Method in interface promc.io.PEventFile.HEventOrBuilder
repeated .promc.HEvent.Group group = 5;
getGroupIndex(Comparable) - Method in class org.jfree.data.KeyToGroupMap
Returns the index for the group.
getGroupList() - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
getGroupList() - Method in class promc.io.PEventFile.HEvent
repeated .promc.HEvent.Group group = 5;
getGroupList() - Method in interface promc.io.PEventFile.HEventOrBuilder
repeated .promc.HEvent.Group group = 5;
getGroupOrBuilder(int) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
getGroupOrBuilder(int) - Method in class promc.io.PEventFile.HEvent
repeated .promc.HEvent.Group group = 5;
getGroupOrBuilder(int) - Method in interface promc.io.PEventFile.HEventOrBuilder
repeated .promc.HEvent.Group group = 5;
getGroupOrBuilderList() - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
getGroupOrBuilderList() - Method in class promc.io.PEventFile.HEvent
repeated .promc.HEvent.Group group = 5;
getGroupOrBuilderList() - Method in interface promc.io.PEventFile.HEventOrBuilder
repeated .promc.HEvent.Group group = 5;
getGroupPaint() - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Returns the paint used to draw the line between the minimum and maximum value items in each category.
getGroups() - Method in class org.jfree.data.KeyToGroupMap
Returns a list of the groups (always including the default group) in the map.
getGroupSegmentCount() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns the number of segments in a segment group.
getGroupStroke() - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Returns the stroke used to draw the line between the minimum and maximum value items in each category.
getGS() - Method in class jplot.JPlot
 
getGT() - Method in class org.nfunk.jep.OperatorSet
 
getGuideLinePaint() - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Returns the paint used to draw the guide lines.
getGuideLineStroke() - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Returns the stroke used to draw the guide lines.
getH() - Method in class cern.colt.matrix.linalg.QRDecomposition
Returns the Householder vectors H.
getH() - Method in class Jama.QRDecomposition
Return the Householder vectors
getH() - Method in class jhplot.math.kalman.jama.QRDecomposition
Return the Householder vectors
getH() - Method in class jhplot.math.QRDecomposition
Return the Householder vectors
getH() - Method in class org.apache.commons.math3.linear.QRDecomposition
Returns the Householder reflector vectors.
getH1D() - Method in class jhplot.F1D
Return H1D histogram from F1D function.
getH1D(double, double) - Method in class jhplot.F1D
Return H1D histogram from F1D function.
getH1D(String, int, double, double) - Method in class jhplot.F1D
Return a Histogram given by the F1D function.
getH1D() - Method in class jhplot.HProf1D
Make H1D copy of the current histogram.
getH1D(String) - Method in class jhplot.HProf1D
Convert to H1D for graphical representation using default graphics attributes.
getH1D(String, String) - Method in class jhplot.HProf1D
Convert to H1D for graphical representation using default graphics attributes.
getH1D(int) - Method in class jhplot.io.CFBook
Get H1D histogram from the index (key)
getH1D(String) - Method in class jhplot.io.FileRoot
Get H1D histogram associated with the key name.
getH1D(int) - Method in class jhplot.P0D
Return H1D histogram with P0D content.
getH1D(int, double, double) - Method in class jhplot.P0D
Return H1D histogram with P0D content.
getH1D(int) - Method in class jhplot.P0I
Return H1D histogram with P0I content.
getH1D(int, double, double) - Method in class jhplot.P0I
Return H1D histogram with P0I content.
getH1D(int, double, double) - Method in class jhplot.PND
Return H1D histogram with PND content.
getH1D(int, double, double, int) - Method in class jhplot.PND
Make a histogram from a column of PND.
getH1D(int) - Method in class jhplot.PND
Create histogram.
getH1D(int, double, double) - Method in class jhplot.PNI
Return H1D histogram with PND content.
getH1D(int) - Method in class jhplot.PNI
Create histogram.
getH1D(int, double, double, int) - Method in class jhplot.PNI
Make a histogram from a column of PND.
getH1D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H1D h1D = 7;
getH1D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.H1D h1D = 7;
getH1D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.H1D h1D = 7;
getH1DBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H1D h1D = 7;
getH1DOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H1D h1D = 7;
getH1DOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.H1D h1D = 7;
getH1DOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.H1D h1D = 7;
getH1F(String) - Method in class org.jlab.groot.group.DataGroup
 
getH1FAttributes() - Static method in class org.jlab.groot.base.GStyle
 
getH2D(String, int, double, double, int, double, double) - Method in class jhplot.F2D
Generate a 2D histogram from the F2D function using a custom number of bins and given min and max values.
getH2D(String) - Method in class jhplot.HProf2D
Make H2D copy of the current histogram.
getH2D(String, String) - Method in class jhplot.HProf2D
Make H2D copy of the current histogram.
getH2D() - Method in class jhplot.HProf2D
Convert to H2D keeping the original title
getH2D(int) - Method in class jhplot.io.CFBook
Get H2D histogram from the index (key) ID
getH2D(String) - Method in class jhplot.io.FileRoot
Get H2D histogram associated with the key name.
getH2D() - Method in class jplot3d.JSurfacePanel
 
getH2D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H2D h2D = 8;
getH2D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.H2D h2D = 8;
getH2D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.H2D h2D = 8;
getH2DBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H2D h2D = 8;
getH2DOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H2D h2D = 8;
getH2DOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.H2D h2D = 8;
getH2DOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.H2D h2D = 8;
getH2F(String) - Method in class org.jlab.groot.group.DataGroup
 
getH2FAttributes() - Static method in class org.jlab.groot.base.GStyle
 
getHadOverEem(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEem(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEem(int) - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEem(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEem(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEem(int) - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEem(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEem(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEem(int) - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemCount() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemCount() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemCount() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemList() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemList() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemList() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemList() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 HadOverEem = 10 [packed = true];
getHadOverEemList() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 HadOverEem = 10 [packed = true];
getHeadPercent() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the head percent.
getHeight(Graphics) - Method in class graph.TextLine
 
getHeight() - Method in class jplot.GraphLabel
Returns the height of the bounding box of the label
getHeight() - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
getHeight() - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
getHeight() - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Returns the height (in data space) of the data rectangle into which the image will be drawn.
getHeight(Graphics2D) - Method in class org.jfree.chart.axis.MarkerAxisBand
Returns the height of the band.
getHeight() - Method in class org.jfree.chart.block.AbstractBlock
Returns the natural height of the block, if this is known in advance.
getHeight() - Method in class org.jfree.chart.block.RectangleConstraint
Returns the fixed height.
getHeight() - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Get the height of this item.
getHeight() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getHeightConstraintType() - Method in class org.jfree.chart.block.RectangleConstraint
Returns the constraint type.
getHeightRange() - Method in class org.jfree.chart.block.RectangleConstraint
Returns the width range.
getHeights(int) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double heights = 2 [packed = true];
getHeights(int) - Method in class promc.io.PBufFile.Record.H1D
repeated double heights = 2 [packed = true];
getHeights(int) - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double heights = 2 [packed = true];
getHeights(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double heights = 2 [packed = true];
getHeights(int) - Method in class promc.io.PBufFile.Record.H2D
repeated double heights = 2 [packed = true];
getHeights(int) - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double heights = 2 [packed = true];
getHeightsCount() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double heights = 2 [packed = true];
getHeightsCount() - Method in class promc.io.PBufFile.Record.H1D
repeated double heights = 2 [packed = true];
getHeightsCount() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double heights = 2 [packed = true];
getHeightsCount() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double heights = 2 [packed = true];
getHeightsCount() - Method in class promc.io.PBufFile.Record.H2D
repeated double heights = 2 [packed = true];
getHeightsCount() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double heights = 2 [packed = true];
getHeightsList() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double heights = 2 [packed = true];
getHeightsList() - Method in class promc.io.PBufFile.Record.H1D
repeated double heights = 2 [packed = true];
getHeightsList() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double heights = 2 [packed = true];
getHeightsList() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double heights = 2 [packed = true];
getHeightsList() - Method in class promc.io.PBufFile.Record.H2D
repeated double heights = 2 [packed = true];
getHeightsList() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double heights = 2 [packed = true];
getHi() - Method in exception org.apache.commons.math3.exception.NoBracketingException
Get the higher end of the interval.
getHi() - Method in exception org.apache.commons.math3.exception.OutOfRangeException
 
getHi() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
 
getHi() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.
 
getHigh(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the high-value for the specified series and item.
getHigh(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the high-value for the specified series and item.
getHigh() - Method in class org.jfree.data.time.ohlc.OHLC
Returns the high value.
getHigh(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the high-value for an item within a series.
getHigh(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the high-value for one item in a series.
getHigh(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the high value.
getHigh() - Method in class org.jfree.data.xy.OHLCDataItem
Returns the high value.
getHigh(int, int) - Method in interface org.jfree.data.xy.OHLCDataset
Returns the high-value for the specified series and item.
getHighEdge(int) - Method in class org.jlab.groot.data.DataVector
 
getHighlightPaint() - Method in class org.jfree.chart.needle.MeterNeedle
Returns the highlight paint.
getHighValue() - Method in class jhplot.utils.SHisto
Returns the highest exclusive pixel value checked for all bands.
getHighValue(int) - Method in class jhplot.utils.SHisto
Returns the highest value checked for a specific band.
getHighValue(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the high-value (as a double primitive) for an item within a series.
getHighValue(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the high-value (as a double primitive) for an item within a series.
getHighValue() - Method in class org.jfree.data.time.ohlc.OHLCItem
Returns the high value.
getHighValue(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the high-value for an item within a series.
getHighValue(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the high-value (as a double primitive) for an item within a series.
getHighValue(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the high-value (as a double primitive) for an item within a series.
getHighValue(int, int) - Method in interface org.jfree.data.xy.OHLCDataset
Returns the high-value (as a double primitive) for an item within a series.
getHistogram() - Method in class org.jlab.groot.fitter.ParallelSliceFitter
 
getHitContributions() - Method in interface hep.lcio.event.Cluster
Returns the energy contribution of the hits Runs parallel to the CalorimeterHitVec from getCalorimeterHits()
getHitContributions() - Method in class hep.lcio.implementation.event.ICluster
 
getHorizontalAlignment() - Method in class org.jfree.chart.title.Title
Returns the horizontal alignment of the title.
getHorizontalAxisTrace() - Method in class org.jfree.chart.ChartPanel
Returns the flag that controls whether or not a horizontal axis trace line is drawn over the plot area at the current mouse location.
getHour() - Method in class org.jfree.data.time.Hour
Returns the hour.
getHour() - Method in class org.jfree.data.time.Minute
Returns the hour.
getHourSuffix() - Method in class org.jfree.chart.util.RelativeDateFormat
Returns the string that is appended to the hour count.
getHourValue() - Method in class org.jfree.data.time.Minute
Returns the hour.
getHQR() - Method in class Jampack.Zmat
Returns a Householder QR decomposition if a valid one exists.
getHTMLUrl(String) - Method in class jhepsim.AboutDialog
Returns a HTML page which is found in a valid image URL.
getHTMLUrl(String) - Method in class jhplot.gui.GHFrame
Returns a HTML page which is found in a valid image URL.
getHTMLUrl(String) - Method in class jhplot.utils.AboutDialog
Returns a HTML page which is found in a valid image URL.
getHTMLUrl(String) - Method in class jhplot.utils.HelpDialog
Returns a HTML page which is found in a valid image URL.
getHyperplane() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Get the underlying hyperplane.
getHyperplane() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Get the underlying hyperplane.
getIcon(int) - Method in class net.java.dev.colorchooser.ColorChooserBeanInfo
This method returns an image object that can be used to represent the bean in toolboxes, toolbars, etc.
getID() - Method in class jplot.GraphLabel
 
getID() - Method in class org.jfree.chart.block.AbstractBlock
Returns the id.
getID() - Method in interface org.jfree.chart.block.Block
Returns an ID for the block.
getID() - Method in class org.jfree.chart.fx.interaction.AbstractMouseHandlerFX
Returns the ID for the handler.
getID() - Method in interface org.jfree.chart.fx.interaction.MouseHandlerFX
Returns the ID for the handler.
getID() - Method in class org.jfree.data.general.DatasetGroup
Returns the identification string for this group.
getId() - Method in class org.nfunk.jep.SimpleNode
Returns the id of the node (for simpler identification).
getId(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getId(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getId(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getId() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
getId() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
required sint32 id = 1;
getId() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required sint32 id = 1;
getId() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
getId() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
required sint32 id = 1;
getId() - Method in interface proeic.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required sint32 id = 1;
getId() - Method in class promc.io.PEventFile.HEvent.Builder
optional int64 id = 1;
getId() - Method in class promc.io.PEventFile.HEvent
optional int64 id = 1;
getId() - Method in interface promc.io.PEventFile.HEventOrBuilder
optional int64 id = 1;
getId(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getId(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getId(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getId() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
getId() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
required sint32 id = 1;
getId() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required sint32 id = 1;
getId() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
getId() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
required sint32 id = 1;
getId() - Method in interface promc.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required sint32 id = 1;
getId(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getId(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getId(int) - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getId() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
getId() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
required sint32 id = 1;
getId() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required sint32 id = 1;
getId() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
getId() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
required sint32 id = 1;
getId() - Method in interface pronlo.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required sint32 id = 1;
getId(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getId(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getId(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getId() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
getId() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
required sint32 id = 1;
getId() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required sint32 id = 1;
getId() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
getId() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
required sint32 id = 1;
getId() - Method in interface proreco.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required sint32 id = 1;
getID1() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID1 = 4;
getID1() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional int32 ID1 = 4;
getID1() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 ID1 = 4;
getId1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
getId1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 id1 = 1;
getId1() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id1 = 1;
getID1() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID1 = 4;
getID1() - Method in class promc.io.ProMC.ProMCEvent.Event
optional int32 ID1 = 4;
getID1() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 ID1 = 4;
getId1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
getId1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 id1 = 1;
getId1() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id1 = 1;
getId1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
getId1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 id1 = 1;
getId1() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id1 = 1;
getID1(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID1 = 4 [packed = true];
getID1(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 ID1 = 4 [packed = true];
getID1(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 ID1 = 4 [packed = true];
getId1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
getId1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 id1 = 1;
getId1() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id1 = 1;
getID1Count() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID1 = 4 [packed = true];
getID1Count() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 ID1 = 4 [packed = true];
getID1Count() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 ID1 = 4 [packed = true];
getID1List() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID1 = 4 [packed = true];
getID1List() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 ID1 = 4 [packed = true];
getID1List() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 ID1 = 4 [packed = true];
getID2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID2 = 5;
getID2() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional int32 ID2 = 5;
getID2() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 ID2 = 5;
getId2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
getId2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 id2 = 2;
getId2() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id2 = 2;
getID2() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID2 = 5;
getID2() - Method in class promc.io.ProMC.ProMCEvent.Event
optional int32 ID2 = 5;
getID2() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 ID2 = 5;
getId2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
getId2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 id2 = 2;
getId2() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id2 = 2;
getId2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
getId2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 id2 = 2;
getId2() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id2 = 2;
getID2(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID2 = 5 [packed = true];
getID2(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 ID2 = 5 [packed = true];
getID2(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 ID2 = 5 [packed = true];
getId2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
getId2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 id2 = 2;
getId2() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id2 = 2;
getID2Count() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID2 = 5 [packed = true];
getID2Count() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 ID2 = 5 [packed = true];
getID2Count() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 ID2 = 5 [packed = true];
getID2List() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID2 = 5 [packed = true];
getID2List() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 ID2 = 5 [packed = true];
getID2List() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 ID2 = 5 [packed = true];
getIda(int) - Method in class promc.io.PEventFile.HEvent.Builder
repeated int64 ida = 4 [packed = true];
getIda(int) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated int64 ida = 2 [packed = true];
getIda(int) - Method in class promc.io.PEventFile.HEvent.Entry
repeated int64 ida = 2 [packed = true];
getIda(int) - Method in interface promc.io.PEventFile.HEvent.EntryOrBuilder
repeated int64 ida = 2 [packed = true];
getIda(int) - Method in class promc.io.PEventFile.HEvent
repeated int64 ida = 4 [packed = true];
getIda(int) - Method in interface promc.io.PEventFile.HEventOrBuilder
repeated int64 ida = 4 [packed = true];
getIdaCount() - Method in class promc.io.PEventFile.HEvent.Builder
repeated int64 ida = 4 [packed = true];
getIdaCount() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated int64 ida = 2 [packed = true];
getIdaCount() - Method in class promc.io.PEventFile.HEvent.Entry
repeated int64 ida = 2 [packed = true];
getIdaCount() - Method in interface promc.io.PEventFile.HEvent.EntryOrBuilder
repeated int64 ida = 2 [packed = true];
getIdaCount() - Method in class promc.io.PEventFile.HEvent
repeated int64 ida = 4 [packed = true];
getIdaCount() - Method in interface promc.io.PEventFile.HEventOrBuilder
repeated int64 ida = 4 [packed = true];
getIdaList() - Method in class promc.io.PEventFile.HEvent.Builder
repeated int64 ida = 4 [packed = true];
getIdaList() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated int64 ida = 2 [packed = true];
getIdaList() - Method in class promc.io.PEventFile.HEvent.Entry
repeated int64 ida = 2 [packed = true];
getIdaList() - Method in interface promc.io.PEventFile.HEvent.EntryOrBuilder
repeated int64 ida = 2 [packed = true];
getIdaList() - Method in class promc.io.PEventFile.HEvent
repeated int64 ida = 4 [packed = true];
getIdaList() - Method in interface promc.io.PEventFile.HEventOrBuilder
repeated int64 ida = 4 [packed = true];
getIdata(int) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 18;
getIdata(int) - Method in class proeic.io.ProMC.ProMCEvent.Event
repeated sint64 idata = 18;
getIdata(int) - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
repeated sint64 idata = 18;
getIdata(int) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 16 [packed = true];
getIdata(int) - Method in class promc.io.ProMC.ProMCEvent.Event
repeated sint64 idata = 16 [packed = true];
getIdata(int) - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
repeated sint64 idata = 16 [packed = true];
getIdata(int) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 4;
getIdata(int) - Method in class pronlo.io.ProMC.ProMCEvent.Event
repeated sint64 idata = 4;
getIdata(int) - Method in interface pronlo.io.ProMC.ProMCEvent.EventOrBuilder
repeated sint64 idata = 4;
getIdataCount() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 18;
getIdataCount() - Method in class proeic.io.ProMC.ProMCEvent.Event
repeated sint64 idata = 18;
getIdataCount() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
repeated sint64 idata = 18;
getIdataCount() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 16 [packed = true];
getIdataCount() - Method in class promc.io.ProMC.ProMCEvent.Event
repeated sint64 idata = 16 [packed = true];
getIdataCount() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
repeated sint64 idata = 16 [packed = true];
getIdataCount() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 4;
getIdataCount() - Method in class pronlo.io.ProMC.ProMCEvent.Event
repeated sint64 idata = 4;
getIdataCount() - Method in interface pronlo.io.ProMC.ProMCEvent.EventOrBuilder
repeated sint64 idata = 4;
getIdataList() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 18;
getIdataList() - Method in class proeic.io.ProMC.ProMCEvent.Event
repeated sint64 idata = 18;
getIdataList() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
repeated sint64 idata = 18;
getIdataList() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 16 [packed = true];
getIdataList() - Method in class promc.io.ProMC.ProMCEvent.Event
repeated sint64 idata = 16 [packed = true];
getIdataList() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
repeated sint64 idata = 16 [packed = true];
getIdataList() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 4;
getIdataList() - Method in class pronlo.io.ProMC.ProMCEvent.Event
repeated sint64 idata = 4;
getIdataList() - Method in interface pronlo.io.ProMC.ProMCEvent.EventOrBuilder
repeated sint64 idata = 4;
getIDataPointSet() - Method in class jhplot.P1D
Get IDataPointSet.
getIDataPointSet() - Method in class jhplot.PND
Get the data point set for JAIDA
getIDataPointSet() - Method in class jhplot.PNI
Get the data point set for JAIDA
getIdCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getIdCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getIdCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getIdCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getIdCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getIdCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getIdCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getIdCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getIdCount() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getIdCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getIdCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getIdCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getIdentifier() - Method in class org.apache.commons.math3.ml.neuralnet.Neuron
Gets the neuron's identifier.
getIdList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getIdList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getIdList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getIdList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getIdList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getIdList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getIdList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getIdList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getIdList() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getIdList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
getIdList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 id = 1 [packed = true];
getIdList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 id = 1 [packed = true];
getIEEEFlags() - Method in class org.apache.commons.math3.dfp.DfpField
Get the IEEE 854 status flags.
getIFunction() - Method in class jhplot.F1D
Get Jaida function
getIFunction() - Method in class jhplot.F2D
Get Jaida function
getIFunction() - Method in class jhplot.F3D
Get Jaida function
getIFunction() - Method in class jhplot.FProxy
Get Jaida function
getIgnoreNullValues() - Method in class org.jfree.chart.plot.PiePlot
Returns the flag that controls whether null values in the dataset are ignored.
getIgnoreZeroValues() - Method in class org.jfree.chart.plot.PiePlot
Returns the flag that controls whether zero values in the dataset are ignored.
getIgnoreZeroValues() - Method in class org.jfree.chart.renderer.category.StackedBarRenderer3D
Returns the flag that controls whether or not zero values are drawn by the renderer.
getIllegalFileNameChars() - Method in enum org.apache.commons.io.FileSystem
Gets a cloned copy of the illegal characters for this file system.
getIm() - Method in class Jampack.Zmat
Returns a copy of the imaginary part of a Zmat.
getImage() - Method in class jhplot.HLabelEq
Return image of this equation
GetImage() - Method in class jplot3dp.MathParser.SimpleCharStream
 
getImage() - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Returns the image for the annotation.
getImage() - Method in class org.jfree.chart.annotations.XYImageAnnotation
Returns the image for the annotation.
getImage() - Method in class org.jfree.chart.title.ImageTitle
Returns the image for the title.
GetImage() - Method in class org.nfunk.jep.JavaCharStream
 
getImageAnchor() - Method in class org.jfree.chart.annotations.XYImageAnnotation
Returns the image anchor for the annotation.
getImageFile(String) - Method in class jhplot.HLabelEq
Return image of this equation as a file.
getImageIcon(String) - Static method in class jminhep.utils.ResourceLoader
 
getImageIcon(String) - Method in class jplot.JPlot
Returns an image which is found in a valid image URL.
getImagEigenvalue(int) - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets the imaginary part of the ith eigenvalue of the original matrix.
getImagEigenvalues() - Method in class cern.colt.matrix.linalg.EigenvalueDecomposition
Returns the imaginary parts of the eigenvalues.
getImagEigenvalues() - Method in class Jama.EigenvalueDecomposition
Return the imaginary parts of the eigenvalues
getImagEigenvalues() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets a copy of the imaginary parts of the eigenvalues of the original matrix.
getImageMap(String, ChartRenderingInfo) - Static method in class org.jfree.chart.ChartUtilities
Creates an HTML image map.
getImageMap(String, ChartRenderingInfo, ToolTipTagFragmentGenerator, URLTagFragmentGenerator) - Static method in class org.jfree.chart.ChartUtilities
Creates an HTML image map.
getImageMap(String, ChartRenderingInfo) - Static method in class org.jfree.chart.imagemap.ImageMapUtilities
Creates an image map element that complies with the XHTML 1.0 specification.
getImageMap(String, ChartRenderingInfo, ToolTipTagFragmentGenerator, URLTagFragmentGenerator) - Static method in class org.jfree.chart.imagemap.ImageMapUtilities
Creates an image map element that complies with the XHTML 1.0 specification.
getImageMapAreaTag(ToolTipTagFragmentGenerator, URLTagFragmentGenerator) - Method in class org.jfree.chart.entity.ChartEntity
Returns an HTML image map tag for this entity.
getImageURL(String) - Static method in class jminhep.utils.ResourceLoader
 
getImaginary() - Method in class org.apache.commons.math3.complex.Complex
Access the imaginary part.
getImaginary(int) - Method in class org.apache.commons.math3.complex.RootsOfUnity
Get the imaginary part of the k-th n-th root of unity.
getImaginaryCharacter() - Method in class org.apache.commons.math3.complex.ComplexFormat
Access the imaginaryCharacter.
getImaginaryFormat() - Method in class org.apache.commons.math3.complex.ComplexFormat
Access the imaginaryFormat.
getImplicitMul() - Method in class org.nfunk.jep.JEP
Returns the value of the implicit multiplication option.
getImproperInstance() - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
Returns the default complex format for the current locale.
getImproperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
Returns the default complex format for the given locale.
getImproperInstance() - Static method in class org.apache.commons.math3.fraction.FractionFormat
Returns the default complex format for the current locale.
getImproperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.FractionFormat
Returns the default complex format for the given locale.
getIncludeBaseInRange() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the flag that controls whether or not the base value for the bars is included in the range calculated by AbstractCategoryItemRenderer.findRangeBounds(CategoryDataset).
getIncludeInDataBounds() - Method in interface org.jfree.chart.annotations.XYAnnotationBoundsInfo
Returns a flag that determines whether or not the annotation's bounds should be taken into account for auto-range calculations on the axes that the annotation is plotted against.
getIncludeInDataBounds() - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Returns the flag that controls whether or not the annotation should contribute to the autoRange for the axis it is plotted against.
getIncoming() - Method in class org.apache.commons.math3.geometry.spherical.twod.Vertex
Get incoming edge.
getIncompletePaint() - Method in class org.jfree.chart.renderer.category.GanttRenderer
Returns the paint used to show the percentage incomplete.
getIndex(int) - Method in class jhplot.math.Sorting
Get the ascending order of one line.
getIndex() - Method in class jhplot.math.Sorting
Get the ascending order of all lines.
getIndex() - Method in class jplot.DataFile
Get the current datafile index
getIndex() - Method in exception org.apache.commons.io.IOIndexedException
The index of this exception.
getIndex() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
Get the index of the wrong value.
getIndex() - Method in class org.jfree.chart.entity.ContourEntity
Deprecated.
Returns the index.
getIndex(Comparable) - Method in class org.jfree.data.category.CategoryToPieDataset
Returns the index for a given key, or -1 if there is no such key.
getIndex(Comparable) - Method in class org.jfree.data.DefaultKeyedValues
Returns the index for a given key.
getIndex(Comparable) - Method in class org.jfree.data.general.DefaultPieDataset
Returns the index for a key, or -1 if the key is not recognised.
getIndex(Comparable) - Method in class org.jfree.data.KeyedObjects
Returns the index for a given key, or -1.
getIndex(Comparable) - Method in interface org.jfree.data.KeyedValues
Returns the index for a given key.
getIndex(RegularTimePeriod) - Method in class org.jfree.data.time.TimeSeries
Returns the index for the item (if any) that corresponds to a time period.
getIndex(long, int[]) - Method in class org.jlab.groot.matrix.SparseIndex
 
getIndexer() - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
getIndexOf(CategoryItemRenderer) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the index of the specified renderer, or -1 if the renderer is not assigned to this plot.
getIndexOf(PolarItemRenderer) - Method in class org.jfree.chart.plot.PolarPlot
Returns the index of the specified renderer, or -1 if the renderer is not assigned to this plot.
getIndexOf(XYItemRenderer) - Method in class org.jfree.chart.plot.XYPlot
Returns the index of the specified renderer, or -1 if the renderer is not assigned to this plot.
getIndexOfChild(Object, Object) - Method in class root.RootHistogramTreeModel
 
getInf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Get the lower bound of the interval.
getInf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Get the lowest value belonging to the instance.
getInf() - Method in class org.apache.commons.math3.geometry.spherical.oned.Arc
Get the lower angular bound of the arc.
getInfo() - Method in class jhplot.io.FileRoot
Get the StreamerInfo
getInfo() - Static method in class jhplot.JHPlot
 
getInfo() - Method in class org.jfree.chart.renderer.RendererState
Returns the plot rendering info.
getInitialDelay() - Method in class org.jfree.chart.ChartPanel
Returns the initial tooltip delay value used inside this chart panel.
getInitialErrorCovariance() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
Returns the initial error covariance matrix.
getInitialErrorCovariance() - Method in interface org.apache.commons.math3.filter.ProcessModel
Returns the initial error covariance matrix.
getInitialGuess() - Method in class org.apache.commons.math3.optim.InitialGuess
Gets the initial guess.
getInitialGuess() - Method in class org.apache.commons.math3.optimization.InitialGuess
Deprecated.
Gets the initial guess.
getInitialStateEstimate() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
Returns the initial state estimation vector.
getInitialStateEstimate() - Method in interface org.apache.commons.math3.filter.ProcessModel
Returns the initial state estimation vector.
getInitialStepBoundFactor() - Method in class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
Gets the value of a tuning parameter.
getInitialTime() - Method in class org.apache.commons.math3.ode.ContinuousOutputFieldModel
Get the initial integration time.
getInitialTime() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Get the initial integration time.
getInitScaling() - Method in interface jplot3d.SurfaceModel
 
getInitScaling() - Method in class jplot3d.SurfaceModelCanvas
 
getInnerColor() - Method in class jhplot.HPlot
Returns the color used to fill the shaded triangles.
getInnerColor() - Method in class jplot.GraphSettings
Returns the color used to fill the shaded triangles.
getInnerRadius() - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Returns the inner radius, relative to the framing rectangle.
getInnerRadius() - Method in class org.jfree.chart.plot.dial.StandardDialRange
Returns the inner radius.
getInnerSeparatorExtension() - Method in class org.jfree.chart.plot.RingPlot
Returns the length of the inner extension of the separator line that is drawn between sections, expressed as a percentage of the depth of the section.
getInputDimsNo() - Method in class jhplot.math.pca.PCA
Get number of dimensions of the input vectors
getInputList() - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
getInputText() - Method in class jhplot.utils.GHFontChooser
Get outour string
getInsets() - Method in class org.jfree.chart.block.BlockBorder
Returns the space reserved for the border.
getInsets() - Method in interface org.jfree.chart.block.BlockFrame
Returns the space reserved for the border.
getInsets() - Method in class org.jfree.chart.block.LineBorder
Returns the insets.
getInsets() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the insets.
getInsets() - Method in class org.jfree.chart.plot.Plot
Returns the insets for the plot area.
getInsideArc(Circle) - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Get the arc of the instance that lies inside the other circle.
getInstance() - Static method in class hep.lcio.implementation.io.LCFactory
 
getInstance() - Static method in class org.apache.commons.io.FileCleaner
Deprecated.
Returns the singleton instance, which is used by the deprecated, static methods.
getInstance() - Static method in class org.apache.commons.math3.complex.ComplexField
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.complex.ComplexFormat
Returns the default complex format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.complex.ComplexFormat
Returns the default complex format for the given locale.
getInstance(String, Locale) - Static method in class org.apache.commons.math3.complex.ComplexFormat
Returns the default complex format for the given locale.
getInstance() - Static method in class org.apache.commons.math3.fraction.BigFractionField
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.fraction.FractionField
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Returns the default 1D vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Returns the default 1D vector format for the given locale.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Euclidean3D
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Returns the default 3D vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Returns the default 3D vector format for the given locale.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Euclidean2D
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Returns the default 2D vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Returns the default 2D vector format for the given locale.
getInstance() - Static method in class org.apache.commons.math3.geometry.spherical.oned.Sphere1D
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.geometry.spherical.twod.Sphere2D
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.linear.RealMatrixFormat
Returns the default real vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.linear.RealMatrixFormat
Returns the default real vector format for the given locale.
getInstance() - Static method in class org.apache.commons.math3.linear.RealVectorFormat
Returns the default real vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.linear.RealVectorFormat
Returns the default real vector format for the given locale.
getInstance(Field<T>, int) - Static method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckFieldTransformer
Get the Nordsieck transformer for a given field and number of steps.
getInstance(int) - Static method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
Get the Nordsieck transformer for a given number of steps.
getInstance() - Static method in class org.apache.commons.math3.ode.sampling.DummyStepHandler
Get the only instance.
getInstance() - Static method in class org.apache.commons.math3.util.BigRealField
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.util.Decimal64Field
Returns the unique instance of this class.
getInstance(int, int) - Static method in class org.lsmp.djep.vectorJep.values.Matrix
 
getInstance(int) - Static method in class org.lsmp.djep.vectorJep.values.MVector
Creates a vector of a given size.
getInstance(Object) - Static method in class org.lsmp.djep.vectorJep.values.Scaler
 
getInstance(Dimensions) - Static method in class org.lsmp.djep.vectorJep.values.Tensor
Factory method to return a new Vector, Matrix or Tensor with the given dimensions.
getInt(String, int) - Method in class jplot.XMLRead
Returns a value of a number (integer) element.
getInteger(double) - Method in class graph.Axis
Return the pixel equivalent of the passed data value.
getIntegerArrayList() - Method in class jhplot.P0I
Get data in form of DoubleArrayList from cern.colt package
getIntegerProperty(String) - Method in class hep.lcio.util.SIODump.Resolver
 
getIntegral() - Method in class jhplot.stat.DataKeeper
Calculate integral, summing up all values
getIntegral() - Method in class org.jlab.groot.data.H1F
 
getIntegral() - Method in class org.jlab.groot.math.Func1D
 
getIntercept() - Method in class jhplot.stat.LinReg
Get Intercept
getIntercept() - Method in class jhplot.stat.LinRegWeighted
Get Intercept
getIntercept() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the intercept of the estimated regression line, if SimpleRegression.hasIntercept() is true; otherwise 0.
getIntercept() - Method in class org.jfree.data.function.LineFunction2D
Returns the 'a' coefficient that was specified in the constructor.
getInterceptError() - Method in class jhplot.stat.LinReg
Get the standard error on intercept
getInterceptError() - Method in class jhplot.stat.LinRegWeighted
Get the standard error on intercept
getInterceptStdErr() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the standard error of the intercept estimate, usually denoted s(b0).
getInteriorGap() - Method in class org.jfree.chart.plot.PiePlot
Returns the interior gap, measured as a percentage of the available drawing space.
getInteriorGap() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the interior gap, measured as a percentage of the available drawing space.
getInternalValues() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
As of 3.1.
getInterpolatedDerivatives() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Get the derivatives of the state vector of the interpolated point.
getInterpolatedDerivatives() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the derivatives of the state vector of the interpolated point.
getInterpolatedDerivatives() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the derivatives of the state vector of the interpolated point.
getInterpolatedSecondaryDerivatives(int) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Get the interpolated secondary derivatives corresponding to the secondary equations.
getInterpolatedSecondaryDerivatives(int) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the interpolated secondary derivatives corresponding to the secondary equations.
getInterpolatedSecondaryDerivatives(int) - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the interpolated secondary derivatives corresponding to the secondary equations.
getInterpolatedSecondaryState(int) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Get the interpolated secondary state corresponding to the secondary equations.
getInterpolatedSecondaryState(int) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the interpolated secondary state corresponding to the secondary equations.
getInterpolatedSecondaryState(int) - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the interpolated secondary state corresponding to the secondary equations.
getInterpolatedState(T) - Method in class org.apache.commons.math3.ode.ContinuousOutputFieldModel
Get the state at interpolated time.
getInterpolatedState() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Get the state vector of the interpolated point.
getInterpolatedState(T) - Method in class org.apache.commons.math3.ode.sampling.AbstractFieldStepInterpolator
Get the state at interpolated time.
getInterpolatedState() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the state vector of the interpolated point.
getInterpolatedState(T) - Method in interface org.apache.commons.math3.ode.sampling.FieldStepInterpolator
Get the state at interpolated time.
getInterpolatedState() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the state vector of the interpolated point.
getInterpolatedStateVariation() - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Get the state vector variation from current to interpolated state.
getInterpolatedTime() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Get the time of the interpolated point.
getInterpolatedTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the time of the interpolated point.
getInterpolatedTime() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the time of the interpolated point.
getInterpolatingPoints() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the interpolating points array.
getInterpolatingValues() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the interpolating values array.
getInterval() - Method in class org.apache.commons.io.monitor.FileAlterationMonitor
Returns the interval.
getIntervalPositionFactor() - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the interval position factor.
getIntervalPositionFactor() - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the interval position factor.
getIntervalPositionFactor() - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns the interval position factor.
getIntervalPositionFactor() - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the interval position factor.
getIntervals() - Method in class org.jfree.chart.plot.MeterPlot
Returns an unmodifiable list of the intervals for the plot.
getIntervalWidth() - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the full interval width.
getIntervalWidth() - Method in class org.jfree.data.xy.DefaultTableXYDataset
returns the full interval width.
getIntervalWidth() - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns the interval width.
getIntervalWidth() - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the interval width.
getIntKeys() - Method in interface hep.lcio.event.LCParameters
Returns a list of all keys of integer parameters.
getIntKeys() - Method in class hep.lcio.implementation.event.ILCParameters
 
getIntOption(String) - Static method in class jhepsim.Options
Returns the mapped option integer value or 0 if the option is undefined.
getIntVal(int) - Method in interface hep.lcio.event.LCGenericObject
Returns the integer value for the given index.
getIntVal(String) - Method in interface hep.lcio.event.LCParameters
Returns the first integer value for the given key.
getIntVal(int) - Method in class hep.lcio.example.CalibrationConstant
 
getIntVal(int) - Method in class hep.lcio.implementation.event.ILCGenericObject
 
getIntVal(String) - Method in class hep.lcio.implementation.event.ILCParameters
 
getIntVals(String) - Method in interface hep.lcio.event.LCParameters
Returns values for the given key.
getIntVals(String) - Method in class hep.lcio.implementation.event.ILCParameters
 
getInverse() - Method in class org.apache.commons.math3.complex.Quaternion
Returns the inverse of this instance.
getInverse() - Method in interface org.apache.commons.math3.linear.DecompositionSolver
Get the pseudo-inverse of the decomposed matrix.
getInverse() - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
Get the inverse (or pseudo-inverse) of the decomposed matrix.
getInverse(Number) - Method in interface org.lsmp.djep.groupJep.GroupI
Get Inverse of a number
getInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.BigReals
 
getInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
getInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.Integers
 
getInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.PermutationGroup
 
getInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.Quaternions
 
getInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
getInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.Reals
 
getInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.Zn
 
getInverse() - Method in class org.lsmp.djep.groupJep.values.Permutation
 
getInverseConditionNumber() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Computes the inverse of the condition number.
getInverseOp() - Method in class org.lsmp.djep.xjep.XOperator
 
getIPhi() - Method in interface hep.lcio.event.Cluster
Intrinsic direction of cluster at position: Phi.
getIPhi() - Method in class hep.lcio.implementation.event.ICluster
 
getIsFixedBins() - Method in class promc.io.PBufFile.Record.H1D.Builder
required bool isFixedBins = 17;
getIsFixedBins() - Method in class promc.io.PBufFile.Record.H1D
required bool isFixedBins = 17;
getIsFixedBins() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
required bool isFixedBins = 17;
getIsFixedBins() - Method in class promc.io.PBufFile.Record.H2D.Builder
required bool isFixedBins = 13;
getIsFixedBins() - Method in class promc.io.PBufFile.Record.H2D
required bool isFixedBins = 13;
getIsFixedBins() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
required bool isFixedBins = 13;
getIsospin() - Method in class hephysics.particle.HEParticle
Get isospin
getItem(int) - Method in class jplot.DataFile
 
getItem() - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Returns the legend item.
getItem() - Method in class org.jfree.chart.entity.XYItemEntity
Returns the item index.
getItem(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Return an item from within the dataset.
getItem(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Return an item from within the dataset.
getItem(int) - Method in class org.jfree.data.xy.MatrixSeries
Return the matrix item at the specified index.
getItem(int) - Method in class org.jfree.data.xy.NormalizedMatrixSeries
Returns an item.
getItemColumn(int) - Method in class org.jfree.data.xy.MatrixSeries
Returns the column of the specified item.
getItemContainer() - Method in class org.jfree.chart.title.LegendTitle
Returns the container that holds the legend items.
getItemCount() - Method in class org.jfree.chart.LegendItemCollection
Returns the number of legend items in the collection.
getItemCount() - Method in class org.jfree.chart.plot.AbstractPieLabelDistributor
Returns the number of items in the list.
getItemCount() - Method in class org.jfree.chart.renderer.OutlierList
Returns the number of outliers in the list.
getItemCount() - Method in class org.jfree.data.category.CategoryToPieDataset
Returns the number of items (values) in the collection.
getItemCount() - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
getItemCount() - Method in class org.jfree.data.ComparableObjectSeries
Returns the number of items in the series.
getItemCount(int) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the number of items in the specified series.
getItemCount() - Method in class org.jfree.data.DefaultKeyedValues
Returns the number of items (values) in the collection.
getItemCount() - Method in class org.jfree.data.gantt.TaskSeries
Returns the number of items in the series.
getItemCount(int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the number of items (tasks) in the specified series.
getItemCount(int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the number of items in a series.
getItemCount() - Method in class org.jfree.data.general.DefaultPieDataset
Returns the number of items in the dataset.
getItemCount() - Method in class org.jfree.data.general.Series
Returns the number of data items in the series.
getItemCount(int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the number of items in a series.
getItemCount(int) - Method in class org.jfree.data.jdbc.JDBCXYDataset
Returns the number of items in the specified series.
getItemCount() - Method in class org.jfree.data.jdbc.JDBCXYDataset
Returns the number of items in all series.
getItemCount() - Method in class org.jfree.data.KeyedObjects
Returns the number of items (values) in the collection.
getItemCount(int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the number of items in the specified series.
getItemCount(int) - Method in class org.jfree.data.statistics.HistogramDataset
Returns the number of data items for a series.
getItemCount() - Method in class org.jfree.data.statistics.SimpleHistogramBin
Returns the item count.
getItemCount(int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the number of items in a series.
getItemCount(int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the number of items in a series.
getItemCount(int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the number of items in the specified series.
getItemCount() - Method in class org.jfree.data.time.TimePeriodValues
Returns the number of items in the series.
getItemCount(int) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the number of items in the specified series.
getItemCount() - Method in class org.jfree.data.time.TimeSeries
Returns the number of items in the series.
getItemCount(int) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the number of items in the specified series.
getItemCount() - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the number of items in ALL series.
getItemCount(int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the number of items in a series.
getItemCount() - Method in interface org.jfree.data.Values
Returns the number of items (values) in the collection.
getItemCount() - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the number of x values in the dataset.
getItemCount(int) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the number of items in the specified series.
getItemCount(int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the number of items in the specified series.
getItemCount(int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the number of items in the specified series.
getItemCount(int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the item count for the specified series.
getItemCount() - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the number of x values in the dataset.
getItemCount(int) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the number of items in the specified series.
getItemCount(int) - Method in class org.jfree.data.xy.DefaultWindDataset
Returns the number of items in a series.
getItemCount(int) - Method in class org.jfree.data.xy.DefaultXYDataset
Returns the number of items in the specified series.
getItemCount(int) - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns the number of items in the specified series.
getItemCount() - Method in class org.jfree.data.xy.MatrixSeries
Returns the number of items in the series.
getItemCount(int) - Method in class org.jfree.data.xy.MatrixSeriesCollection
Returns the number of items in the specified series.
getItemCount() - Method in interface org.jfree.data.xy.TableXYDataset
Returns the number of items every series.
getItemCount(int) - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns the number of items in the specified series.
getItemCount(int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the number of items in the specified series.
getItemCount(int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the number of items in a series.
getItemCount(int) - Method in interface org.jfree.data.xy.XYDataset
Returns the number of items in a series.
getItemCount(int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the number of items in the specified series.
getItemCount() - Method in class org.jfree.data.xy.XYSeries
Returns the number of items in the series.
getItemCount(int) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the number of items in the specified series.
getItemCount(int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the number of items in the specified series.
getItemCreateEntity(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns a boolean that indicates whether or not the specified item should have a chart entity created for it.
getItemFillPaint(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the paint used to fill data items as they are drawn.
getItemFont() - Method in class org.jfree.chart.title.LegendTitle
Returns the item font.
getItemLabelAnchor() - Method in class org.jfree.chart.labels.ItemLabelPosition
Returns the item label anchor.
getItemLabelAnchorOffset() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the item label anchor offset.
getItemLabelFont(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the font for an item label.
getItemLabelFont() - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.getSeriesItemLabelFont(int) and AbstractRenderer.getBaseItemLabelFont().
getItemLabelFont(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the font for an item label.
getItemLabelFont() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.getSeriesItemLabelFont(int) and CategoryItemRenderer.getBaseItemLabelFont().
getItemLabelFont(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the font for an item label.
getItemLabelFont() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.getSeriesItemLabelFont(int) and XYItemRenderer.getBaseItemLabelFont().
getItemLabelGenerator(int, int) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the item label generator for a data item.
getItemLabelGenerator(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the item label generator for the specified data item.
getItemLabelGenerator(int, int) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the label generator for a data item.
getItemLabelGenerator() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Deprecated.
As of version 1.0.6, this override setting should not be used. You can use the base setting instead (AbstractXYItemRenderer.getBaseItemLabelGenerator()).
getItemLabelGenerator(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the item label generator for a data item.
getItemLabelPadding() - Method in class org.jfree.chart.title.LegendTitle
Returns the padding used for the items labels.
getItemLabelPaint(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the paint used to draw an item label.
getItemLabelPaint() - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.getSeriesItemLabelPaint(int) and AbstractRenderer.getBaseItemLabelPaint().
getItemLabelPaint(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the paint used to draw an item label.
getItemLabelPaint() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.getSeriesItemLabelPaint(int) and CategoryItemRenderer.getBaseItemLabelPaint().
getItemLabelPaint(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the paint used to draw an item label.
getItemLabelPaint() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.getSeriesItemLabelPaint(int) and XYItemRenderer.getBaseItemLabelPaint().
getItemLabelPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the item label paint.
getItemLineVisible(int, int) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the flag used to control whether or not the line for an item is visible.
getItemLineVisible(int, int) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns the flag used to control whether or not the shape for an item is visible.
getItemMargin() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the item margin as a percentage of the available space for all bars.
getItemMargin() - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Returns the item margin.
getItemMargin() - Method in class org.jfree.chart.renderer.category.LevelRenderer
Returns the item margin.
getItemMargin() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the item margin, which is the gap between items within a category (expressed as a percentage of the overall category width).
getItemMargin() - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Returns the item margin, which is the gap between items within a category (expressed as a percentage of the overall category width).
getItemMiddle(Comparable, Comparable, CategoryDataset, CategoryAxis, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the Java2D coordinate for the middle of the specified data item.
getItemMiddle(Comparable, Comparable, CategoryDataset, CategoryAxis, Rectangle2D, RectangleEdge) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the Java2D coordinate for the middle of the specified data item.
getItemMiddle(Comparable, Comparable, CategoryDataset, CategoryAxis, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.renderer.category.GanttRenderer
Returns the Java2D coordinate for the middle of the specified data item.
getItemMiddle(Comparable, Comparable, CategoryDataset, CategoryAxis, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.renderer.category.LevelRenderer
Returns the Java2D coordinate for the middle of the specified data item.
getItemOutlinePaint(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the paint used to outline data items as they are drawn.
getItemOutlinePaint(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the paint used to outline data items as they are drawn.
getItemOutlinePaint(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the paint used to outline data items as they are drawn.
getItemOutlineStroke(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the stroke used to outline data items.
getItemOutlineStroke(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the stroke used to outline data items.
getItemOutlineStroke(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the stroke used to outline data items.
getItemPaint(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the paint used to color data items as they are drawn.
getItemPaint(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the paint used to fill data items as they are drawn.
getItemPaint(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the paint used to color data items as they are drawn.
getItemPaint() - Method in class org.jfree.chart.title.LegendTitle
Returns the item paint.
getItemParameterName() - Method in class org.jfree.chart.urls.TimeSeriesURLGenerator
Returns the item parameter name.
getItemRow(int) - Method in class org.jfree.data.xy.MatrixSeries
Returns the row of the specified item.
getItems() - Method in class org.jfree.data.time.TimeSeries
Returns the list of data items for the series (the list contains TimeSeriesDataItem objects and is unmodifiable).
getItems() - Method in class org.jfree.data.xy.XYSeries
Returns the list of data items for the series (the list contains XYDataItem objects and is unmodifiable).
getItemShape(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns a shape used to represent a data item.
getItemShape(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns a shape used to represent a data item.
getItemShape(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns a shape used to represent a data item.
getItemShapeFilled(int, int) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the flag used to control whether or not the shape for an item is filled.
getItemShapeFilled(int, int) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Returns the flag used to control whether or not the shape for an item is filled.
getItemShapeFilled(int, int) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns the flag used to control whether or not the shape for an item is filled.
getItemShapeFilled(int, int) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns the flag used to control whether or not the shape for an item is filled.
getItemShapeVisible(int, int) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the flag used to control whether or not the shape for an item is visible.
getItemShapeVisible(int, int) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns the flag used to control whether or not the shape for an item is visible.
getItemString(int, boolean) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
getItemStroke(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the stroke used to draw data items.
getItemStroke(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the stroke used to draw data items.
getItemStroke(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the stroke used to draw data items.
getItemURLGenerator(int, int) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the URL generator for a data item.
getItemURLGenerator(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the URL generator for an item.
getItemVisible(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns a boolean that indicates whether or not the specified item should be drawn.
getItemVisible(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns a boolean that indicates whether or not the specified item should be drawn (this is typically used to hide an entire series).
getItemVisible(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns a boolean that indicates whether or not the specified item should be drawn (this is typically used to hide an entire series).
getIterationCounter() - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresAdapter
Get a independent Incrementor that counts up to the maximum number of iterations and then throws an exception.
getIterationCounter() - Method in class org.apache.commons.math3.optim.AbstractOptimizationProblem
Get a independent Incrementor that counts up to the maximum number of iterations and then throws an exception.
getIterationCounter() - Method in interface org.apache.commons.math3.optim.OptimizationProblem
Get a independent Incrementor that counts up to the maximum number of iterations and then throws an exception.
getIterationManager() - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
Returns the iteration manager attached to this solver.
getIterations() - Method in interface jhplot.math.num.IterativeMethod.IterativeState
Access the current iteration.
getIterations() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the number of iterations of the last run of the integrator.
getIterations() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the number of iterations of the last run of the integrator.
getIterations() - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresOptimizer.Optimum
Get the number of times the algorithm iterated in order to produce this optimum.
getIterations() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Gets the number of iterations performed by the algorithm.
getIterations() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated.
Get the number of iterations realized by the algorithm.
getIterations() - Method in interface org.apache.commons.math3.optimization.linear.LinearOptimizer
Deprecated.
Get the number of iterations realized by the algorithm.
getIterations() - Method in class org.apache.commons.math3.util.IterationEvent
Returns the number of iterations performed at the time this event is created.
getIterations() - Method in class org.apache.commons.math3.util.IterationManager
Returns the number of iterations of this solver, 0 if no iterations has been performed yet.
getIterativeThreshold() - Method in class jhplot.utils.SHisto
Calculates the threshold using iterative bisection.
getIterator(int[], Object[]) - Static method in class jhplot.math.SortUtils
Answer iterator, which iterates over specified data array according to the specified permutation, that is data[p[0]],..,data[p[data.length-1]]
getIterator(int[], List) - Static method in class jhplot.math.SortUtils
Answer iterator, which iterates over specified data list according to the specified permutation, that is data.get(p[0]),..,data.get(p[data.length-1])
getIthDim(int) - Method in class org.lsmp.djep.vectorJep.Dimensions
 
getITheta() - Method in interface hep.lcio.event.Cluster
Intrinsic direction of cluster at position: Theta.
getITheta() - Method in class hep.lcio.implementation.event.ICluster
 
getITree() - Method in class jhplot.io.FileAida
Return ITree for further manipulations
getJacobian() - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresProblem.Evaluation
Get the weighted Jacobian matrix.
getJacobianEvaluations() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated.
 
getJets() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Jets jets = 3;
getJets() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Jets jets = 3;
getJets() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Jets jets = 3;
getJetsBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Jets jets = 3;
getJetsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Jets jets = 3;
getJetsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Jets jets = 3;
getJetsOrBuilder() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Jets jets = 3;
getJetsSorted() - Method in class hephysics.jet.JetN2
Get jets after sorting in jet pT.
getJetsSorted() - Method in class hephysics.jet.KTjet
Get jets after sorting in jet pT.
getJetsSorted() - Method in class hephysics.jet.SCJet
Get jets after sorting in jet pT.
getJPanel() - Method in class jhplot.gui.GHMargin
Return JPanel of this margin
getJPlot(int, int) - Method in class jhplot.HPlot
Get jplots for each graph
getJPlot() - Method in class jhplot.HPlot
Get jplots for each graph for current graph
getJPoints() - Method in interface jplot3d.SurfaceModel
 
getJPoints() - Method in class jplot3d.SurfaceModelCanvas
Return points for plotting
getJustification() - Method in class graph.TextLine
 
getK() - Method in class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Return the number of clusters this instance will use.
getK() - Method in class org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer
Return the number of clusters this instance will use.
getK() - Method in class org.apache.commons.math3.util.Combinations
Gets the number of elements in each combination.
getKey() - Method in class jhplot.io.db.RecordWriter
 
getKey(int) - Method in class jhplot.io.FileRoot
Get a key using its index.
getKey(String) - Method in class jhplot.io.FileRoot
Get a key
getKey() - Method in class org.apache.commons.math3.util.Pair
Get the key.
getKey() - Method in class org.jfree.chart.entity.CategoryLabelEntity
Returns the category key.
getKey() - Method in class org.jfree.chart.plot.CategoryMarker
Returns the key.
getKey() - Method in class org.jfree.chart.plot.PieLabelRecord
Returns the key for the section that the label applies to.
getKey(int) - Method in class org.jfree.data.category.CategoryToPieDataset
Returns the key at the specified index.
getKey() - Method in class org.jfree.data.DefaultKeyedValue
Returns the key.
getKey(int) - Method in class org.jfree.data.DefaultKeyedValues
Returns a key.
getKey() - Method in class org.jfree.data.general.DefaultKeyedValueDataset
Returns the key associated with the value, or null if the dataset has no data item.
getKey(int) - Method in class org.jfree.data.general.DefaultPieDataset
Returns the key for the specified item, or null.
getKey() - Method in class org.jfree.data.general.Series
Returns the key for the series.
getKey() - Method in class org.jfree.data.KeyedObject
Returns the key.
getKey(int) - Method in class org.jfree.data.KeyedObjects
Returns the key at the specified position in the list.
getKey() - Method in interface org.jfree.data.KeyedValue
Returns the key associated with the value.
getKey(int) - Method in interface org.jfree.data.KeyedValues
Returns the key associated with the item at a given position.
getKey() - Method in class org.jfree.data.xml.ItemHandler
Returns the key that has been read by the handler, or null.
getKey(int[]) - Method in class org.jlab.groot.matrix.SparseIndex
 
getKey() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
getKey() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
getKey() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
getKey() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
getKey() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
getKey() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
getKey() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
required string key = 1;
getKey() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
required string key = 1;
getKey() - Method in interface proeic.io.ProMCStatFile.ProMCStat.MetaFloatOrBuilder
required string key = 1;
getKey() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
required string key = 1;
getKey() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
required string key = 1;
getKey() - Method in interface proeic.io.ProMCStatFile.ProMCStat.MetaIntOrBuilder
required string key = 1;
getKey() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
getKey() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
getKey() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
getKey() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
getKey() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
getKey() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
getKey() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
getKey() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
getKey() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
getKey() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
getKey() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
getKey() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
getKey() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
getKey() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
getKey() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
getKey() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
getKey() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
getKey() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
getKeyBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
getKeyBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
getKeyBytes() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
getKeyBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
getKeyBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
getKeyBytes() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
getKeyBytes() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
required string key = 1;
getKeyBytes() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
required string key = 1;
getKeyBytes() - Method in interface proeic.io.ProMCStatFile.ProMCStat.MetaFloatOrBuilder
required string key = 1;
getKeyBytes() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
required string key = 1;
getKeyBytes() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
required string key = 1;
getKeyBytes() - Method in interface proeic.io.ProMCStatFile.ProMCStat.MetaIntOrBuilder
required string key = 1;
getKeyBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
getKeyBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
getKeyBytes() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
getKeyBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
getKeyBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
getKeyBytes() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
getKeyBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
getKeyBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
getKeyBytes() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
getKeyBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
getKeyBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
getKeyBytes() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
getKeyBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
getKeyBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
getKeyBytes() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
getKeyBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
getKeyBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
getKeyBytes() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
getKeyColor() - Method in class jhplot.HKey
Get key color
getKeyColor() - Method in class jplot.GraphLabel
 
getKeyCount(Comparable) - Method in class org.jfree.data.KeyToGroupMap
Returns the number of keys mapped to the specified group.
getKeyFast(int[]) - Method in class org.jlab.groot.matrix.SparseIndex
 
getKeyLineWidth() - Method in class jplot.GraphLabel
 
getKeys() - Method in class jhplot.io.FileRoot
Return all keys of the current directory as a list.
getKeys() - Method in class jhplot.io.HBook
Return array of all know keys
getKeys() - Method in class jhplot.io.HDataBase
Returns an enumeration of all the keys in the database.
getKeys() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets all the keys stored in the exception
getKeys() - Method in class org.jfree.data.category.CategoryToPieDataset
Returns the keys for the dataset.
getKeys() - Method in class org.jfree.data.DefaultKeyedValues
Returns the keys for the values in the collection.
getKeys() - Method in class org.jfree.data.general.DefaultPieDataset
Returns the categories in the dataset.
getKeys() - Method in class org.jfree.data.KeyedObjects
Returns a list containing all the keys in the list.
getKeys() - Method in interface org.jfree.data.KeyedValues
Returns the keys for the values in the collection.
getKeysH1D() - Method in class jhplot.io.CFBook
Get keys of all known H1D histograms.
getKeysH2D() - Method in class jhplot.io.CFBook
Get keys of all known H2D histograms.
getKeySize() - Method in class jhplot.HKey
Get key size
getKeySize() - Method in class jplot.GraphLabel
 
getKeysP1D() - Method in class jhplot.io.CFBook
Get keys of all known P1D containers.
getKeySpace() - Method in class jhplot.HKey
Get a space between the key and the text describing the key
getKeySpace() - Method in class jplot.GraphLabel
 
getKeyType() - Method in class jhplot.HKey
Get key type
getKeyType() - Method in class jplot.GraphLabel
 
getKeyValue(String) - Method in class graph.ScanString
 
getKeyValue(String) - Method in class graph.ScanWord
return the matching token given the keyword
getKnots() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Get an array copy of the knot points.
getKtDistance1(ParticleF) - Method in class hephysics.jet.KTjet
This is the KT distance to the beam (assuming Z=Y=0).
getKtDistance1(ParticleD) - Method in class hephysics.jet.SCJet
This is the KT distance to the beam (assuming Z=Y=0).
getKtDistance12(ParticleF, ParticleF) - Method in class hephysics.jet.KTjet
Calculate delta R distance.
getKtDistance12(ParticleD, ParticleD) - Method in class hephysics.jet.SCJet
Calculate delta R distance.
getKthSelector() - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Get the kthSelector used for computation.
getKurtosis() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the Kurtosis of the available values.
getKurtosisImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured kurtosis implementation.
getL() - Method in class cern.colt.matrix.linalg.CholeskyDecomposition
Returns the triangular factor, L.
getL() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns the lower triangular factor, L.
getL() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns the lower triangular factor, L.
getL() - Method in class Jama.CholeskyDecomposition
Return triangular factor.
getL() - Method in class Jama.LUDecomposition
Return lower triangular factor
getL() - Method in class jhplot.math.CholeskyDecomposition
Return triangular factor.
getL() - Method in class jhplot.math.kalman.jama.LUDecomposition
Return lower triangular factor
getL() - Method in class jhplot.math.LUDecomposition
Return lower triangular factor
getL() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
Returns the matrix L of the decomposition.
getL() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Returns the matrix L of the decomposition.
getL() - Method in class org.apache.commons.math3.linear.LUDecomposition
Returns the matrix L of the decomposition.
getL1Distance(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Distance between two vectors.
getL1Distance(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Distance between two vectors.
getL1Distance(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Distance between two vectors.
getL1Distance(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Distance between two vectors.
getL1Norm() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Returns the L1 norm of the vector.
getL1Norm() - Method in class org.apache.commons.math3.linear.RealVector
Returns the L1 norm of the vector.
getLabel(String) - Static method in class jplot.MyUtils
Make a label specifically used by the tic-panel.
getLabel() - Method in class jplot.Utils.LabeledTextField
 
getLabel() - Method in class org.jfree.chart.axis.Axis
Returns the label for the axis.
getLabel() - Method in class org.jfree.chart.axis.CategoryTick
Returns the label.
getLabel() - Method in class org.jfree.chart.LegendItem
Returns the label.
getLabel() - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Returns the label text.
getLabel() - Method in class org.jfree.chart.plot.Marker
Returns the label (if null no label is displayed).
getLabel() - Method in class org.jfree.chart.plot.MeterInterval
Returns the label.
getLabel() - Method in class org.jfree.chart.plot.PieLabelRecord
Returns the label.
getLabelAnchor() - Method in class org.jfree.chart.axis.CategoryLabelPosition
Returns the text block anchor.
getLabelAnchor() - Method in class org.jfree.chart.axis.CategoryTick
Returns the label anchor.
getLabelAnchor() - Method in class org.jfree.chart.plot.Crosshair
Returns the label anchor point.
getLabelAnchor() - Method in class org.jfree.chart.plot.Marker
Returns the label anchor.
getLabelAngle() - Method in class org.jfree.chart.axis.Axis
Returns the angle of the axis label.
getLabelBackgroundColor() - Method in class org.jfree.chart.plot.Marker
Returns the label background color.
getLabelBackgroundPaint() - Method in class org.jfree.chart.plot.Crosshair
Returns the label background paint.
getLabelBackgroundPaint() - Method in class org.jfree.chart.plot.PiePlot
Returns the section label background paint.
getLabelColor() - Method in class jhplot.HChart
Get label color.
getLabelColor() - Method in class jhplot.HPlot3D
Get label color
getLabelColor() - Method in interface jplot3d.SurfaceModel
 
getLabelColor() - Method in class jplot3d.SurfaceModelCanvas
 
getLabelDistributor() - Method in class org.jfree.chart.plot.PiePlot
Returns the object responsible for the vertical layout of the pie section labels.
getLabelFont() - Method in interface jplot3d.SurfaceModel
 
getLabelFont() - Method in class jplot3d.SurfaceModelCanvas
 
getLabelFont() - Method in class org.jfree.chart.axis.Axis
Returns the font for the axis label.
getLabelFont() - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Returns the label font.
getLabelFont() - Method in class org.jfree.chart.LegendItem
Returns the label font.
getLabelFont() - Method in class org.jfree.chart.plot.CompassPlot
Returns the label font.
getLabelFont() - Method in class org.jfree.chart.plot.Crosshair
Returns the label font.
getLabelFont() - Method in class org.jfree.chart.plot.Marker
Returns the label font.
getLabelFont() - Method in class org.jfree.chart.plot.PiePlot
Returns the section label font.
getLabelFont() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the series label font.
getLabelFont() - Method in class org.jlab.groot.base.AxisAttributes
 
getLabelFont() - Method in class org.jlab.groot.graphics.GraphicsAxis
returns properties for the label fonts.
getLabelFont() - Method in class org.jlab.groot.ui.GraphicsAxis
returns properties for the label fonts.
getLabelFontName() - Method in class org.jlab.groot.base.AxisAttributes
 
getLabelFontSize() - Method in class org.jlab.groot.base.AxisAttributes
 
getLabelFontSize() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getLabelFormat() - Method in class org.jfree.chart.labels.AbstractCategoryItemLabelGenerator
Returns the label format string.
getLabelFormat() - Method in class org.jfree.chart.labels.AbstractPieItemLabelGenerator
Returns the label format string.
getLabelFraction(Graphics2D, boolean) - Method in class org.jlab.groot.ui.GraphicsAxis
 
getLabelGap() - Method in class org.jfree.chart.plot.PiePlot
Returns the gap between the edge of the pie and the labels, expressed as a percentage of the plot width.
getLabelGenerator() - Method in class org.jfree.chart.plot.Crosshair
Returns the crosshair label generator.
getLabelGenerator() - Method in class org.jfree.chart.plot.PiePlot
Returns the section label generator.
getLabelGenerator() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the label generator.
getLabelHeight() - Method in class org.jfree.chart.plot.PieLabelRecord
Returns the label height (you could derive this from the label itself, but we cache the value so it can be retrieved quickly).
getLabelInfo() - Method in class org.jfree.chart.axis.PeriodAxis
Returns an array of label info records.
getLabelInsets() - Method in class org.jfree.chart.axis.Axis
Returns the insets for the label (that is, the amount of blank space that should be left around the label).
getLabelLinkMargin() - Method in class org.jfree.chart.plot.PiePlot
Returns the margin (expressed as a percentage of the width or height) between the edge of the pie and the link point.
getLabelLinkPaint() - Method in class org.jfree.chart.plot.PiePlot
Returns the paint used for the lines that connect pie sections to their corresponding labels.
getLabelLinkPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the label link paint for pie charts.
getLabelLinkStroke() - Method in class org.jfree.chart.plot.PiePlot
Returns the stroke used for the label linking lines.
getLabelLinkStyle() - Method in class org.jfree.chart.plot.PiePlot
Returns the label link style.
getLabelLinkStyle() - Method in class org.jfree.chart.StandardChartTheme
Returns the label link style for pie charts.
getLabelLinksVisible() - Method in class org.jfree.chart.plot.PiePlot
Returns the flag that controls whether or not label linking lines are visible.
getLabelLocation() - Method in class org.jfree.chart.axis.Axis
Returns the location of the axis label.
getLabelOffset(int) - Method in class jhplot.HPlot3D
Get offset for labels on X
getLabelOffset() - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Returns the label offset.
getLabelOffset() - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Returns the label offset.
getLabelOffset() - Method in class org.jfree.chart.plot.Marker
Returns the label offset.
getLabelOffset() - Method in class org.jlab.groot.base.AxisAttributes
 
getLabelOffsetType() - Method in class org.jfree.chart.plot.Marker
Returns the label offset type.
getLabelOffsetX() - Method in interface jplot3d.SurfaceModel
 
getLabelOffsetX() - Method in class jplot3d.SurfaceModelCanvas
 
getLabelOffsetY() - Method in interface jplot3d.SurfaceModel
 
getLabelOffsetY() - Method in class jplot3d.SurfaceModelCanvas
 
getLabelOffsetZ() - Method in interface jplot3d.SurfaceModel
 
getLabelOffsetZ() - Method in class jplot3d.SurfaceModelCanvas
 
getLabelOutlinePaint() - Method in class org.jfree.chart.plot.Crosshair
Returns the label outline paint.
getLabelOutlinePaint() - Method in class org.jfree.chart.plot.PiePlot
Returns the section label outline paint.
getLabelOutlineStroke() - Method in class org.jfree.chart.plot.Crosshair
Returns the label outline stroke.
getLabelOutlineStroke() - Method in class org.jfree.chart.plot.PiePlot
Returns the section label outline stroke.
getLabelPadding() - Method in class org.jfree.chart.plot.PiePlot
Returns the label padding.
getLabelPaint() - Method in class org.jfree.chart.axis.Axis
Returns the color/shade used to draw the axis label.
getLabelPaint() - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Returns the label paint.
getLabelPaint() - Method in class org.jfree.chart.LegendItem
Returns the paint used to draw the label.
getLabelPaint() - Method in class org.jfree.chart.plot.Crosshair
Returns the label paint.
getLabelPaint() - Method in class org.jfree.chart.plot.Marker
Returns the label paint.
getLabelPaint() - Method in class org.jfree.chart.plot.PiePlot
Returns the section label paint.
getLabelPaint() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the series label paint.
getLabelPanel() - Method in class jplot.JPlot
 
getLabelPosition(RectangleEdge) - Method in class org.jfree.chart.axis.CategoryLabelPositions
Returns the category label position specification for an axis at the given location.
getLabelPosition() - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Returns the label position.
getLabelPrecision() - Method in class graph.Contour
Get the label precision.
getLabels() - Method in class jplot.GraphSettings
Returns a vector with the graph labels.
getLabels() - Method in class org.jlab.groot.ui.GraphicsAxisLabels
 
getLabelShadowPaint() - Method in class org.jfree.chart.plot.PiePlot
Returns the section label shadow paint.
getLabelSignificance() - Method in class graph.Contour
Get the number of significant figures for labels.
getLabelStyle() - Method in class graph.Contour
Get the label style, either TextLine.SCIENTIFIC or TextLine.ALGEBRAIC.
getLabelTemplate() - Method in class org.jfree.chart.labels.StandardCrosshairLabelGenerator
Returns the label template string.
getLabelTextAnchor() - Method in class org.jfree.chart.plot.Marker
Returns the label text anchor.
getLabelTicks(int) - Method in class jplot.GraphSettings
Return tick labels used to make plots.
getLabelType() - Method in class org.jfree.chart.plot.CompassPlot
Returns the label type.
getLabelX() - Method in class jhplot.Plottable
Get the label X
getLabelXOffset() - Method in class org.jfree.chart.plot.Crosshair
Returns the x-offset for the label (in Java2D units).
getLabelY() - Method in class jhplot.Plottable
Get label Y
getLabelYOffset() - Method in class org.jfree.chart.plot.Crosshair
Returns the y-offset for the label (in Java2D units).
getLabelZ() - Method in class jhplot.Plottable
Get label Z
getLargeFont() - Method in class org.jfree.chart.StandardChartTheme
Returns the large font for this theme.
getLargerTickUnit(TickUnit) - Method in class org.jfree.chart.axis.NumberTickUnitSource
 
getLargerTickUnit(TickUnit) - Method in class org.jfree.chart.axis.StandardTickUnitSource
Returns a tick unit that is larger than the supplied unit.
getLargerTickUnit(TickUnit) - Method in class org.jfree.chart.axis.TickUnits
Returns a tick unit that is larger than the supplied unit.
getLargerTickUnit(TickUnit) - Method in interface org.jfree.chart.axis.TickUnitSource
Returns the smallest tick unit available in the source that is larger than unit or, if there is no larger unit, returns unit.
getLargest() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Deprecated.
Get the node whose element is the largest one in the tree.
getLast() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the last time period in the axis range.
getLastBarPaint() - Method in class org.jfree.chart.renderer.category.WaterfallBarRenderer
Returns the paint used to draw the last bar.
getLastDim() - Method in class org.lsmp.djep.vectorJep.Dimensions
get the last dimension, 1 for numbers, or the length of a vector.
getLastItemIndex() - Method in class org.jfree.chart.renderer.xy.XYItemRendererState
Returns the last item index (this is updated with each call to XYItemRendererState.startSeriesPass(XYDataset, int, int, int, int, int).
getLastMillisecond() - Method in class org.jfree.data.time.Day
Returns the last millisecond of the day.
getLastMillisecond(Calendar) - Method in class org.jfree.data.time.Day
Returns the last millisecond of the day, evaluated using the supplied calendar (which determines the time zone).
getLastMillisecond() - Method in class org.jfree.data.time.FixedMillisecond
Returns the last millisecond of the time period.
getLastMillisecond(Calendar) - Method in class org.jfree.data.time.FixedMillisecond
Returns the last millisecond of the time period.
getLastMillisecond() - Method in class org.jfree.data.time.Hour
Returns the last millisecond of the hour.
getLastMillisecond(Calendar) - Method in class org.jfree.data.time.Hour
Returns the last millisecond of the hour.
getLastMillisecond() - Method in class org.jfree.data.time.Millisecond
Returns the last millisecond of the second.
getLastMillisecond(Calendar) - Method in class org.jfree.data.time.Millisecond
Returns the last millisecond of the time period.
getLastMillisecond() - Method in class org.jfree.data.time.Minute
Returns the last millisecond of the minute.
getLastMillisecond(Calendar) - Method in class org.jfree.data.time.Minute
Returns the last millisecond of the minute.
getLastMillisecond() - Method in class org.jfree.data.time.Month
Returns the last millisecond of the month.
getLastMillisecond(Calendar) - Method in class org.jfree.data.time.Month
Returns the last millisecond of the month, evaluated using the supplied calendar (which determines the time zone).
getLastMillisecond() - Method in class org.jfree.data.time.Quarter
Returns the last millisecond of the quarter.
getLastMillisecond(Calendar) - Method in class org.jfree.data.time.Quarter
Returns the last millisecond of the Quarter, evaluated using the supplied calendar (which determines the time zone).
getLastMillisecond() - Method in class org.jfree.data.time.RegularTimePeriod
Returns the last millisecond of the time period.
getLastMillisecond(TimeZone) - Method in class org.jfree.data.time.RegularTimePeriod
Deprecated.
As of 1.0.3, you should avoid using this method (it creates a new Calendar instance every time it is called). You are advised to call RegularTimePeriod.getLastMillisecond(Calendar) instead.
getLastMillisecond(Calendar) - Method in class org.jfree.data.time.RegularTimePeriod
Returns the last millisecond of the time period, evaluated using the supplied calendar (which incorporates a timezone).
getLastMillisecond() - Method in class org.jfree.data.time.Second
Returns the last millisecond of the second.
getLastMillisecond(Calendar) - Method in class org.jfree.data.time.Second
Returns the last millisecond of the second.
getLastMillisecond() - Method in class org.jfree.data.time.Week
Returns the last millisecond of the week.
getLastMillisecond(Calendar) - Method in class org.jfree.data.time.Week
Returns the last millisecond of the week, evaluated using the supplied calendar (which determines the time zone).
getLastMillisecond() - Method in class org.jfree.data.time.Year
Returns the last millisecond of the year.
getLastMillisecond(Calendar) - Method in class org.jfree.data.time.Year
Returns the last millisecond of the year, evaluated using the supplied calendar (which determines the time zone).
getLastModified() - Method in class jplot.DataFile
Returns the modification date of the file in ms, I guess.
getLastModified() - Method in class org.apache.commons.io.monitor.FileEntry
Return the last modified time from the last time it was checked.
getLatestAngle() - Method in class org.jfree.chart.plot.PiePlotState
Returns the latest angle.
getLayerIndex(DialLayer) - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the index for the specified layer.
getLCIOXML() - Static method in class hep.lcio.util.SIODumpCommandHandler
Get an @org.jdom.Element for the lcio.xml root.
getLE() - Method in class org.nfunk.jep.OperatorSet
 
getLeading(Graphics) - Method in class graph.TextLine
 
getLeft() - Method in class org.jfree.chart.axis.AxisSpace
Returns the space reserved for axes at the left of the plot area.
getLeftArrow() - Method in class org.jfree.chart.axis.ValueAxis
Returns a shape that can be displayed as an arrow pointing left at the end of an axis line.
getLeftEdge(VectorGraphics) - Method in class graph.RTextLine
Return the left edge of the rotated text.
getLeftEdge(VectorGraphics, int) - Method in class graph.RTextLine
Return the left edge of the rotated text.
getLeftMargin() - Method in class jplot.GraphSettings
Returns the distance between the left-border of the panel and the left Y-axis.
getLeftMargin() - Method in class org.jlab.groot.base.PadMargins
 
getLegend() - Method in class jhplot.DrawOptions
Returns true if this line style should draw the name in the legend of the graph, false otherwise
getLegend(int) - Method in class jplot.DataFile
 
getLegend() - Method in class org.jfree.chart.JFreeChart
Returns the legend for the chart, if there is one.
getLegend(int) - Method in class org.jfree.chart.JFreeChart
Returns the nth legend for a chart, or null.
getLegendArea() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Returns the shape used to represent an area in the legend.
getLegendArea() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer2
Returns the shape used to represent an area in the legend.
getLegendBackgroundPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the legend background paint.
getLegendBar() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the shape used to represent bars in each legend item.
getLegendCollection() - Method in class org.jfree.chart.renderer.WaferMapRenderer
Builds the list of legend entries.
getLegendFont() - Method in class jhplot.HPlot
Returns the font used by the legend.
getLegendFont() - Method in class jplot.GraphSettings
Returns the font used by the legend.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns a legend item for a series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.category.AreaRenderer
Returns a legend item for a series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns a legend item for a series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Returns a legend item for a series.
getLegendItem(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns a legend item for a series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.category.CategoryStepRenderer
Returns a legend item for a series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns a legend item for a series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Returns a legend item for a series.
getLegendItem(int) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Return the legend for the given series.
getLegendItem(int) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Return the legend for the given series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns a default legend item for the specified series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns a legend item for a series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Returns a default legend item for the specified series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer2
Returns a default legend item for the specified series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns a default legend item for the specified series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.xy.XYBubbleRenderer
Returns a legend item for the specified series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Returns a default legend item for the specified series.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.xy.XYDotRenderer
Returns a legend item for the specified series.
getLegendItem(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns a legend item for a series from a dataset.
getLegendItem(int, int) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns a legend item for the specified series.
getLegendItemCount() - Method in class org.jfree.data.jdbc.JDBCXYDataset
Deprecated.
This method is not used in JFreeChart 1.0.x (it was left in the API by mistake and is officially deprecated from version 1.0.3 onwards).
getLegendItemGraphicAnchor() - Method in class org.jfree.chart.title.LegendTitle
Returns the legend item graphic anchor.
getLegendItemGraphicEdge() - Method in class org.jfree.chart.title.LegendTitle
Returns the location of the shape within each legend item.
getLegendItemGraphicLocation() - Method in class org.jfree.chart.title.LegendTitle
Returns the legend item graphic location.
getLegendItemGraphicPadding() - Method in class org.jfree.chart.title.LegendTitle
Returns the padding that will be applied to each item graphic.
getLegendItemLabelGenerator() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the legend item label generator.
getLegendItemLabelGenerator() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the legend item label generator.
getLegendItemLabelGenerator() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the legend item label generator.
getLegendItemLabels() - Method in class org.jfree.data.jdbc.JDBCXYDataset
Deprecated.
This method is not used in JFreeChart 1.0.x (it was left in the API by mistake and is officially deprecated from version 1.0.3 onwards).
getLegendItemPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the legend item paint.
getLegendItems() - Method in interface org.jfree.chart.LegendItemSource
Returns a (possibly empty) collection of legend items.
getLegendItems() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the legend items for the plot.
getLegendItems() - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Returns a collection of legend items for the plot.
getLegendItems() - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Returns a collection of legend items for the plot.
getLegendItems() - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Returns a collection of legend items for the plot.
getLegendItems() - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Returns a collection of legend items for the plot.
getLegendItems() - Method in class org.jfree.chart.plot.CompassPlot
Returns the legend items for the plot.
getLegendItems() - Method in class org.jfree.chart.plot.MeterPlot
Returns an item for each interval.
getLegendItems() - Method in class org.jfree.chart.plot.MultiplePiePlot
Returns a collection of legend items for the pie chart.
getLegendItems() - Method in class org.jfree.chart.plot.PiePlot
Returns a collection of legend items for the pie chart.
getLegendItems() - Method in class org.jfree.chart.plot.Plot
Returns the legend items for the plot.
getLegendItems() - Method in class org.jfree.chart.plot.PolarPlot
Returns the legend items for the plot.
getLegendItems() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns a collection of legend items for the spider web chart.
getLegendItems() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the legend items for the plot.
getLegendItems() - Method in class org.jfree.chart.plot.WaferMapPlot
Return the legend items from the renderer.
getLegendItems() - Method in class org.jfree.chart.plot.XYPlot
Returns the legend items for the plot.
getLegendItems() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns a (possibly empty) collection of legend items for the series that this renderer is responsible for drawing.
getLegendItems() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns a (possibly empty) collection of legend items for the series that this renderer is responsible for drawing.
getLegendItemShape() - Method in class org.jfree.chart.plot.MultiplePiePlot
Returns the shape used for legend items.
getLegendItemShape() - Method in class org.jfree.chart.plot.PiePlot
Returns the shape used for legend items.
getLegendItemShape() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the shape used for legend items.
getLegendItemToolTipGenerator() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the legend item tool tip generator.
getLegendItemToolTipGenerator() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns the legend item tool tip generator.
getLegendItemToolTipGenerator() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the legend item tool tip generator.
getLegendItemURLGenerator() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the legend item URL generator.
getLegendItemURLGenerator() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns the legend item URL generator.
getLegendItemURLGenerator() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the legend item URL generator.
getLegendLabelGenerator() - Method in class org.jfree.chart.plot.PiePlot
Returns the legend label generator.
getLegendLabelToolTipGenerator() - Method in class org.jfree.chart.plot.PiePlot
Returns the legend label tool tip generator.
getLegendLabelURLGenerator() - Method in class org.jfree.chart.plot.PiePlot
Returns the legend label URL generator.
getLegendLine() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns the shape used to represent a line in the legend.
getLegendLine() - Method in class org.jfree.chart.renderer.xy.SamplingXYLineRenderer
Deprecated.
As of version 1.0.14, this method is deprecated. You should use the AbstractRenderer.getBaseLegendShape() method instead.
getLegendLine() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns the shape used to represent a line in the legend.
getLegendLine() - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Returns the shape used to represent a line in the legend.
getLegendLine() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns the shape used to represent a line in the legend.
getLegendPanel() - Method in class jplot.JPlot
 
getLegendPos(int) - Method in class jhplot.HPlot
Returns the x or y coordinates (defined in pixels, relative to the size of the panel showing the graph) of the legend.
getLegendPosition(int) - Method in class jplot.GraphSettings
Returns the x or y coordinates (defined in pixels, relative to the size of the panel showing the graph) of the legend.
getLegendPosUse() - Method in class jhplot.HPlot
Returns whether or not we use the legend coordinates.
getLegendShape(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the legend shape defined for the specified series (possibly null).
getLegendShape() - Method in class org.jfree.chart.renderer.xy.XYDotRenderer
Returns the shape used to represent an item in the legend.
getLegendSpacing() - Method in class jhplot.HPlot
Returns the vertical spacing, between each line of the legend.
getLegendSpacing() - Method in class jplot.GraphSettings
Returns the vertical spacing, between each line of the legend.
getLegendTextFont(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the legend text font defined for the specified series (possibly null).
getLegendTextPaint(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the legend text paint defined for the specified series (possibly null).
getLength() - Method in class org.apache.commons.io.monitor.FileEntry
Return the length.
getLength() - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
Returns the length of the chromosome.
getLength() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Deprecated.
as of 3.1, replaced by Interval.getSize()
getLength() - Method in class org.apache.commons.math3.geometry.spherical.twod.Edge
Get the length of the arc.
getLength() - Method in class org.jfree.data.Range
Returns the length of the range.
getLength() - Method in class org.jfree.data.xy.Vector
Returns the length of the vector.
getLength() - Method in class org.jlab.groot.math.Dimension1D
 
getLengthUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
getLengthUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 LengthUnit = 17;
getLengthUnit() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 LengthUnit = 17;
getLengthUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
getLengthUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 LengthUnit = 17;
getLengthUnit() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 LengthUnit = 17;
getLengthUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
getLengthUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 LengthUnit = 17;
getLengthUnit() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 LengthUnit = 17;
getLengthUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
getLengthUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 LengthUnit = 17;
getLengthUnit() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 LengthUnit = 17;
getLevel() - Method in class org.apache.commons.io.monitor.FileEntry
Return the level
getLevels() - Method in class graph.Contour
Return the contour levels.
getLevels() - Method in class jplot.Contour
Return the contour levels.
getLifetime() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
getLifetime() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float lifetime = 5;
getLifetime() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float lifetime = 5;
getLifetime() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
getLifetime() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float lifetime = 5;
getLifetime() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float lifetime = 5;
getLifetime() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
getLifetime() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float lifetime = 5;
getLifetime() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float lifetime = 5;
getLifetime() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
getLifetime() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float lifetime = 5;
getLifetime() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float lifetime = 5;
getLikelihood() - Method in interface hep.lcio.event.ParticleID
The likelihood of this hypothesis - in a user defined normalization.
getLikelihood() - Method in class hep.lcio.implementation.event.IParticleID
 
getLimit() - Method in class jhplot.stat.CLimits
Build a Confidence level.
getLimit(Random) - Method in class jhplot.stat.CLimits
Build a Confidence level with a custom Random() to build Poisson random numbers.
getLimit() - Method in class org.jfree.chart.plot.MultiplePiePlot
Returns the limit (as a percentage) below which small pie sections are aggregated.
getLimitGuess() - Method in class jhplot.stat.limit.StatConfidence
Get limit guess
getLimits() - Method in class jhplot.FProxy
Get limits if any.
getLimits() - Method in class org.jlab.groot.math.Axis
A getter for the array of bin limits
getLine() - Method in class jplot3dp.MathParser.SimpleCharStream
Deprecated. 
getLine() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Segment
Get the line containing the segment.
getLine() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Segment
Get the line containing the segment.
getLine() - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Returns the list.
getLine() - Method in class org.jfree.chart.LegendItem
Returns the line.
getLine() - Method in class org.jfree.chart.title.LegendGraphic
Returns the line centered about (0, 0).
getLine() - Method in class org.nfunk.jep.JavaCharStream
Deprecated. 
getLinearFit(Number[], Number[]) - Static method in class org.jfree.data.statistics.Statistics
Fits a straight line to a set of (x, y) data, returning the slope and intercept.
getLineBoxColor() - Method in class jplot3d.ColorModelSet
 
getLineBoxColor() - Method in interface jplot3d.SurfaceColor
 
getLineColor() - Method in class jhplot.FPR
Get line color
getLineColor() - Method in class jplot3d.ColorModelSet
 
getLineColor(int, float) - Method in class jplot3d.ColorModelSet
 
getLineColor() - Method in interface jplot3d.SurfaceColor
 
getLineColor(int, float) - Method in interface jplot3d.SurfaceColor
 
getLineColor() - Method in class org.jlab.groot.base.AxisAttributes
 
getLineColor() - Method in class org.jlab.groot.base.DatasetAttributes
 
getLineColor() - Method in class org.jlab.groot.data.GraphErrors
 
getLineColor() - Method in class org.jlab.groot.data.H1F
 
getLineColor() - Method in class org.jlab.groot.math.Func1D
 
getLinePaint() - Method in class org.jfree.chart.LegendItem
Returns the paint used for lines.
getLinePaint() - Method in class org.jfree.chart.title.LegendGraphic
Returns the line paint.
getLineParm() - Method in class jhplot.DrawOptions
Get all drawing parameters.
getLinePars() - Method in class jhplot.P1D
get LinePars class which holds graphical attributes
getLinePars() - Method in class jplot.DataArray
Get the drawing style parameters at once.
getLinePars() - Method in class jplot.DataArray3D
Get the drawing style parameters at once.
getLinePars(int) - Method in class jplot.DataFile
returns the linestyle of one of the vector items.
getLinePars() - Method in class jplot.LineStyle
 
getLinePars() - Method in class jplot.LineStyleButton
 
getLineSegments() - Method in class org.apache.commons.math3.geometry.euclidean.twod.hull.ConvexHull2D
Get the line segments of the convex hull, ordered.
getLineStroke() - Method in class org.jfree.chart.LegendItem
Returns the line stroke for the series.
getLineStroke() - Method in class org.jfree.chart.title.LegendGraphic
Returns the line stroke.
getLineStyle() - Method in class jhplot.DrawOptions
Get line style.
getLineStyle() - Method in class org.jlab.groot.base.AxisAttributes
 
getLineStyle() - Method in class org.jlab.groot.base.DatasetAttributes
 
getLineStyle() - Method in class org.jlab.groot.base.PadAttributes
 
getLineStyle() - Method in class org.jlab.groot.math.Func1D
 
getLinesVisible() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Deprecated.
As of 1.0.7 (the override facility is unnecessary, just use the per-series and base (default) settings).
getLinesVisible() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Deprecated.
As of 1.0.7, use the per-series and base level settings.
getLineThickness() - Method in class org.jlab.groot.data.GraphErrors
 
getLineWidth() - Method in class jhplot.HKey
Get a key line width
getLineWidth() - Method in class org.jlab.groot.base.AxisAttributes
 
getLineWidth() - Method in class org.jlab.groot.base.DatasetAttributes
 
getLineWidth() - Method in class org.jlab.groot.base.PadAttributes
 
getLineWidth() - Method in class org.jlab.groot.data.H1F
 
getLineWidth() - Method in class org.jlab.groot.math.Func1D
 
getLInfDistance(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Distance between two vectors.
getLInfDistance(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Distance between two vectors.
getLInfDistance(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Distance between two vectors.
getLInfNorm() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Returns the L norm of the vector.
getLInfNorm() - Method in class org.apache.commons.math3.linear.RealVector
Returns the L norm of the vector.
getLinkArea() - Method in class org.jfree.chart.plot.PiePlotState
Returns the link area.
getLinkPercent() - Method in class org.jfree.chart.plot.PieLabelRecord
Returns the link percent.
getList(int) - Method in class org.jlab.groot.group.DataGroupDescriptor
 
getList() - Method in class org.nfunk.jep.OperatorSet
 
getListCellRendererComponent(JList, Object, int, boolean, boolean) - Method in class org.jfree.chart.editor.PaletteSample
Deprecated.
Returns a list cell renderer for the stroke, so the sample can be displayed in a list or combo.
getListCount() - Method in class org.jfree.chart.labels.CustomXYToolTipGenerator
Returns the number of tool tip lists stored by the renderer.
getListCount() - Method in class org.jfree.chart.urls.CustomCategoryURLGenerator
Returns the number of URL lists stored by the renderer.
getListCount() - Method in class org.jfree.chart.urls.CustomPieURLGenerator
Returns the number of URL maps stored by the renderer.
getListCount() - Method in class org.jfree.chart.urls.CustomXYURLGenerator
Returns the number of URL lists stored by the renderer.
getListeners() - Method in class org.apache.commons.io.monitor.FileAlterationObserver
Returns the set of registered file system listeners.
getListeners(Class) - Method in class org.jfree.chart.ChartPanel
Returns an array of the listeners of the given type registered with the panel.
getListeners(Class) - Method in class org.jfree.chart.plot.Marker
Returns an array containing all the listeners of the specified type.
getListOfBranches() - Method in interface org.jlab.groot.tree.ITree
 
getListOfBranches() - Method in class org.jlab.groot.tree.Tree
returns list of branch names.
getLn10() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant ln(10).
getLn2() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant ln(2).
getLn2Split() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant ln(2) split in two pieces.
getLn5() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant ln(5).
getLn5Split() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant ln(5) split in two pieces.
getLNQb(int, double, double) - Method in class jhplot.stat.ConfidenceLevel
Get a histogram of a canonical -2lnQ plot for background hypothesis (full)
getLNQsb(int, double, double) - Method in class jhplot.stat.ConfidenceLevel
Get a histogram of a canonical -2lnQ plot for for signal and background hypothesis
getLo() - Method in exception org.apache.commons.math3.exception.NoBracketingException
Get the lower end of the interval.
getLo() - Method in exception org.apache.commons.math3.exception.OutOfRangeException
 
getLo() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
 
getLo() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.
 
getLocale() - Method in class org.jfree.chart.axis.DateAxis
Returns the locale for this axis.
getLocale() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the locale for this axis.
getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathArithmeticException
getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalArgumentException
getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalStateException
getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathRuntimeException
getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathUnsupportedOperationException
getLocalizedMessage() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets the message in the default locale.
getLocalizedString(Locale) - Method in class org.apache.commons.math3.exception.util.DummyLocalizable
Gets the localized string.
getLocalizedString(Locale) - Method in interface org.apache.commons.math3.exception.util.Localizable
Gets the localized string.
getLocalizedString(Locale) - Method in enum org.apache.commons.math3.exception.util.LocalizedFormats
Gets the localized string.
getLocation() - Method in interface hep.lcio.event.TrackState
The location of the track state.
getLocation() - Method in class hep.lcio.implementation.event.ITrackState
 
getLocation() - Method in class jhplot.math.num.pdf.Weibull
Access the location parameter.
getLocation() - Method in class org.apache.commons.math3.distribution.GumbelDistribution
Access the location parameter, mu.
getLocation() - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
Access the location parameter, mu.
getLocation() - Method in class org.apache.commons.math3.distribution.LevyDistribution
Get the location parameter of the distribution.
getLocation() - Method in class org.apache.commons.math3.distribution.LogisticDistribution
Access the location parameter, mu.
getLocation() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Get the hyperplane location on the real line.
getLocation() - Method in class org.apache.commons.math3.geometry.spherical.oned.LimitAngle
Get the hyperplane location on the circle.
getLocation() - Method in class org.apache.commons.math3.geometry.spherical.twod.Vertex
Get Vertex location.
getLocation(Neuron) - Method in class org.apache.commons.math3.ml.neuralnet.twod.util.LocationFinder
Retrieves a neuron's grid coordinates.
getLog() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getLog() - Method in class org.jlab.groot.math.Dimension1D
 
getLog() - Method in class org.jlab.groot.ui.GraphicsAxis
returns the logarithmic properties of the axis
getLog10TickLabelsFlag() - Method in class org.jfree.chart.axis.LogarithmicAxis
Returns the 'log10TickLabelsFlag' flag.
getLogLikelihood() - Method in class org.apache.commons.math3.distribution.fitting.MultivariateNormalMixtureExpectationMaximization
Gets the log likelihood of the data under the fitted model.
getLong() - Method in interface org.apache.commons.io.file.Counters.Counter
Gets the counter as a Long.
getLongFromTo(int, int) - Method in class cern.colt.bitvector.BitVector
Returns a long value representing bits of the receiver from index from to index to.
getLongFromTo(long[], int, int) - Static method in class cern.colt.bitvector.QuickBitVector
Returns a long value representing bits of a bitvector from index from to index to.
getLongProperty(String) - Method in class hep.lcio.util.SIODump.Resolver
 
getLow(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the low-value for the specified series and item.
getLow(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the low-value for the specified series and item.
getLow() - Method in class org.jfree.data.time.ohlc.OHLC
Returns the low value.
getLow(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the low-value for an item within a series.
getLow(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the low-value for one item in a series.
getLow(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the low value.
getLow() - Method in class org.jfree.data.xy.OHLCDataItem
Returns the low value.
getLow(int, int) - Method in interface org.jfree.data.xy.OHLCDataset
Returns the low-value for the specified series and item.
getLowEdge(int) - Method in class org.jlab.groot.data.DataVector
Returns the low edge for the bin which is determined by bin width.
getLower() - Method in class jhplot.math.num.pdf.Uniform
Access the lower parameter.
getLower() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Deprecated.
as of 3.1, replaced by Interval.getInf()
getLower() - Method in class org.apache.commons.math3.optim.SimpleBounds
Gets the lower bounds.
getLower() - Method in class org.apache.commons.math3.optimization.SimpleBounds
Deprecated.
Gets the lower bounds.
getLowerBound() - Method in class org.apache.commons.math3.optim.BaseMultivariateOptimizer
 
getLowerBound() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.
 
getLowerBound() - Method in class org.apache.commons.math3.stat.interval.ConfidenceInterval
 
getLowerBound() - Method in class org.jfree.chart.axis.ValueAxis
Returns the lower bound of the axis range.
getLowerBound() - Method in class org.jfree.chart.plot.dial.StandardDialRange
Returns the lower bound (a data value) of the dial range.
getLowerBound() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the lower bound for the scale.
getLowerBound() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the lower bound for the thermometer.
getLowerBound() - Method in class org.jfree.chart.renderer.GrayPaintScale
Returns the lower bound.
getLowerBound() - Method in class org.jfree.chart.renderer.LookupPaintScale
Returns the lower bound.
getLowerBound() - Method in interface org.jfree.chart.renderer.PaintScale
Returns the lower bound for the scale.
getLowerBound() - Method in class org.jfree.data.Range
Returns the lower bound for the range.
getLowerBound() - Method in class org.jfree.data.statistics.SimpleHistogramBin
Returns the lower bound.
getLowerClip() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the lower clip value.
getLowerDate() - Method in class org.jfree.data.time.DateRange
Returns the lower (earlier) date for the range.
getLowerEdgesX() - Method in class jhplot.H2D
Get lower edges for X bins as 1D array.
getLowerEdgesY() - Method in class jhplot.H2D
Get lower edges for Y bins as 1D array.
getLowerEdgeX(int) - Method in class jhplot.H2D
Get lower edge of the bin in X
getLowerEdgeX(int) - Method in class jhplot.HProf2D
Get lower edge of the bin in X
getLowerEdgeY(int) - Method in class jhplot.H2D
Get lower edge of the bins in Y
getLowerEdgeY(int) - Method in class jhplot.HProf2D
Get lower edge of the bins in Y
getLowerMargin() - Method in class org.jfree.chart.axis.CategoryAxis
Returns the lower margin for the axis.
getLowerMargin() - Method in class org.jfree.chart.axis.ValueAxis
Returns the lower margin for the axis, expressed as a percentage of the axis range.
getLowerMillis() - Method in class org.jfree.data.time.DateRange
Returns the lower bound of the range in milliseconds.
getLowerY() - Method in class org.jfree.chart.plot.PieLabelRecord
Returns the lower bound of the label.
getLowestNonZeroValue(int) - Method in class jplot.DataArray
Returns the lowest, but non-zero value in the range.
getLowestNonZeroValue(int) - Method in class jplot.DataArray2D
Returns the lowest, but non-zero value in the range.
getLowestNonZeroValue(int) - Method in class jplot.DataArray3D
Returns the lowest, but non-zero value in the range.
getLowValue() - Method in class jhplot.utils.SHisto
Returns the lowest inclusive pixel value checked for all bands.
getLowValue(int) - Method in class jhplot.utils.SHisto
Returns the lowest inclusive pixel value checked for a specific band.
getLowValue(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the low-value (as a double primitive) for an item within a series.
getLowValue(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the low-value (as a double primitive) for an item within a series.
getLowValue() - Method in class org.jfree.data.time.ohlc.OHLCItem
Returns the low value.
getLowValue(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the low-value for an item within a series.
getLowValue(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the low-value (as a double primitive) for an item within a series.
getLowValue(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the low-value (as a double primitive) for an item within a series.
getLowValue(int, int) - Method in interface org.jfree.data.xy.OHLCDataset
Returns the low-value (as a double primitive) for an item within a series.
getLParticle() - Method in class hephysics.jet.ParticleF
 
getLParticle() - Method in class hephysics.particle.HEParticle
Returns a light-weight particle class
getLParticleArray(ProMCHeaderFile.ProMCHeader, ProMC.ProMCEvent.Particles, int, double, double) - Static method in class hephysics.hepsim.PromcUtil
Fill particles from ProMC and apply into array after some cuts if available.
getLParticleList(ProMCHeaderFile.ProMCHeader, ProMC.ProMCEvent.Particles, int, double, double) - Static method in class hephysics.hepsim.PromcUtil
Fill particles from ProMC and apply some cuts if available.
getLT() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
Returns the transpose of the matrix L of the decomposition.
getLT() - Method in class org.nfunk.jep.OperatorSet
 
getLU() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns a copy of the combined lower and upper triangular factor, LU.
getLU() - Method in class Jampack.Zmat
Returns an LU decomposition if a valid one exists.
getLuminosityAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
getLuminosityAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional double luminosity_accumulated = 5;
getLuminosityAccumulated() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional double luminosity_accumulated = 5;
getLuminosityAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
getLuminosityAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat
optional double luminosity_accumulated = 5;
getLuminosityAccumulated() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional double luminosity_accumulated = 5;
getLuminosityAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
getLuminosityAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional double luminosity_accumulated = 5;
getLuminosityAccumulated() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional double luminosity_accumulated = 5;
getLuminosityAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
getLuminosityAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional double luminosity_accumulated = 5;
getLuminosityAccumulated() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional double luminosity_accumulated = 5;
getMagThetaPhiString() - Method in class j4np.physics.Vector3
 
getMajorTickIncrement() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the increment (in data units) between major tick labels.
getMajorTickLength() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the length factor for the major tick marks.
getMajorTickPaint() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the major tick paint.
getMajorTickStroke() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the stroke used to draw the major tick marks.
getMajorTickTimePeriodClass() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the class that controls the spacing of the major tick marks.
getMajorVersion() - Static method in class cern.colt.Version
Returns the major version of this release.
getMap() - Method in interface org.jfree.data.general.CombinationDataset
Deprecated.
Returns a map or indirect indexing form our series into parent's series.
getMap() - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns a map or indirect indexing form our series into parent's series.
getMap() - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns a map or indirect indexing form our series into parent's series.
getMap() - Method in class org.jlab.groot.base.Attributes
 
getMapper() - Method in class org.apache.commons.math3.ode.FieldExpandableODE
Get the mapper for the set of equations.
getMargin() - Method in class org.jfree.chart.block.AbstractBlock
Returns the margin.
getMargin() - Method in class org.jfree.chart.plot.PolarPlot
Returns the margin around the plot area.
getMargin() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the margin which is a percentage amount by which the bars are trimmed.
getMarginBackground() - Method in class jhplot.gui.GHPanel
Get color for all global margins
getMarginBottom() - Method in class jhplot.HPlot
Returns the distance between the bottom-border of the panel and the bottom X-axis.
getMarginLeft() - Method in class jhplot.HPlot
Returns the distance between the left-border of the panel and the left Y-axis.
getMarginPanelBottom() - Method in class jhplot.gui.GHPanel
get JPanel for bottom margin
getMarginPanelCenter() - Method in class jhplot.gui.GHPanel
get JPanel for central with drawings
getMarginPanelLeft() - Method in class jhplot.gui.GHPanel
get JPanel for left margin
getMarginPanelRight() - Method in class jhplot.gui.GHPanel
get JPanel for right margin
getMarginPanelTop() - Method in class jhplot.gui.GHPanel
get JPanel for top margin
getMarginRight() - Method in class jhplot.HPlot
Returns the distance between the right-border of the panel and the right Y-axis.
getMarginSizeBottom() - Method in class jhplot.gui.GHPanel
Get size of the bottom margin as ratio to the main panel
getMarginSizeLeft() - Method in class jhplot.gui.GHPanel
Get the size of left margin terms of the ratio to the main panel
getMarginSizeRight() - Method in class jhplot.gui.GHPanel
Get the size of right margin of the global canvas in terms of the ratio to thye global canvas
getMarginSizeTop() - Method in class jhplot.gui.GHPanel
Get size of the top margin of global canvas in terms of ratio to the main panel
getMarginTop() - Method in class jhplot.HPlot
Returns the distance between the top-border of the panel and the top X-axis.
getMarker() - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Get the marker.
getMarker() - Method in class org.jfree.chart.event.MarkerChangeEvent
Returns the marker that triggered the event.
getMarkerBand() - Method in class org.jfree.chart.axis.NumberAxis
Returns the (optional) marker band for the axis.
getMarkerColor() - Method in class org.jlab.groot.base.DatasetAttributes
 
getMarkerColor() - Method in class org.jlab.groot.data.GraphErrors
 
getMarkers() - Method in class graph.Graph2D
Get the markers
getMarkerSize() - Method in class org.jlab.groot.base.DatasetAttributes
 
getMarkerSize() - Method in class org.jlab.groot.data.GraphErrors
 
getMarkerStyle() - Method in class org.jlab.groot.base.DatasetAttributes
 
getMarkerStyle() - Method in class org.jlab.groot.data.GraphErrors
 
getMass() - Method in interface hep.lcio.event.MCParticle
Returns the mass of the particle in [GeV] - only float used in files.
getMass() - Method in interface hep.lcio.event.ReconstructedParticle
Mass of the reconstructed particle, set independently from four vector quantities - only float used in files.
getMass() - Method in class hep.lcio.implementation.event.IMCParticle
 
getMass() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getMass() - Method in class hep.physics.particle.BasicParticle
 
getMass() - Method in interface hep.physics.particle.Particle
Mass
getMass() - Method in interface hep.physics.particle.properties.ParticleType
The rest mass of the particle (in Gev)
getMass() - Method in class hephysics.particle.LParticle
Get a mass
getMass(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float mass = 4 [packed = true];
getMass(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float mass = 4 [packed = true];
getMass(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float mass = 4 [packed = true];
getMass() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
getMass() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
required double mass = 2;
getMass() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required double mass = 2;
getMass(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
getMass(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint64 mass = 4 [packed = true];
getMass(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 mass = 4 [packed = true];
getMass() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
getMass() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
required double mass = 2;
getMass() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required double mass = 2;
getMass() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
getMass() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
required double mass = 2;
getMass() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required double mass = 2;
getMass(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 Mass = 4 [packed = true];
getMass(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint64 Mass = 4 [packed = true];
getMass(int) - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint64 Mass = 4 [packed = true];
getMass(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 Mass = 4 [packed = true];
getMass(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint64 Mass = 4 [packed = true];
getMass(int) - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint64 Mass = 4 [packed = true];
getMass(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 Mass = 4 [packed = true];
getMass(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint64 Mass = 4 [packed = true];
getMass(int) - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint64 Mass = 4 [packed = true];
getMass(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
getMass(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint64 mass = 4 [packed = true];
getMass(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 mass = 4 [packed = true];
getMass() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
getMass() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
required double mass = 2;
getMass() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required double mass = 2;
getMassCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float mass = 4 [packed = true];
getMassCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float mass = 4 [packed = true];
getMassCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float mass = 4 [packed = true];
getMassCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
getMassCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint64 mass = 4 [packed = true];
getMassCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 mass = 4 [packed = true];
getMassCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 Mass = 4 [packed = true];
getMassCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint64 Mass = 4 [packed = true];
getMassCount() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint64 Mass = 4 [packed = true];
getMassCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 Mass = 4 [packed = true];
getMassCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint64 Mass = 4 [packed = true];
getMassCount() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint64 Mass = 4 [packed = true];
getMassCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 Mass = 4 [packed = true];
getMassCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint64 Mass = 4 [packed = true];
getMassCount() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint64 Mass = 4 [packed = true];
getMassCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
getMassCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint64 mass = 4 [packed = true];
getMassCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 mass = 4 [packed = true];
getMassList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float mass = 4 [packed = true];
getMassList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float mass = 4 [packed = true];
getMassList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float mass = 4 [packed = true];
getMassList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
getMassList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint64 mass = 4 [packed = true];
getMassList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 mass = 4 [packed = true];
getMassList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 Mass = 4 [packed = true];
getMassList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint64 Mass = 4 [packed = true];
getMassList() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint64 Mass = 4 [packed = true];
getMassList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 Mass = 4 [packed = true];
getMassList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint64 Mass = 4 [packed = true];
getMassList() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint64 Mass = 4 [packed = true];
getMassList() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 Mass = 4 [packed = true];
getMassList() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint64 Mass = 4 [packed = true];
getMassList() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint64 Mass = 4 [packed = true];
getMassList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
getMassList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint64 mass = 4 [packed = true];
getMassList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 mass = 4 [packed = true];
getMatrix(int, int, int, int) - Method in class Jama.Matrix
Get a submatrix.
getMatrix(int[], int[]) - Method in class Jama.Matrix
Get a submatrix.
getMatrix(int, int, int[]) - Method in class Jama.Matrix
Get a submatrix.
getMatrix(int[], int, int) - Method in class Jama.Matrix
Get a submatrix.
getMatrix(int, int, int, int) - Method in class jhplot.math.kalman.jama.Matrix
Get a submatrix.
getMatrix(int[], int[]) - Method in class jhplot.math.kalman.jama.Matrix
Get a submatrix.
getMatrix(int, int, int[]) - Method in class jhplot.math.kalman.jama.Matrix
Get a submatrix.
getMatrix(int[], int, int) - Method in class jhplot.math.kalman.jama.Matrix
Get a submatrix.
getMatrix(int, int, double[][], int, int) - Static method in class jminhep.utils.VEC
Method for filling string with a matrix
Based on ER Harold, "Java I/O", O'Reilly, around p.
getMatrix() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the 3X3 matrix corresponding to the instance
getMatrix() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the 3X3 matrix corresponding to the instance
getMax() - Method in class jhplot.F1D
Get the maximum value in X
getMax() - Method in class jhplot.FND
Get the maximum value in X
getMax() - Method in class jhplot.H1D
Get Maximum value of axis
getMax() - Method in class jhplot.HProf1D
Get Maximum value of axis
getMax() - Method in class jhplot.P0D
Returns the maximum value.
getMax() - Method in class jhplot.P0I
Returns the minimum value.
getMax(int) - Method in class jhplot.P1D
Returns the maximum value in the range.
getMax(int) - Method in class jhplot.P2D
Returns the maximum value in the range.
getMax(int) - Method in class jhplot.P3D
Returns the maximum value in the range.
getMax() - Method in class jhplot.PND
Get min value
getMax() - Method in class jhplot.PNI
Get min value
getMax() - Method in class jminhep.cluster.DataHolder
Get Max values of the data
getMax() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
 
getMax() - Method in exception org.apache.commons.math3.exception.MaxCountExceededException
 
getMax() - Method in exception org.apache.commons.math3.exception.NumberIsTooLargeException
 
getMax() - Method in class org.apache.commons.math3.optim.univariate.SearchInterval
Gets the upper bound.
getMax() - Method in class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
 
getMax() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.
 
getMax() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the maximum of the available values
getMax() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the maximum of the available values
getMax() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the maximum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMax() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the maximum of the ith entries of the arrays that correspond to each multivariate sample
getMax() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the maximum of the available values
getMax() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getMax() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the maximum of the values that have been added.
getMax() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the maximum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMax() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the maximum of the values that have been added.
getMax() - Method in class org.jfree.chart.axis.AxisState
Returns the maximum width/height.
getMax() - Method in class org.jlab.groot.data.DataVector
calculate maximum value in the data
getMax() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getMax() - Method in class org.jlab.groot.math.Dimension1D
 
getMax() - Method in class org.jlab.groot.math.Func1D
 
getMax() - Method in class promc.io.PBufFile.Record.F1D.Builder
optional double max = 4;
getMax() - Method in class promc.io.PBufFile.Record.F1D
optional double max = 4;
getMax() - Method in interface promc.io.PBufFile.Record.F1DOrBuilder
optional double max = 4;
getMax() - Method in class promc.io.PBufFile.Record.H1D.Builder
required double max = 10;
getMax() - Method in class promc.io.PBufFile.Record.H1D
required double max = 10;
getMax() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
required double max = 10;
getMaxAbsoluteResidual() - Method in class jhplot.stat.LinReg
Get max absolute residual
getMaxAscent(Graphics) - Method in class graph.TextLine
 
getMaxCandleWidthInMilliseconds() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns the maximum width (in milliseconds) of each candle.
getMaxCheckInterval() - Method in class org.apache.commons.math3.ode.events.EventState
Get the maximal time interval between events handler checks.
getMaxCheckInterval() - Method in class org.apache.commons.math3.ode.events.FieldEventState
Get the maximal time interval between events handler checks.
getMaxChipX() - Method in class org.jfree.data.general.WaferMapDataset
Returns the wafer x-dimension.
getMaxChipY() - Method in class org.jfree.data.general.WaferMapDataset
Returns the number of chips in the y-dimension.
getMaxDescent(Graphics) - Method in class graph.TextLine
 
getMaxEndIndex() - Method in class org.jfree.data.time.TimePeriodValues
Returns the index of the time period with the maximum end milliseconds.
getMaxEntropyThreshold() - Method in class jhplot.utils.SHisto
Calculates the threshold which maximizes the entropy.
getMaxEval() - Method in class org.apache.commons.math3.optim.MaxEval
Gets the maximum number of evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Get the maximum number of function evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Get the maximum number of function evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math3.analysis.solvers.BracketedRealFieldUnivariateSolver
Get the maximum number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Gets the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
 
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
Deprecated.
Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
Deprecated.
Get the maximal number of function evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math3.optimization.BaseOptimizer
Deprecated.
Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.
Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated.
Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.
Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.
 
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated.
Get the maximal number of function evaluations.
getMaxFileNameLength() - Method in enum org.apache.commons.io.FileSystem
Gets the maximum length for file names.
getMaxGrowth() - Method in class org.apache.commons.math3.ode.MultistepFieldIntegrator
Get the maximal growth factor for stepsize control.
getMaxGrowth() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Get the maximal growth factor for stepsize control.
getMaxGrowth() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Get the maximal growth factor for stepsize control.
getMaxGrowth() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the maximal growth factor for stepsize control.
getMaxHeight() - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Returns the maximum height.
getMaxIcon() - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Returns the icon displayed for the maximum value data item within each category.
getMaximalCount() - Method in class org.apache.commons.math3.util.Incrementor
Deprecated.
Gets the upper limit of the counter.
getMaximalCount() - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Gets the upper limit of the counter.
getMaximalIterationCount() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the upper limit for the number of iterations.
getMaximalIterationCount() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the upper limit for the number of iterations.
getMaximalOrder() - Method in class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Get the maximal order.
getMaximalOrder() - Method in class org.apache.commons.math3.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the maximal order.
getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured maximum implementation.
getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured maximum implementation
getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured maximum implementation
getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured maximum implementation
getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured maximum implementation
getMaximum() - Method in class org.jlab.groot.data.H2F
 
getMaximumBarWidth() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the maximum bar width, as a percentage of the available drawing space.
getMaximumBarWidth() - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Returns the maximum bar width as a percentage of the available drawing space.
getMaximumBin() - Method in class org.jlab.groot.data.H1F
Returns bin number with maximum entries.
getMaximumCategoryCount() - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the maximum category count.
getMaximumCategoryCount() - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the maximum category count.
getMaximumCategoryLabelLines() - Method in class org.jfree.chart.axis.CategoryAxis
Returns the maximum number of lines to use for each category label.
getMaximumCategoryLabelWidthRatio() - Method in class org.jfree.chart.axis.CategoryAxis
Returns the category label width ratio.
getMaximumDate() - Method in class org.jfree.chart.axis.DateAxis
Returns the latest date visible on the axis.
getMaximumDrawHeight() - Method in class org.jfree.chart.ChartPanel
Returns the maximum drawing height for charts.
getMaximumDrawWidth() - Method in class org.jfree.chart.ChartPanel
Returns the maximum drawing width for charts.
getMaximumExplodePercent() - Method in class org.jfree.chart.plot.PiePlot
Returns the maximum explode percent.
getMaximumItemAge() - Method in class org.jfree.data.time.TimeSeries
Returns the maximum item age (in time periods) for the series.
getMaximumItemCount() - Method in class org.jfree.data.ComparableObjectSeries
Returns the maximum number of items that will be retained in the series.
getMaximumItemCount() - Method in class org.jfree.data.time.TimeSeries
Returns the maximum number of items that will be retained in the series.
getMaximumItemCount() - Method in class org.jfree.data.xy.XYSeries
Returns the maximum number of items that will be retained in the series.
getMaximumItemWidth() - Method in class org.jfree.chart.renderer.category.LevelRenderer
Returns the maximum width, as a percentage of the available drawing space.
getMaximumIterations() - Method in class jhplot.math.num.IterativeMethod
Access the maximum number of iterations.
getMaximumIterations() - Method in class jhplot.math.num.root.Bracket
Access the maximum number of iterations.
getMaximumLabelWidth() - Method in class org.jfree.chart.plot.PiePlot
Returns the maximum label width as a percentage of the plot width.
getMaximumLinesToDisplay() - Method in class org.jfree.chart.title.TextTitle
Returns the maximum number of lines to display.
getMaximumRelativeError() - Method in class jhplot.math.num.IterativeMethod
Access the maximum relative error.
getMaximumSize(JComponent) - Method in class net.java.dev.colorchooser.ColorChooserUI
 
getMaximumVerticalDataValue() - Method in class org.jfree.chart.plot.ThermometerPlot
Deprecated.
This method is not used. Officially deprecated in version 1.0.6.
getMaximumXValue() - Method in class org.jfree.data.general.DefaultHeatMapDataset
Returns the highest x-value represented in this dataset.
getMaximumXValue() - Method in interface org.jfree.data.general.HeatMapDataset
Returns the highest x-value represented in this dataset.
getMaximumYValue() - Method in class org.jfree.data.general.DefaultHeatMapDataset
Returns the highest y-value represented in this dataset.
getMaximumYValue() - Method in interface org.jfree.data.general.HeatMapDataset
Returns the highest y-value represented in this dataset.
getMaxIndex() - Method in class jhplot.P0D
Returns index corresponding to maximum value.
getMaxIndex() - Method in class jhplot.P0I
Returns index corresponding to maximum value.
getMaxIndex(int) - Method in class jhplot.P1D
Returns the index of maximum value in the range.
getMaxIndex() - Method in class org.apache.commons.math3.linear.RealVector
Get the index of the maximum entry.
getMaxItemWidth() - Method in class org.jfree.chart.renderer.category.LevelRenderer
Deprecated.
getMaxIter() - Method in class org.apache.commons.math3.optim.MaxIter
Gets the maximum number of evaluations.
getMaxIterationCount() - Method in class org.apache.commons.math3.ode.events.EventState
Get the upper limit in the iteration count for event localization.
getMaxIterationCount() - Method in class org.apache.commons.math3.ode.events.FieldEventState
Get the upper limit in the iteration count for event localization.
getMaxIterations() - Method in class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Returns the maximum number of iterations this instance will use.
getMaxIterations() - Method in class org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer
Returns the maximum number of iterations this instance will use.
getMaxIterations() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Gets the maximal number of iterations.
getMaxIterations() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated.
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in interface org.apache.commons.math3.optimization.linear.LinearOptimizer
Deprecated.
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in class org.apache.commons.math3.util.IterationManager
Returns the maximum number of iterations.
getMaxLen() - Method in class org.lsmp.djep.xjep.PrintVisitor
 
getMaxMiddleIndex() - Method in class org.jfree.data.time.TimePeriodValues
Returns the index of the time period with the maximum middle milliseconds.
getMaxNumberOfSubticsLog() - Method in class jhplot.HPlot
Returns the maximum number of subticks for log scale (default is 10).
getMaxNumberOfTics() - Method in class jplot.GraphSettings
Returns the maximum number of tics for log10 scale.
getMaxOrderForSumOfPowers() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns Integer.MAX_VALUE, the maximum order k for which sums of powers are retrievable.
getMaxOrderForSumOfPowers() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the maximum order k for which sums of powers are retrievable, as specified upon instance construction.
getMaxOutlier(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the maximum outlier (non-farout) for an item.
getMaxOutlier(Comparable, Comparable) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the maximum outlier (non-farout) for an item.
getMaxOutlier() - Method in class org.jfree.data.statistics.BoxAndWhiskerItem
Returns the maximum outlier.
getMaxOutlier(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerXYDataset
Returns the maximum value which is not a farout, ie Q3 + (interquartile range * farout coefficient).
getMaxOutlier(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the maximum outlier (non farout) value for an item.
getMaxOutlier(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the maximum outlier (non farout) value for an item.
getMaxOutlier(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the maximum value which is not a farout, ie Q3 + (interquartile range * farout coefficient).
getMaxPathLength() - Method in enum org.apache.commons.io.FileSystem
Gets the maximum length of the path to a file.
getMaxRadius() - Method in class org.jfree.chart.plot.PolarPlot
Deprecated.
Since 1.0.14, use PolarPlot.getAxis() and call the getUpperBound() method.
getMaxRegularValue(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the maximum regular (non-outlier) value for an item.
getMaxRegularValue(Comparable, Comparable) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the maximum regular (non-outlier) value for an item.
getMaxRegularValue() - Method in class org.jfree.data.statistics.BoxAndWhiskerItem
Returns the maximum regular value.
getMaxRegularValue(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerXYDataset
Returns the max-value for the specified series and item.
getMaxRegularValue(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the maximum regular (non outlier) value for an item.
getMaxRegularValue(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the maximum regular (non outlier) value for an item.
getMaxRegularValue(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the max-value for the specified series and item.
getMaxStartIndex() - Method in class org.jfree.data.time.TimePeriodValues
Returns the index of the time period with the maximum start milliseconds.
getMaxStep() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
Get the maximal step.
getMaxStep() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the maximal step.
getMaxTemplateValue() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the template value for the maximum size of the indicator bounds.
getMaxValue(int) - Method in class jhplot.HPlot
Returns the maximum data value for the specified axis.
getMaxValue(int) - Method in class jplot.DataArray
Returns the maximum value in the range.
getMaxValue(int) - Method in class jplot.DataArray2D
Returns the maximum value in the range.
getMaxValue(int) - Method in class jplot.DataArray3D
Returns the maximum value in the range.
getMaxValue(int) - Method in class jplot.GraphSettings
Returns the maximum data value for the specified axis.
getMaxValue() - Method in class org.apache.commons.math3.linear.RealVector
Get the value of the maximum entry.
getMaxValue() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the maximum value any category axis can take.
getMaxValue() - Method in class org.jfree.data.general.WaferMapDataset
Returns the maximum value stored in the dataset.
getMaxVarianceThreshold() - Method in class jhplot.utils.SHisto
Calculates the threshold which maximizes the ratio of the between-class variance to the within-class variance for each band.
getMaxWidth() - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Returns the maximum width.
getMaxX() - Method in class jhplot.F2D
Get Max value in X
getMaxX() - Method in class jhplot.F3D
Get Max value in X
getMaxX() - Method in class jhplot.H2D
Get max value of axis in X
getMaxX() - Method in class jhplot.HProf2D
Get max value of axis in X
getMaxX() - Method in class jhplot.stat.LinReg
Get a maximum value for X
getMaxX() - Method in class jhplot.stat.LinRegWeighted
Get a maximum value for X
getMaxX() - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Returns the largest X coordinate of the framing rectangle of this legend item.
getMaxX() - Method in class org.jfree.data.xy.XYSeries
Returns the largest x-value in the series, ignoring any Double.NaN values.
getMaxX() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getMaxX() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double maxX = 4;
getMaxX() - Method in class promc.io.PBufFile.Record.F2D
optional double maxX = 4;
getMaxX() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
optional double maxX = 4;
getMaxY() - Method in class jhplot.F2D
Get Max value in Y
getMaxY() - Method in class jhplot.F3D
Get Max value in Y
getMaxY() - Method in class jhplot.H2D
Get max value of Y axis
getMaxY() - Method in class jhplot.HProf2D
Get max value of Y axis
getMaxY() - Method in class jhplot.stat.LinReg
Get maximum value in Y
getMaxY() - Method in class jhplot.stat.LinRegWeighted
Get maximum value in Y
getMaxY() - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Returns the largest Y coordinate of the framing rectangle of this legend item.
getMaxY() - Method in class org.jfree.data.time.TimeSeries
Returns the largest y-value in the series, ignoring any null and Double.NaN values.
getMaxY() - Method in class org.jfree.data.xy.XYSeries
Returns the largest y-value in the series, ignoring any Double.NaN values.
getMaxY() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getMaxY() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double maxY = 6;
getMaxY() - Method in class promc.io.PBufFile.Record.F2D
optional double maxY = 6;
getMaxY() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
optional double maxY = 6;
getMaxZ() - Method in class jhplot.F3D
Set Max value in Z
getMaxZ() - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns the maximum Z value.
getMaxZValue() - Method in interface org.jfree.data.contour.ContourDataset
Deprecated.
Returns the largest Z data value.
getMaxZValue() - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the maximum z-value.
getMColor() - Method in class jhplot.gui.GHMargin
Get the text color
getMCParticle() - Method in interface hep.lcio.event.SimTrackerHit
Returns the MC particle that caused the hit.
getMCParticle() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
getMCParticles() - Method in class hep.physics.event.generator.GeneratorEvent
 
getMCParticles() - Method in interface hep.physics.event.generator.MCEvent
Returns the list of Particles associated with this event
getMean() - Method in class jhplot.math.num.pdf.Exponential
Access the mean.
getMean() - Method in class jhplot.math.num.pdf.Laplace
Access the mean.
getMean() - Method in class jhplot.math.num.pdf.Logistic
Access the mean.
getMean() - Method in class jhplot.math.num.pdf.LogNormal
Access the mean.
getMean() - Method in class jhplot.math.num.pdf.NegativeBinomial
Get mean value.
getMean() - Method in class jhplot.math.num.pdf.Normal
Access the mean.
getMean() - Method in class jhplot.math.num.pdf.Poisson
Access the mean.
getMean(int) - Method in class jhplot.stat.PCA
Get means for the component k
getMean() - Method in class jhplot.utils.SHisto
Returns the mean values for all bands of the histogram.
getMean() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Access the mean.
getMean() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Access the mean.
getMean() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Get the mean for the distribution.
getMean() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the arithmetic mean of the available values
getMean() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the arithmetic mean of the available values
getMean() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMean() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the mean of the ith entries of the arrays that correspond to each multivariate sample
getMean() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the arithmetic mean of the available values
getMean() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getMean() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the mean of the values that have been added.
getMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the mean of the values that have been added.
getMean() - Method in class org.jfree.data.function.NormalDistributionFunction2D
Returns the mean for the function.
getMean() - Method in class org.jfree.data.statistics.BoxAndWhiskerItem
Returns the mean.
getMean() - Method in class org.jfree.data.statistics.MeanAndStandardDeviation
Returns the mean.
getMean(DataVector) - Method in class org.jlab.groot.data.DataVector
Calculates the normalized mean with the given axis.
getMean() - Method in class org.jlab.groot.data.DataVector
Calculates the mean of the vector.
getMean() - Method in class org.jlab.groot.data.H1F
Calculates the mean of the data in the histogram
getMean() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double mean = 16;
getMean() - Method in class promc.io.PBufFile.Record.H1D
optional double mean = 16;
getMean() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional double mean = 16;
getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured mean implementation.
getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured mean implementation
getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured mean implementation
getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured mean implementation
getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured mean implementation
getMeans() - Method in class jhplot.stat.Anova
Returns an array of means for all of your sample groups.
getMeans() - Method in class jhplot.stat.StatShape
Get weighted means in X and Y
getMeans() - Method in class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Gets the mean vector.
getMeans(int) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double means = 4 [packed = true];
getMeans(int) - Method in class promc.io.PBufFile.Record.H1D
repeated double means = 4 [packed = true];
getMeans(int) - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double means = 4 [packed = true];
getMeansCount() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double means = 4 [packed = true];
getMeansCount() - Method in class promc.io.PBufFile.Record.H1D
repeated double means = 4 [packed = true];
getMeansCount() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double means = 4 [packed = true];
getMeanSlices() - Method in class org.jlab.groot.fitter.ParallelSliceFitter
 
getMeansList() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double means = 4 [packed = true];
getMeansList() - Method in class promc.io.PBufFile.Record.H1D
repeated double means = 4 [packed = true];
getMeansList() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double means = 4 [packed = true];
getMeanSquareError() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the sum of squared errors divided by the degrees of freedom, usually abbreviated MSE.
getMeanSquareError() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the sum of squared errors divided by the degrees of freedom, usually abbreviated MSE.
getMeansX(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansX = 4 [packed = true];
getMeansX(int) - Method in class promc.io.PBufFile.Record.H2D
repeated double meansX = 4 [packed = true];
getMeansX(int) - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double meansX = 4 [packed = true];
getMeansXCount() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansX = 4 [packed = true];
getMeansXCount() - Method in class promc.io.PBufFile.Record.H2D
repeated double meansX = 4 [packed = true];
getMeansXCount() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double meansX = 4 [packed = true];
getMeansXList() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansX = 4 [packed = true];
getMeansXList() - Method in class promc.io.PBufFile.Record.H2D
repeated double meansX = 4 [packed = true];
getMeansXList() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double meansX = 4 [packed = true];
getMeansY(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansY = 7 [packed = true];
getMeansY(int) - Method in class promc.io.PBufFile.Record.H2D
repeated double meansY = 7 [packed = true];
getMeansY(int) - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double meansY = 7 [packed = true];
getMeansYCount() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansY = 7 [packed = true];
getMeansYCount() - Method in class promc.io.PBufFile.Record.H2D
repeated double meansY = 7 [packed = true];
getMeansYCount() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double meansY = 7 [packed = true];
getMeansYList() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansY = 7 [packed = true];
getMeansYList() - Method in class promc.io.PBufFile.Record.H2D
repeated double meansY = 7 [packed = true];
getMeansYList() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double meansY = 7 [packed = true];
getMeanValue(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the mean value for an item.
getMeanValue(Comparable, Comparable) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the average value for an item.
getMeanValue(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerXYDataset
Returns the mean for the specified series and item.
getMeanValue(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the mean value for an item.
getMeanValue(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the mean value for an item.
getMeanValue(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the mean for the specified series and item.
getMeanValue(int, int) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the mean value for an item.
getMeanValue(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the mean value for an item.
getMeanValue() - Method in class org.jfree.data.statistics.MeanAndStandardDeviation
Returns the mean as a double primitive.
getMeanValue(int, int) - Method in interface org.jfree.data.statistics.StatisticalCategoryDataset
Returns the mean value for an item.
getMeanValue(Comparable, Comparable) - Method in interface org.jfree.data.statistics.StatisticalCategoryDataset
Returns the mean value for an item.
getMeanX() - Method in class jhplot.H2D
Get mean on X.
getMeanX() - Method in class jhplot.HProf2D
Get mean on X.
getMeanY() - Method in class jhplot.H2D
Get mean on Y
getMeanY() - Method in class jhplot.HProf2D
Get mean on Y
getMeasurement_matrix() - Method in class jhplot.math.kalman.JKalman
Getter
getMeasurement_noise_cov() - Method in class jhplot.math.kalman.JKalman
Getter
getMeasurementDimension() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns the dimension of the measurement vector.
getMeasurementMatrix() - Method in class org.apache.commons.math3.filter.DefaultMeasurementModel
Returns the measurement matrix.
getMeasurementMatrix() - Method in interface org.apache.commons.math3.filter.MeasurementModel
Returns the measurement matrix.
getMeasurementNoise() - Method in class org.apache.commons.math3.filter.DefaultMeasurementModel
Returns the measurement noise matrix.
getMeasurementNoise() - Method in interface org.apache.commons.math3.filter.MeasurementModel
Returns the measurement noise matrix.
getMedian() - Method in class jhplot.math.num.pdf.Cauchy
Access the location parameter.
getMedian() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Access the median.
getMedian() - Method in class org.jfree.data.statistics.BoxAndWhiskerItem
Returns the median.
getMedianValue(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the median value for an item.
getMedianValue(Comparable, Comparable) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the median value for an item.
getMedianValue(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerXYDataset
Returns the median-value for the specified series and item.
getMedianValue(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the median value for an item.
getMedianValue(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the median value for an item.
getMedianValue(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the median-value for the specified series and item.
getMembership() - Method in class jminhep.cluster.Partition
Get membeship of each pint inside the cluster.
getMembershipMatrix() - Method in class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Returns the nxk membership matrix, where n is the number of data points and k the number of clusters.
getMembeship() - Method in class jminhep.algorithms.FuzzyCMeansAlg
Return cluster membership
getMercuryPaint() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the default mercury paint.
getMessage(String) - Static method in class jminhep.utils.ResourceLoader
 
getMessage() - Method in exception jplot3dp.MathParser.ParseException
This method has the standard behavior when this object has been created using the standard constructors.
getMessage() - Method in error jplot3dp.MathParser.TokenMgrError
You can also modify the body of this method to customize your error messages.
getMessage() - Method in exception org.apache.commons.math3.exception.MathArithmeticException
getMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalArgumentException
getMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalStateException
getMessage() - Method in exception org.apache.commons.math3.exception.MathRuntimeException
getMessage() - Method in exception org.apache.commons.math3.exception.MathUnsupportedOperationException
getMessage() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets the default message.
getMessage(Locale) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets the message in a specified locale.
getMessage(Locale, String) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets the message in a specified locale.
getMessage() - Method in exception org.nfunk.jep.ParseException
This method has the standard behavior when this object has been created using the standard constructors.
getMessage() - Method in error org.nfunk.jep.TokenMgrError
You can also modify the body of this method to customize your error messages.
getMessageDigest() - Method in class org.apache.commons.io.input.MessageDigestCalculatingInputStream
Returns the MessageDigest, which is being used for generating the checksum.
getMET(int) - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated uint64 MET = 1 [packed = true];
getMET(int) - Method in class proreco.io.ProMC.ProMCEvent.MissingET
repeated uint64 MET = 1 [packed = true];
getMET(int) - Method in interface proreco.io.ProMC.ProMCEvent.MissingETOrBuilder
repeated uint64 MET = 1 [packed = true];
getMetaFloat(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloat(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloat(int) - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloat(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloat(int) - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloat(int) - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloat(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloat(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloat(int) - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloat(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloat(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloat(int) - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloat(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloat(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloat(int) - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatBuilderList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatBuilderList() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatBuilderList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatBuilderList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatBuilderList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatCount() - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatCount() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatCount() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatCount() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatList() - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatList() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatList() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatOrBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatOrBuilder(int) - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatOrBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilder(int) - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatOrBuilderList() - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatOrBuilderList() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
getMetaFloatOrBuilderList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaFloatOrBuilderList() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
getMetaInt(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaInt(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaInt(int) - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaInt(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaInt(int) - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaInt(int) - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaInt(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaInt(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaInt(int) - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaInt(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaInt(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaInt(int) - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaInt(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaInt(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaInt(int) - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntBuilderList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntBuilderList() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntBuilderList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntBuilderList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntBuilderList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntCount() - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntCount() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntCount() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntCount() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntList() - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntList() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntList() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntOrBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntOrBuilder(int) - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntOrBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilder(int) - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntOrBuilderList() - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntOrBuilderList() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
getMetaIntOrBuilderList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMetaIntOrBuilderList() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
getMETCount() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated uint64 MET = 1 [packed = true];
getMETCount() - Method in class proreco.io.ProMC.ProMCEvent.MissingET
repeated uint64 MET = 1 [packed = true];
getMETCount() - Method in interface proreco.io.ProMC.ProMCEvent.MissingETOrBuilder
repeated uint64 MET = 1 [packed = true];
getMeterAngle() - Method in class org.jfree.chart.plot.MeterPlot
Returns the meter angle in degrees.
getMethodDescriptors() - Method in class net.java.dev.colorchooser.ColorChooserBeanInfo
Gets the bean's MethodDescriptors.
getMETList() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated uint64 MET = 1 [packed = true];
getMETList() - Method in class proreco.io.ProMC.ProMCEvent.MissingET
repeated uint64 MET = 1 [packed = true];
getMETList() - Method in interface proreco.io.ProMC.ProMCEvent.MissingETOrBuilder
repeated uint64 MET = 1 [packed = true];
getMFont() - Method in class jhplot.gui.GHMargin
Get the font on this panel
getMicroVersion() - Static method in class cern.colt.Version
Returns the micro version of this release.
getMid() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
 
getMid() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.
 
getMiddleMillisecond() - Method in class org.jfree.data.time.FixedMillisecond
Returns the millisecond closest to the middle of the time period.
getMiddleMillisecond(Calendar) - Method in class org.jfree.data.time.FixedMillisecond
Returns the millisecond closest to the middle of the time period.
getMiddleMillisecond() - Method in class org.jfree.data.time.RegularTimePeriod
Returns the millisecond closest to the middle of the time period.
getMiddleMillisecond(TimeZone) - Method in class org.jfree.data.time.RegularTimePeriod
Deprecated.
As of 1.0.3, you should avoid using this method (it creates a new Calendar instance every time it is called). You are advised to call RegularTimePeriod.getMiddleMillisecond(Calendar) instead.
getMiddleMillisecond(Calendar) - Method in class org.jfree.data.time.RegularTimePeriod
Returns the millisecond closest to the middle of the time period, evaluated using the supplied calendar (which incorporates a timezone).
getMidPoint() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Deprecated.
as of 3.1, replaced by Interval.getBarycenter()
getMillisecond() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns the millisecond used to reference this segment (always between the segmentStart and segmentEnd).
getMillisecond() - Method in class org.jfree.data.time.Millisecond
Returns the millisecond.
getMillisecond(TimePeriodAnchor, Calendar) - Method in class org.jfree.data.time.RegularTimePeriod
Returns the millisecond (relative to the epoch) corresponding to the specified anchor using the supplied calendar (which incorporates a time zone).
getMin() - Method in class jhplot.F1D
Get the minimum value in X
getMin() - Method in class jhplot.FND
Get the minimum value in X
getMin() - Method in class jhplot.H1D
Get Minimum value of the axis
getMin() - Method in class jhplot.HProf1D
Get Minimum value of the axis
getMin() - Method in class jhplot.P0D
Returns the minimum value.
getMin() - Method in class jhplot.P0I
Returns the minimum value.
getMin(int) - Method in class jhplot.P1D
Returns the minimum value in the range.
getMin(int) - Method in class jhplot.P2D
Returns the minimum value in the range.
getMin(int) - Method in class jhplot.P3D
Returns the minimum value in the range.
getMin() - Method in class jhplot.PND
Get max value
getMin() - Method in class jhplot.PNI
Get max value
getMin() - Method in class jminhep.cluster.DataHolder
Get Min values of the data holder
getMin() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
 
getMin() - Method in exception org.apache.commons.math3.exception.NumberIsTooSmallException
 
getMin() - Method in class org.apache.commons.math3.optim.univariate.SearchInterval
Gets the lower bound.
getMin() - Method in class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
 
getMin() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.
 
getMin() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the minimum of the available values
getMin() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the minimum of the available values
getMin() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the minimum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMin() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the minimum of the ith entries of the arrays that correspond to each multivariate sample
getMin() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the minimum of the available values
getMin() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getMin() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the minimum of the values that have been added.
getMin() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the minimum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMin() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the minimum of the values that have been added.
getMin() - Method in class org.jlab.groot.data.DataVector
calculate the minimum value in the data.
getMin() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getMin() - Method in class org.jlab.groot.math.Dimension1D
 
getMin() - Method in class org.jlab.groot.math.Func1D
 
getMin() - Method in class promc.io.PBufFile.Record.F1D.Builder
optional double min = 3;
getMin() - Method in class promc.io.PBufFile.Record.F1D
optional double min = 3;
getMin() - Method in interface promc.io.PBufFile.Record.F1DOrBuilder
optional double min = 3;
getMin() - Method in class promc.io.PBufFile.Record.H1D.Builder
required double min = 9;
getMin() - Method in class promc.io.PBufFile.Record.H1D
required double min = 9;
getMin() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
required double min = 9;
getMinEndIndex() - Method in class org.jfree.data.time.TimePeriodValues
Returns the index of the time period with the minimum end milliseconds.
getMinErrorThreshold() - Method in class jhplot.utils.SHisto
Calculates the threshold which minimizes the probability of error.
getMinFuzzinessThreshold() - Method in class jhplot.utils.SHisto
Calculates the threshold which minimizes the fuzziness.
getMinIcon() - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Returns the icon displayed for the minimum value data item within each category.
getMinimalIterationCount() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the min limit for the number of iterations.
getMinimalIterationCount() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the min limit for the number of iterations.
getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured minimum implementation.
getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured minimum implementation
getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured minimum implementation
getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured minimum implementation
getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured minimum implementation
getMinimumArcAngleToDraw() - Method in class org.jfree.chart.plot.PiePlot
Returns the minimum arc angle that will be drawn.
getMinimumBarLength() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the minimum bar length (in Java2D units).
getMinimumDate() - Method in class org.jfree.chart.axis.DateAxis
Returns the earliest date visible on the axis.
getMinimumDrawHeight() - Method in class org.jfree.chart.ChartPanel
Returns the minimum drawing height for charts.
getMinimumDrawWidth() - Method in class org.jfree.chart.ChartPanel
Returns the minimum drawing width for charts.
getMinimumSize() - Method in class jplot.GraphGeneral
Get the minimum size of this component.
getMinimumSize(JComponent) - Method in class net.java.dev.colorchooser.ColorChooserUI
 
getMinimumVerticalDataValue() - Method in class org.jfree.chart.plot.ThermometerPlot
Deprecated.
This method is not used. Officially deprecated in version 1.0.6.
getMinimumXValue() - Method in class org.jfree.data.general.DefaultHeatMapDataset
Returns the lowest x-value represented in this dataset.
getMinimumXValue() - Method in interface org.jfree.data.general.HeatMapDataset
Returns the lowest x-value represented in this dataset.
getMinimumYValue() - Method in class org.jfree.data.general.DefaultHeatMapDataset
Returns the lowest y-value represented in this dataset.
getMinimumYValue() - Method in interface org.jfree.data.general.HeatMapDataset
Returns the lowest y-value represented in this dataset.
getMinIndex() - Method in class jhplot.P0D
Returns index corresponding to minimum value.
getMinIndex() - Method in class jhplot.P0I
Returns index corresponding to minimum value.
getMinIndex(int) - Method in class jhplot.P1D
Returns the index of minimum value in the range.
getMinIndex() - Method in class org.apache.commons.math3.linear.RealVector
Get the index of the minimum entry.
getMinMiddleIndex() - Method in class org.jfree.data.time.TimePeriodValues
Returns the index of the time period with the minimum middle milliseconds.
getMinOrderForSumOfPowers() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns Integer.MIN_VALUE, the minimum order k for which sums of powers are retrievable.
getMinOrderForSumOfPowers() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the minimum order k for which sums of powers are retrievable, as specified upon instance construction.
getMinorTickCount() - Method in class org.jfree.chart.axis.TickUnit
Returns the minor tick count.
getMinorTickCount() - Method in class org.jfree.chart.axis.ValueAxis
Returns the number of minor tick marks to display.
getMinorTickCount() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the number of minor tick marks between major tick marks.
getMinorTickLength() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the length factor for the minor tick marks.
getMinorTickMarkInsideLength() - Method in class org.jfree.chart.axis.Axis
Returns the inside length of the minor tick marks.
getMinorTickMarkInsideLength() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the inside length for the minor tick marks.
getMinorTickMarkOutsideLength() - Method in class org.jfree.chart.axis.Axis
Returns the outside length of the minor tick marks.
getMinorTickMarkOutsideLength() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the outside length for the minor tick marks.
getMinorTickMarkPaint() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the paint used to display minor tick marks, if they are visible.
getMinorTickMarkStroke() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the stroke used to display minor tick marks, if they are visible.
getMinorTickPaint() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the paint used to draw the minor tick marks.
getMinorTickStroke() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the stroke used to draw the minor tick marks.
getMinorTickTimePeriodClass() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the class that controls the spacing of the minor tick marks.
getMinorVersion() - Static method in class cern.colt.Version
Returns the minor version of this release.
getMinOutlier(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the minimum outlier (non-farout) for an item.
getMinOutlier(Comparable, Comparable) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the minimum outlier (non-farout) for an item.
getMinOutlier() - Method in class org.jfree.data.statistics.BoxAndWhiskerItem
Returns the minimum outlier.
getMinOutlier(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerXYDataset
Returns the minimum value which is not a farout.
getMinOutlier(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the minimum outlier (non farout) value for an item.
getMinOutlier(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the minimum outlier (non farout) value for an item.
getMinOutlier(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the minimum value which is not a farout.
getMinPts() - Method in class org.apache.commons.math3.ml.clustering.DBSCANClusterer
Returns the minimum number of points needed for a cluster.
getMinPts() - Method in class org.apache.commons.math3.stat.clustering.DBSCANClusterer
Deprecated.
Returns the minimum number of points needed for a cluster.
getMinReduction() - Method in class org.apache.commons.math3.ode.MultistepFieldIntegrator
Get the minimal reduction factor for stepsize control.
getMinReduction() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Get the minimal reduction factor for stepsize control.
getMinReduction() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Get the minimal reduction factor for stepsize control.
getMinReduction() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the minimal reduction factor for stepsize control.
getMinRegularValue(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the minimum regular (non-outlier) value for an item.
getMinRegularValue(Comparable, Comparable) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the minimum regular (non-outlier) value for an item.
getMinRegularValue() - Method in class org.jfree.data.statistics.BoxAndWhiskerItem
Returns the minimum regular value.
getMinRegularValue(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerXYDataset
Returns the min-value for the specified series and item.
getMinRegularValue(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the minimum regular (non outlier) value for an item.
getMinRegularValue(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the minimum regular (non outlier) value for an item.
getMinRegularValue(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the min-value for the specified series and item.
getMinStartIndex() - Method in class org.jfree.data.time.TimePeriodValues
Returns the index of the time period with the minimum start milliseconds.
getMinStep() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
Get the minimal step.
getMinStep() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the minimal step.
getMinus() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Get the tree on the minus side of the cut hyperplane.
getMinus() - Method in class org.apache.commons.math3.geometry.partitioning.SubHyperplane.SplitSubHyperplane
Get the part of the sub-hyperplane on the minus side of the splitting hyperplane.
getMinus() - Method in class org.apache.commons.math3.geometry.spherical.oned.ArcsSet.Split
Get the part of the arcs set on the minus side of the splitting arc.
getMINUSONE() - Method in class org.lsmp.djep.xjep.TreeUtils
 
getMinusOne() - Method in class org.nfunk.jep.type.DoubleNumberFactory
 
getMinusOne() - Method in interface org.nfunk.jep.type.NumberFactory
Return an object representing ZERO-ONE.
getMinute() - Method in class org.jfree.data.time.Minute
Returns the minute.
getMinute() - Method in class org.jfree.data.time.Second
Returns the minute.
getMinuteSuffix() - Method in class org.jfree.chart.util.RelativeDateFormat
Returns the string that is appended to the minute count.
getMinValue(int) - Method in class jhplot.HPlot
Returns the minimum data value for the specified axis.
getMinValue(int) - Method in class jplot.DataArray
Returns the minimum value in the range.
getMinValue(int) - Method in class jplot.DataArray2D
Returns the minimum value in the range.
getMinValue(int) - Method in class jplot.DataArray3D
Returns the minimum value in the range.
getMinValue(int) - Method in class jplot.GraphSettings
Returns the minimum data value for the specified axis.
getMinValue() - Method in class org.apache.commons.math3.linear.RealVector
Get the value of the minimum entry.
getMinValue() - Method in class org.jfree.data.general.WaferMapDataset
Returns the minimum value stored in the dataset.
getMinX() - Method in class jhplot.F2D
Get Min value in X
getMinX() - Method in class jhplot.F3D
Get Min value in X
getMinX() - Method in class jhplot.H2D
Get min value of axis in X
getMinX() - Method in class jhplot.HProf2D
Get min value of axis in X
getMinX() - Method in class jhplot.stat.LinReg
Get a minimum value for X
getMinX() - Method in class jhplot.stat.LinRegWeighted
Get a minimum value for X
getMinX() - Method in class org.jfree.data.xy.XYSeries
Returns the smallest x-value in the series, ignoring any Double.NaN values.
getMinX() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getMinX() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double minX = 3;
getMinX() - Method in class promc.io.PBufFile.Record.F2D
optional double minX = 3;
getMinX() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
optional double minX = 3;
getMinY() - Method in class jhplot.F2D
Get Min value in Y
getMinY() - Method in class jhplot.F3D
Get Min value in Y
getMinY() - Method in class jhplot.H2D
Get min value of Y axis
getMinY() - Method in class jhplot.HProf2D
Get min value of Y axis
getMinY() - Method in class jhplot.stat.LinReg
Get minimum value for Y
getMinY() - Method in class jhplot.stat.LinRegWeighted
Get minimum value for Y
getMinY() - Method in class org.jfree.data.time.TimeSeries
Returns the smallest y-value in the series, ignoring any null and Double.NaN values.
getMinY() - Method in class org.jfree.data.xy.XYSeries
Returns the smallest y-value in the series, ignoring any null and Double.NaN values.
getMinY() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getMinY() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double minY = 5;
getMinY() - Method in class promc.io.PBufFile.Record.F2D
optional double minY = 5;
getMinY() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
optional double minY = 5;
getMinZ() - Method in class jhplot.F3D
Get Min value in Z
getMinZ() - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns the minimum Z value.
getMinZValue() - Method in interface org.jfree.data.contour.ContourDataset
Deprecated.
Returns the smallest Z data value.
getMinZValue() - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the minimum z-value.
getMinZValue(double, double, double, double) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the minimum z-value.
getMissingET() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.MissingET missingET = 10;
getMissingET() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.MissingET missingET = 10;
getMissingET() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.MissingET missingET = 10;
getMissingETBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.MissingET missingET = 10;
getMissingETOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.MissingET missingET = 10;
getMissingETOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.MissingET missingET = 10;
getMissingETOrBuilder() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.MissingET missingET = 10;
getMissingPaint() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the missingPaint.
getMList() - Method in class org.lsmp.djep.matrixJep.MatrixOperatorSet
 
getMod() - Method in class org.nfunk.jep.OperatorSet
 
getMode() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Returns the mode c of this distribution.
getMode() - Method in class org.apache.commons.math3.random.ValueServer
Returns the data generation mode.
getMode() - Method in class org.apache.commons.math3.stat.Frequency
Returns the mode value(s) in comparator order.
getMode() - Method in class org.lsmp.djep.xjep.PrintVisitor
Return the current print mode.
getMode(int) - Method in class org.lsmp.djep.xjep.PrintVisitor
 
getModel() - Method in class jplot3d.JSurfacePanel
 
getModel() - Method in class jplot3dp.MainComponent
 
getModelFunction() - Method in class org.apache.commons.math3.optim.nonlinear.vector.ModelFunction
Deprecated.
Gets the model function to be optimized.
getModelFunctionJacobian() - Method in class org.apache.commons.math3.optim.nonlinear.vector.ModelFunctionJacobian
Deprecated.
Gets the Jacobian of the model function to be optimized.
getModeThreshold(double) - Method in class jhplot.utils.SHisto
Calculates the threshold using the mode method.
getMoment(int, boolean, boolean) - Method in class jhplot.utils.SHisto
Returns a specified (absolute) (central) moment of the histogram.
getMomentum() - Method in interface hep.lcio.event.MCParticle
Returns the particle's 3-momentum at the production vertex in [GeV] - only float used in files.
getMomentum() - Method in interface hep.lcio.event.ReconstructedParticle
The reconstructed particle's 3-momentum - only float used in files,
getMomentum() - Method in interface hep.lcio.event.SimTrackerHit
Returns the 3-momentum of the particle at the hits position in [GeV] - optional, only if bit LCIO::THBIT_MOMENTUM is set.
getMomentum() - Method in class hep.lcio.implementation.event.IMCParticle
 
getMomentum() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getMomentum() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
getMomentum() - Method in class hep.physics.particle.BasicParticle
 
getMomentum() - Method in interface hep.physics.particle.Particle
Momentum
getMomentumAtEndpoint() - Method in interface hep.lcio.event.MCParticle
Returns the particle's 3-momentum at the endpoint in [GeV] Only float used in files.
getMomentumAtEndpoint() - Method in class hep.lcio.implementation.event.IMCParticle
 
getMomentumUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
getMomentumUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 MomentumUnit = 16;
getMomentumUnit() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 MomentumUnit = 16;
getMomentumUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
getMomentumUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 MomentumUnit = 16;
getMomentumUnit() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 MomentumUnit = 16;
getMomentumUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
getMomentumUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 MomentumUnit = 16;
getMomentumUnit() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 MomentumUnit = 16;
getMomentumUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
getMomentumUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 MomentumUnit = 16;
getMomentumUnit() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 MomentumUnit = 16;
getMonth() - Method in class org.jfree.data.time.Day
Returns the month.
getMonth() - Method in class org.jfree.data.time.Hour
Returns the month in which this hour falls.
getMonth() - Method in class org.jfree.data.time.Month
Returns the month.
getMother1(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
getMother1(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 mother1 = 8 [packed = true];
getMother1(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother1 = 8 [packed = true];
getMother1(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
getMother1(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 mother1 = 8 [packed = true];
getMother1(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother1 = 8 [packed = true];
getMother1(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
getMother1(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 mother1 = 8 [packed = true];
getMother1(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother1 = 8 [packed = true];
getMother1Count() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
getMother1Count() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 mother1 = 8 [packed = true];
getMother1Count() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother1 = 8 [packed = true];
getMother1Count() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
getMother1Count() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 mother1 = 8 [packed = true];
getMother1Count() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother1 = 8 [packed = true];
getMother1Count() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
getMother1Count() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 mother1 = 8 [packed = true];
getMother1Count() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother1 = 8 [packed = true];
getMother1List() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
getMother1List() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 mother1 = 8 [packed = true];
getMother1List() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother1 = 8 [packed = true];
getMother1List() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
getMother1List() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 mother1 = 8 [packed = true];
getMother1List() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother1 = 8 [packed = true];
getMother1List() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
getMother1List() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 mother1 = 8 [packed = true];
getMother1List() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother1 = 8 [packed = true];
getMother2(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
getMother2(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 mother2 = 9 [packed = true];
getMother2(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother2 = 9 [packed = true];
getMother2(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
getMother2(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 mother2 = 9 [packed = true];
getMother2(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother2 = 9 [packed = true];
getMother2(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
getMother2(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 mother2 = 9 [packed = true];
getMother2(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother2 = 9 [packed = true];
getMother2Count() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
getMother2Count() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 mother2 = 9 [packed = true];
getMother2Count() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother2 = 9 [packed = true];
getMother2Count() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
getMother2Count() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 mother2 = 9 [packed = true];
getMother2Count() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother2 = 9 [packed = true];
getMother2Count() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
getMother2Count() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 mother2 = 9 [packed = true];
getMother2Count() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother2 = 9 [packed = true];
getMother2List() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
getMother2List() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 mother2 = 9 [packed = true];
getMother2List() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother2 = 9 [packed = true];
getMother2List() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
getMother2List() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 mother2 = 9 [packed = true];
getMother2List() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother2 = 9 [packed = true];
getMother2List() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
getMother2List() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 mother2 = 9 [packed = true];
getMother2List() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 mother2 = 9 [packed = true];
getMouseHandler(String) - Method in class org.jfree.chart.fx.ChartCanvas
Returns the mouse handler with the specified ID, or null if there is no handler with that ID.
getMovingAverage(Number[], Number[], int) - Static method in class org.jfree.data.statistics.Statistics
Returns a data set for a moving average on the data set passed in.
getMPI() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 MPI = 3;
getMPI() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional int32 MPI = 3;
getMPI() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 MPI = 3;
getMPI() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 MPI = 3;
getMPI() - Method in class promc.io.ProMC.ProMCEvent.Event
optional int32 MPI = 3;
getMPI() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 MPI = 3;
getMPI(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 MPI = 3 [packed = true];
getMPI(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 MPI = 3 [packed = true];
getMPI(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 MPI = 3 [packed = true];
getMPICount() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 MPI = 3 [packed = true];
getMPICount() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 MPI = 3 [packed = true];
getMPICount() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 MPI = 3 [packed = true];
getMPIList() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 MPI = 3 [packed = true];
getMPIList() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 MPI = 3 [packed = true];
getMPIList() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 MPI = 3 [packed = true];
getMSE() - Method in class jhplot.stat.LinReg
Get MSE value
getMu() - Method in class org.apache.commons.math3.random.ValueServer
getMulInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.BigReals
 
getMulInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
getMulInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.Reals
 
getMulInverse(Number) - Method in class org.lsmp.djep.groupJep.groups.Zn
 
getMulInverse(Number) - Method in interface org.lsmp.djep.groupJep.interfaces.FieldI
get mul inverse
getMultiLines() - Method in class jplot.GraphLabel
Get the multi text of the label
getMultiple() - Method in class org.jfree.chart.axis.DateTickUnit
Returns the unit multiple.
getMultiplier() - Method in class jplot.LinePars
Returns the multiplier for this line, a value which will be used to multiply each value of the dataset before plotting.
getMultiply() - Method in class org.nfunk.jep.OperatorSet
 
getMultiText() - Method in class jplot.GraphLabel
Get the multi text of the label
getMuons() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Muons muons = 7;
getMuons() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Muons muons = 7;
getMuons() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Muons muons = 7;
getMuonsBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Muons muons = 7;
getMuonsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Muons muons = 7;
getMuonsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Muons muons = 7;
getMuonsOrBuilder() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Muons muons = 7;
getMutationPolicy() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the mutation policy.
getMutationRate() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the mutation rate.
getMValue() - Method in class org.lsmp.djep.matrixJep.MatrixPartialDerivative
 
getMValue() - Method in class org.lsmp.djep.matrixJep.MatrixVariable
returns the value, uses the Scaler type.
getMValue() - Method in interface org.lsmp.djep.matrixJep.MatrixVariableI
Returns the value container of this variable.
getMValue() - Method in class org.lsmp.djep.matrixJep.nodeTypes.ASTMConstant
 
getMValue() - Method in class org.lsmp.djep.matrixJep.nodeTypes.ASTMFunNode
 
getMValue() - Method in class org.lsmp.djep.matrixJep.nodeTypes.ASTMVarNode
 
getMValue() - Method in interface org.lsmp.djep.matrixJep.nodeTypes.MatrixNodeI
 
getN() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Get the number of spline segments.
getN() - Method in class org.apache.commons.math3.stat.correlation.Covariance
Returns the number of observations (length of covariate vectors)
getN() - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
This Covariance method is not supported by a StorelessCovariance, since the number of bivariate observations does not have to be the same for different pairs of covariates - i.e., N as defined in Covariance.getN() is undefined.
getN() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
Get the number of vectors in the sample.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
Get the number of vectors in the sample.
getN() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile
Returns the number of values that have been added.
getN() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns the number of available values
getN() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getN() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Gets the number of observations added to the regression model.
getN() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the number of observations added to the regression model.
getN() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the number of observations that have been added to the model.
getN() - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Returns the number of observations added to the regression model.
getN() - Method in class org.apache.commons.math3.util.Combinations
Gets the size of the set from which combinations are drawn.
getNAccepted() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
getNAccepted() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional int32 nAccepted = 8;
getNAccepted() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nAccepted = 8;
getNAccepted() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
getNAccepted() - Method in class promc.io.ProMCStatFile.ProMCStat
optional int32 nAccepted = 8;
getNAccepted() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nAccepted = 8;
getNAccepted() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
getNAccepted() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional int32 nAccepted = 8;
getNAccepted() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nAccepted = 8;
getNAccepted() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
getNAccepted() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional int32 nAccepted = 8;
getNAccepted() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nAccepted = 8;
getName() - Method in class fitter.BFunc
 
getName() - Method in class hep.lcio.util.CommandHandler
Get the name of this command.
getName() - Method in interface hep.physics.particle.properties.ParticleType
The name of the particle, suitable for printing
getName() - Method in class hephysics.particle.LParticle
Get a name
getName(String) - Method in class jhepsim.HepsimGUI
 
getName() - Method in class jhplot.F1D
Get the name of the function used for evaluation
getName() - Method in class jhplot.F2D
Get the name of the function used for evaluation
getName() - Method in class jhplot.F3D
Get the name of the function used for evaluation
getName() - Method in class jhplot.FND
Get the name of the function used for evaluation
getName() - Method in class jhplot.FPR
Get parametric equation.
getName() - Method in class jhplot.FProxy
Get the name of the function used for evaluation
getName() - Method in class jhplot.math.exp4j.function.Function
Get the name of the Function
getName() - Method in class jhplot.math.exp4j.tokenizer.VariableToken
Get the name of the setVariable
getName() - Method in class jhplot.PND
Get a new title
getName() - Method in class jminhep.algorithms.FuzzyCMeansAlg
Get the description of the algorithm
getName() - Method in class jminhep.algorithms.HierarchicalAlg
Get description
getName() - Method in class jminhep.algorithms.KMeansAlg
Name for this algorithm.
getName() - Method in class jminhep.algorithms.KMeansExchangeAlg
 
getName(int) - Method in class jminhep.cluster.DataHolder
Get name of the i-th attribute
getName() - Method in class jminhep.cluster.Partition
Get name for this clustering
getName() - Method in class jplot.DataFile
Return the filename as such.
getName() - Method in class jplot.LinePars
Returns the name (legend) of this line style
getName(String) - Static method in class org.apache.commons.io.FilenameUtils
Gets the name minus the path from a full fileName.
getName() - Method in enum org.apache.commons.io.IOCase
Gets the name of the constant.
getName() - Method in class org.apache.commons.io.monitor.FileEntry
Return the file name.
getName() - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Get the name of the method.
getName() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get the name of the method.
getName() - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Get the name of the method.
getName() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get the name of the method.
getName() - Method in exception org.apache.commons.math3.ode.UnknownParameterException
 
getName() - Method in class org.jfree.chart.StandardChartTheme
Returns the name of this theme.
getName() - Method in enum org.jlab.groot.base.AttributeType
 
getName() - Method in class org.jlab.groot.data.Directory
returns Directory name
getName() - Method in class org.jlab.groot.data.GraphErrors
 
getName() - Method in class org.jlab.groot.data.H1F
 
getName() - Method in class org.jlab.groot.data.H2F
 
getName() - Method in interface org.jlab.groot.data.IDataSet
 
getName() - Method in class org.jlab.groot.graphics.FunctionPlotter
 
getName() - Method in class org.jlab.groot.graphics.GraphErrorsPlotter
 
getName() - Method in class org.jlab.groot.graphics.Histogram2DPlotter
 
getName() - Method in class org.jlab.groot.graphics.HistogramPlotter
 
getName() - Method in interface org.jlab.groot.graphics.IDataSetPlotter
 
getName() - Method in class org.jlab.groot.group.DataGroup
 
getName() - Method in class org.jlab.groot.group.DataGroupDescriptor
 
getName() - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
getName() - Method in class org.jlab.groot.math.Func1D
 
getName() - Method in class org.jlab.groot.tree.AbstractDescriptor
 
getName() - Method in class org.jlab.groot.tree.Branch
 
getName() - Method in interface org.jlab.groot.tree.ITree
 
getName() - Method in class org.jlab.groot.tree.Tree
returns the name of the tree
getName() - Method in class org.jlab.groot.tree.TreeCut
 
getName() - Method in class org.lsmp.djep.djep.diffRules.AdditionDiffRule
 
getName() - Method in class org.lsmp.djep.djep.diffRules.ChainRuleDiffRules
returns the name of the function
getName() - Method in class org.lsmp.djep.djep.diffRules.DivideDiffRule
 
getName() - Method in class org.lsmp.djep.djep.diffRules.MultiplyDiffRule
 
getName() - Method in class org.lsmp.djep.djep.diffRules.PassThroughDiffRule
 
getName() - Method in class org.lsmp.djep.djep.diffRules.PowerDiffRule
 
getName() - Method in class org.lsmp.djep.djep.diffRules.SubtractDiffRule
 
getName() - Method in interface org.lsmp.djep.djep.DiffRulesI
Returns the name of the function.
getName() - Method in class org.lsmp.djep.djep.PartialDerivative
 
getName() - Method in interface org.lsmp.djep.matrixJep.MatrixVariableI
The name of variable
getName() - Method in class org.lsmp.djep.xjep.MacroFunction
 
getName(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
Returns the value represented by node
getName() - Method in class org.nfunk.jep.ASTFunNode
Returns the name of the node (operator symbol or function name).
getName() - Method in class org.nfunk.jep.ASTVarNode
Returns the name of the variable.
getName() - Method in class org.nfunk.jep.Operator
returns a unique name definig this operator.
getName() - Method in class org.nfunk.jep.Variable
 
getName() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
getName() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
getName() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
getName() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
getName() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
getName() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
getName() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
getName() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
getName() - Method in interface proeic.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
getName() - Method in class promc.io.PBufFile.Record.Builder
optional string name = 1;
getName() - Method in class promc.io.PBufFile.Record.F1D.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.F1D
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.F1DOrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.F2D.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.F2D
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.FND.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.FND
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.FNDOrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.FPR.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.FPR
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.FPROrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record
optional string name = 1;
getName() - Method in class promc.io.PBufFile.Record.H1D.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.H1D
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.H2D.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.H2D
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.P0D.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.P0D
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.P0DOrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.P0I.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.P0I
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.P0IOrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.P1D.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.P1D
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.PND.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.PND
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.PNDOrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.PNI.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.PNI
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.PNIOrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.PXY.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.PXY
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.PXYOrBuilder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
required string name = 1 [default = "none"];
getName() - Method in class promc.io.PBufFile.Record.PXYZ
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
required string name = 1 [default = "none"];
getName() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional string name = 1;
getName() - Method in class promc.io.PEventFile.HEvent.Builder
optional string name = 2;
getName() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
optional string name = 1;
getName() - Method in class promc.io.PEventFile.HEvent.Entry
optional string name = 1;
getName() - Method in interface promc.io.PEventFile.HEvent.EntryOrBuilder
optional string name = 1;
getName() - Method in class promc.io.PEventFile.HEvent
optional string name = 2;
getName() - Method in class promc.io.PEventFile.HEvent.Group.Builder
optional string name = 1;
getName() - Method in class promc.io.PEventFile.HEvent.Group
optional string name = 1;
getName() - Method in interface promc.io.PEventFile.HEvent.GroupOrBuilder
optional string name = 1;
getName() - Method in interface promc.io.PEventFile.HEventOrBuilder
optional string name = 2;
getName() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
getName() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
getName() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
getName() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
getName() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
getName() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
getName() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
getName() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
getName() - Method in interface promc.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
getName() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
getName() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
getName() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
getName() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
getName() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
getName() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
getName() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
getName() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
getName() - Method in interface pronlo.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
getName() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
getName() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
getName() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
getName() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
getName() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
getName() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
getName() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
getName() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
getName() - Method in interface proreco.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
getName() - Method in class root.FakeTKey
 
getNameAt(int, int) - Method in class net.java.dev.colorchooser.Palette
Returns a string description of the color at the point.
getNameBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
getNameBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
getNameBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
getNameBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
getNameBytes() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
getNameBytes() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
getNameBytes() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
getNameBytes() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
getNameBytes() - Method in interface proeic.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
getNameBytes() - Method in class promc.io.PBufFile.Record.Builder
optional string name = 1;
getNameBytes() - Method in class promc.io.PBufFile.Record.F1D.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.F1D
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.F1DOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.F2D.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.F2D
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.FND.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.FND
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.FNDOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.FPR.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.FPR
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.FPROrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record
optional string name = 1;
getNameBytes() - Method in class promc.io.PBufFile.Record.H1D.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.H1D
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.H2D.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.H2D
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.P0D.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.P0D
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.P0DOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.P0I.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.P0I
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.P0IOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.P1D.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.P1D
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.PND.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.PND
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.PNDOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.PNI.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.PNI
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.PNIOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.PXY.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.PXY
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.PXYOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
required string name = 1 [default = "none"];
getNameBytes() - Method in class promc.io.PBufFile.Record.PXYZ
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
required string name = 1 [default = "none"];
getNameBytes() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional string name = 1;
getNameBytes() - Method in class promc.io.PEventFile.HEvent.Builder
optional string name = 2;
getNameBytes() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
optional string name = 1;
getNameBytes() - Method in class promc.io.PEventFile.HEvent.Entry
optional string name = 1;
getNameBytes() - Method in interface promc.io.PEventFile.HEvent.EntryOrBuilder
optional string name = 1;
getNameBytes() - Method in class promc.io.PEventFile.HEvent
optional string name = 2;
getNameBytes() - Method in class promc.io.PEventFile.HEvent.Group.Builder
optional string name = 1;
getNameBytes() - Method in class promc.io.PEventFile.HEvent.Group
optional string name = 1;
getNameBytes() - Method in interface promc.io.PEventFile.HEvent.GroupOrBuilder
optional string name = 1;
getNameBytes() - Method in interface promc.io.PEventFile.HEventOrBuilder
optional string name = 2;
getNameBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
getNameBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
getNameBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
getNameBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
getNameBytes() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
getNameBytes() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
getNameBytes() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
getNameBytes() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
getNameBytes() - Method in interface promc.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
getNameBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
getNameBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
getNameBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
getNameBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
getNameBytes() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
getNameBytes() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
getNameBytes() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
getNameBytes() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
getNameBytes() - Method in interface pronlo.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
getNameBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
getNameBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
getNameBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
getNameBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
getNameBytes() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
getNameBytes() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
getNameBytes() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
getNameBytes() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
getNameBytes() - Method in interface proreco.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
getNameLengthUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
getNameLengthUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
getNameLengthUnit() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
getNameLengthUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
getNameLengthUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
getNameLengthUnit() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
getNameLengthUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
getNameLengthUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
getNameLengthUnit() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
getNameLengthUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
getNameLengthUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
getNameLengthUnit() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
getNameLengthUnitBytes() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
getNameMomentumUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
getNameMomentumUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
getNameMomentumUnit() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
getNameMomentumUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
getNameMomentumUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
getNameMomentumUnit() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
getNameMomentumUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
getNameMomentumUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
getNameMomentumUnit() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
getNameMomentumUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
getNameMomentumUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
getNameMomentumUnit() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
getNameMomentumUnitBytes() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
getNames() - Method in class jhplot.VHolder
Return Vector with the names
getNameX() - Method in class jhplot.DrawOptions
Get the name of X-axis
getNameX() - Method in class jplot.LinePars
Returns the name of the X axis
getNameY() - Method in class jhplot.DrawOptions
Get the title of Y-axis.
getNameY() - Method in class jplot.LinePars
Returns the name of the Y axis
getNameZ() - Method in class jhplot.DrawOptions
Get the title of Z-axis
getNameZ() - Method in class jplot.LinePars
Returns the name of the Z axis
getNAN() - Method in class org.lsmp.djep.xjep.TreeUtils
 
getNaNStrategy() - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Get the NaN Handling strategy used for computation.
getNanStrategy() - Method in class org.apache.commons.math3.stat.ranking.NaturalRanking
Return the NaNStrategy
getNBins() - Method in class org.jlab.groot.math.Axis
A getter for the number of bins, returned in array indexing format (i.e.
getNbinsX() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getNbinsY() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getNbPoints() - Method in class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Get the number of points to use.
getNclusters() - Method in class jminhep.cluster.Partition
get number of reconstructed clusters
getNColumns() - Method in class hep.physics.matrix.BasicMatrix
 
getNColumns() - Method in interface hep.physics.matrix.Matrix
Returns the number of columns
getNColumns() - Method in class hep.physics.matrix.SymmetricMatrix
 
getNColumns() - Method in class hep.physics.vec.BasicHep3Matrix
 
getNColumns() - Method in class hephysics.matrix.BasicMatrix
 
getNColumns() - Method in interface hephysics.matrix.Matrix
Returns the number of columns
getNColumns() - Method in class hephysics.matrix.SymmetricMatrix
 
getNColumns() - Method in class hephysics.vec.Hep3Matrix
 
getNColumns() - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
getNdf() - Method in interface hep.lcio.event.Track
Number of degrees of freedom of the track fit.
getNdf() - Method in class hep.lcio.implementation.event.ITrack
 
getNDF() - Method in class org.jlab.groot.math.Func1D
 
getNDouble() - Method in interface hep.lcio.event.LCGenericObject
Number of double values stored in this object.
getNDouble() - Method in class hep.lcio.example.CalibrationConstant
 
getNDouble() - Method in class hep.lcio.implementation.event.ILCGenericObject
 
getNE() - Method in class org.nfunk.jep.OperatorSet
 
getNeedlePaint() - Method in class org.jfree.chart.plot.MeterPlot
Returns the paint for the needle.
getNegativeBarPaint() - Method in class org.jfree.chart.renderer.category.WaterfallBarRenderer
Returns the paint used to draw bars with negative values.
getNegativeInfinity() - Method in class org.lsmp.djep.xjep.TreeUtils
 
getNegativeItemLabelPosition(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the item label position for negative values.
getNegativeItemLabelPosition() - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.getSeriesNegativeItemLabelPosition(int) and AbstractRenderer.getBaseNegativeItemLabelPosition().
getNegativeItemLabelPosition(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the item label position for negative values.
getNegativeItemLabelPosition() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.getSeriesNegativeItemLabelPosition(int) and CategoryItemRenderer.getBaseNegativeItemLabelPosition().
getNegativeItemLabelPosition(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the item label position for negative values.
getNegativeItemLabelPosition() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.getSeriesNegativeItemLabelPosition(int) and XYItemRenderer.getBaseNegativeItemLabelPosition().
getNegativeItemLabelPositionFallback() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the fallback position for negative item labels that don't fit within a bar.
getNegativeItemLabelPositionFallback() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the fallback position for negative item labels that don't fit within a bar.
getNegativePaint() - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Returns the paint used to highlight negative differences.
getNeighbours(Iterable<Neuron>) - Method in class org.apache.commons.math3.ml.neuralnet.Network
Retrieves the neurons in the neighbourhood of any neuron in the neurons list.
getNeighbours(Iterable<Neuron>, Iterable<Neuron>) - Method in class org.apache.commons.math3.ml.neuralnet.Network
Retrieves the neurons in the neighbourhood of any neuron in the neurons list.
getNeighbours(Neuron) - Method in class org.apache.commons.math3.ml.neuralnet.Network
Retrieves the neighbours of the given neuron.
getNeighbours(Neuron, Iterable<Neuron>) - Method in class org.apache.commons.math3.ml.neuralnet.Network
Retrieves the neighbours of the given neuron.
getNEntries() - Method in class jhplot.io.EFile
Get number of events stored in the file.
getNEntries() - Method in class jhplot.io.PFile
Get number of objects stored in the file.
getNentries() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional int32 nentries = 12;
getNentries() - Method in class promc.io.PBufFile.Record.H1D
optional int32 nentries = 12;
getNentries() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional int32 nentries = 12;
getNentries() - Method in class promc.io.PBufFile.Record.H2D.Builder
optional int32 nentries = 12;
getNentries() - Method in class promc.io.PBufFile.Record.H2D
optional int32 nentries = 12;
getNentries() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
optional int32 nentries = 12;
getNetwork() - Method in class org.apache.commons.math3.ml.neuralnet.oned.NeuronString
Retrieves the underlying network.
getNetwork() - Method in class org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D
Retrieves the underlying network.
getNeuron(long) - Method in class org.apache.commons.math3.ml.neuralnet.Network
Retrieves the neuron with the given (unique) id.
getNeuron(int, int) - Method in class org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D
Retrieves the neuron at location (i, j) in the map.
getNeuron(int, int, NeuronSquareMesh2D.HorizontalDirection, NeuronSquareMesh2D.VerticalDirection) - Method in class org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D
Retrieves the neuron at (location[0], location[1]) in the map.
getNeurons(Comparator<Neuron>) - Method in class org.apache.commons.math3.ml.neuralnet.Network
Creates a list of the neurons, sorted in a custom order.
getNeventsFailed() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
getNeventsFailed() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional int32 nevents_failed = 2;
getNeventsFailed() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_failed = 2;
getNeventsFailed() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
getNeventsFailed() - Method in class promc.io.ProMCStatFile.ProMCStat
optional int32 nevents_failed = 2;
getNeventsFailed() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_failed = 2;
getNeventsFailed() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
getNeventsFailed() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional int32 nevents_failed = 2;
getNeventsFailed() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_failed = 2;
getNeventsFailed() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
getNeventsFailed() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional int32 nevents_failed = 2;
getNeventsFailed() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_failed = 2;
getNeventsRequested() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
getNeventsRequested() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional int32 nevents_requested = 1;
getNeventsRequested() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_requested = 1;
getNeventsRequested() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
getNeventsRequested() - Method in class promc.io.ProMCStatFile.ProMCStat
optional int32 nevents_requested = 1;
getNeventsRequested() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_requested = 1;
getNeventsRequested() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
getNeventsRequested() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional int32 nevents_requested = 1;
getNeventsRequested() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_requested = 1;
getNeventsRequested() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
getNeventsRequested() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional int32 nevents_requested = 1;
getNeventsRequested() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_requested = 1;
getNewestIndex() - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the index of the newest data item.
getNewestTime() - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the newest time.
getNewtonCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of coefficients in Newton form formula.
getNext() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
Deprecated.
Get the node containing the next larger or equal element.
getNext() - Method in class org.apache.commons.math3.random.ValueServer
Returns the next generated value, generated according to the mode value (see MODE constants).
getNextFillPaint() - Method in class org.jfree.chart.plot.DefaultDrawingSupplier
Returns the next fill paint in the sequence.
getNextFillPaint() - Method in interface org.jfree.chart.plot.DrawingSupplier
Returns the next fill paint in a sequence maintained by the supplier.
getNextIndex() - Method in class org.apache.commons.math3.random.HaltonSequenceGenerator
Returns the index i of the next point in the Halton sequence that will be returned by calling HaltonSequenceGenerator.nextVector().
getNextIndex() - Method in class org.apache.commons.math3.random.SobolSequenceGenerator
Returns the index i of the next point in the Sobol sequence that will be returned by calling SobolSequenceGenerator.nextVector().
getNextOutlinePaint() - Method in class org.jfree.chart.plot.DefaultDrawingSupplier
Returns the next outline paint in the sequence.
getNextOutlinePaint() - Method in interface org.jfree.chart.plot.DrawingSupplier
Returns the next outline paint in a sequence maintained by the supplier.
getNextOutlineStroke() - Method in class org.jfree.chart.plot.DefaultDrawingSupplier
Returns the next outline stroke in the sequence.
getNextOutlineStroke() - Method in interface org.jfree.chart.plot.DrawingSupplier
Returns the next Stroke object in a sequence maintained by the supplier.
getNextPaint() - Method in class org.jfree.chart.plot.DefaultDrawingSupplier
Returns the next paint in the sequence.
getNextPaint() - Method in interface org.jfree.chart.plot.DrawingSupplier
Returns the next paint in a sequence maintained by the supplier.
getNextShape() - Method in class org.jfree.chart.plot.DefaultDrawingSupplier
Returns the next shape in the sequence.
getNextShape() - Method in interface org.jfree.chart.plot.DrawingSupplier
Returns the next Shape object in a sequence maintained by the supplier.
getNextStroke() - Method in class org.jfree.chart.plot.DefaultDrawingSupplier
Returns the next stroke in the sequence.
getNextStroke() - Method in interface org.jfree.chart.plot.DrawingSupplier
Returns the next Stroke object in a sequence maintained by the supplier.
GetNextTerm() - Method in class jplot3dp.MathParser.MathParser
 
getNextTimePeriod() - Method in class org.jfree.data.time.TimeSeries
Returns a time period that would be the next in sequence on the end of the time series.
getNextToken() - Method in class jplot3dp.MathParser.MathParser
 
getNextToken() - Method in class jplot3dp.MathParser.MathParserTokenManager
 
getNextToken() - Method in class org.nfunk.jep.Parser
 
getNextToken() - Method in class org.nfunk.jep.ParserTokenManager
 
getNextValue() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Generates a random value from this distribution.
getNFloat() - Method in interface hep.lcio.event.LCGenericObject
Number of float values stored in this object.
getNFloat(String) - Method in interface hep.lcio.event.LCParameters
The number of float values stored for this key.
getNFloat() - Method in class hep.lcio.example.CalibrationConstant
 
getNFloat() - Method in class hep.lcio.implementation.event.ILCGenericObject
 
getNFloat(String) - Method in class hep.lcio.implementation.event.ILCParameters
 
getNFM(int) - Method in class jhplot.stat.FactorialMoments
Return results: NFM as a function of number of bins.
getNInt() - Method in interface hep.lcio.event.LCGenericObject
Number of integer values stored in this object.
getNInt(String) - Method in interface hep.lcio.event.LCParameters
The number of integer values stored for this key.
getNInt() - Method in class hep.lcio.example.CalibrationConstant
 
getNInt() - Method in class hep.lcio.implementation.event.ILCGenericObject
 
getNInt(String) - Method in class hep.lcio.implementation.event.ILCParameters
 
getNKeys() - Method in class jhplot.io.FileRoot
Get number of objects in the current directory of a ROOT file.
getNMC() - Method in class jhplot.stat.limit.StatConfidence
Get number of MC events
getNMCContributions() - Method in interface hep.lcio.event.SimCalorimeterHit
Returns the number of MC contributions to the hit.
getNMCContributions() - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
getNMCParticles() - Method in interface hep.lcio.event.SimCalorimeterHit
Deprecated. 
getNMCParticles() - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
getNNs(int, int[], double[][], int[], double[]) - Static method in class jminhep.algorithms.HierarchicalAlg
Method getNNs, determine NNs and NN dissimilarities
getNobs() - Method in class jhplot.stat.limit.ExpData
Get the number of observations
getNoData() - Method in class jplot.GraphSettings
Get no data flag
getNoDataMessage() - Method in class org.jfree.chart.plot.Plot
Returns the string that is displayed when the dataset is empty or null.
getNoDataMessageFont() - Method in class org.jfree.chart.plot.Plot
Returns the font used to display the 'no data' message.
getNoDataMessagePaint() - Method in class org.jfree.chart.plot.Plot
Returns the paint used to display the 'no data' message.
getNodeFactory() - Method in class org.lsmp.djep.xjep.XJep
Returns the node factory, used for constructing trees of Nodes.
getNodes(DefaultMutableTreeNode, List<String>, int) - Method in class org.jlab.groot.data.Directory
 
getNonZeros(IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.DoubleMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, DoubleArrayList, int) - Method in class cern.colt.matrix.DoubleMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.DoubleMatrix2D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.DoubleMatrix3D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, ObjectArrayList) - Method in class cern.colt.matrix.ObjectMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, ObjectArrayList) - Method in class cern.colt.matrix.ObjectMatrix2D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList, ObjectArrayList) - Method in class cern.colt.matrix.ObjectMatrix3D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNorm() - Method in class org.apache.commons.math3.complex.Quaternion
Computes the norm of the quaternion.
getNorm() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the L2 norm for the vector.
getNorm() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the L2 norm for the vector.
getNorm() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the L2 norm for the vector.
getNorm() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the L2 norm for the vector.
getNorm() - Method in interface org.apache.commons.math3.geometry.Vector
Get the L2 norm for the vector.
getNorm() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Returns the L2 norm of the vector.
getNorm() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in class org.apache.commons.math3.linear.RealVector
Returns the L2 norm of the vector.
getNorm() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the L2 norm of the matrix.
getNorm1() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the L1 norm for the vector.
getNorm1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the L1 norm for the vector.
getNorm1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the L1 norm for the vector.
getNorm1() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the L1 norm for the vector.
getNorm1() - Method in interface org.apache.commons.math3.geometry.Vector
Get the L1 norm for the vector.
getNormal() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the normalized normal vector.
getNormalApproximationInterval(int, int, double) - Static method in class org.apache.commons.math3.stat.interval.IntervalUtils
Create a binomial confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, successes and confidence level using the Normal approximation to the binomial distribution.
getNormInf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the L norm for the vector.
getNormInf() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the L norm for the vector.
getNormInf() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the L norm for the vector.
getNormInf() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the L norm for the vector.
getNormInf() - Method in interface org.apache.commons.math3.geometry.Vector
Get the L norm for the vector.
getNormOfResidual() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Returns the norm of the residual.
getNormOfResidual() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Returns the norm of the residual.
getNormSq() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the square of the norm for the vector.
getNormSq() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the square of the norm for the vector.
getNormSq() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the square of the norm for the vector.
getNormSq() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the square of the norm for the vector.
getNormSq() - Method in interface org.apache.commons.math3.geometry.Vector
Get the square of the norm for the vector.
getNot() - Method in class org.nfunk.jep.OperatorSet
 
getNotify() - Method in class org.jfree.chart.annotations.AbstractAnnotation
Returns a flag that indicates whether listeners should be notified about changes to the annotation.
getNotify() - Method in class org.jfree.chart.title.Title
Returns the flag that indicates whether or not the notification mechanism is enabled.
getNotify() - Method in class org.jfree.data.general.AbstractDataset
Returns the value of the notify flag.
getNotify() - Method in class org.jfree.data.general.Series
Returns the flag that controls whether or not change events are sent to registered listeners.
getNotLarger(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Deprecated.
Get the node whose element is not larger than the reference object.
getNotSmaller(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Deprecated.
Get the node whose element is not smaller than the reference object.
getNPars() - Method in class org.jlab.groot.math.Func1D
 
getNRawDataWords() - Method in interface hep.lcio.event.TPCHit
Deprecated.
Return the number of raw data (32-bit) words stored for the hit.
getNRawDataWords() - Method in class hep.lcio.implementation.event.ITPCHit
 
getNRows() - Method in class hep.physics.matrix.BasicMatrix
 
getNRows() - Method in interface hep.physics.matrix.Matrix
Returns the number of rows
getNRows() - Method in class hep.physics.matrix.SymmetricMatrix
 
getNRows() - Method in class hep.physics.vec.BasicHep3Matrix
 
getNRows() - Method in class hephysics.matrix.BasicMatrix
 
getNRows() - Method in interface hephysics.matrix.Matrix
Returns the number of rows
getNRows() - Method in class hephysics.matrix.SymmetricMatrix
 
getNRows() - Method in class hephysics.vec.Hep3Matrix
 
getNRows() - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
getNSelected() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
getNSelected() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional int32 nSelected = 7;
getNSelected() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nSelected = 7;
getNSelected() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
getNSelected() - Method in class promc.io.ProMCStatFile.ProMCStat
optional int32 nSelected = 7;
getNSelected() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nSelected = 7;
getNSelected() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
getNSelected() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional int32 nSelected = 7;
getNSelected() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nSelected = 7;
getNSelected() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
getNSelected() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional int32 nSelected = 7;
getNSelected() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nSelected = 7;
getNSteps() - Method in class org.apache.commons.math3.ode.MultistepFieldIntegrator
Get the number of steps of the multistep method (excluding the one being computed).
getNSteps() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Get the number of steps of the multistep method (excluding the one being computed).
getNSteps() - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
Deprecated.
as of 3.6, this method is not used anymore
getNString(String) - Method in interface hep.lcio.event.LCParameters
The number of string values stored for this key.
getNString(String) - Method in class hep.lcio.implementation.event.ILCParameters
 
getNthreads() - Method in class org.jlab.groot.fitter.ParallelSliceFitter
 
getNtotX() - Method in class jhplot.gui.GHFrame
Get the total number of graphs in X
getNtotY() - Method in class jhplot.gui.GHFrame
Get the total number of the graphs in Y
getNTried() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
getNTried() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional int32 nTried = 6;
getNTried() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nTried = 6;
getNTried() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
getNTried() - Method in class promc.io.ProMCStatFile.ProMCStat
optional int32 nTried = 6;
getNTried() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nTried = 6;
getNTried() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
getNTried() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional int32 nTried = 6;
getNTried() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nTried = 6;
getNTried() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
getNTried() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional int32 nTried = 6;
getNTried() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nTried = 6;
getNullYString() - Method in class org.jfree.chart.labels.AbstractXYItemLabelGenerator
Returns the string representing a null value.
getNumArguments() - Method in class jhplot.math.exp4j.function.Function
Get the number of arguments for this function
getNumBands() - Method in class jhplot.utils.SHisto
Returns the number of bands of the histogram.
getNumber() - Method in class org.jfree.chart.axis.NumberTick
Returns the number.
getNumber(double) - Method in class org.lsmp.djep.xjep.TreeUtils
 
getNumber() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
getNumber() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional int32 Number = 1;
getNumber() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Number = 1;
getNumber() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
getNumber() - Method in class promc.io.ProMC.ProMCEvent.Event
optional int32 Number = 1;
getNumber() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Number = 1;
getNumber() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
getNumber() - Method in class pronlo.io.ProMC.ProMCEvent.Event
optional int32 Number = 1;
getNumber() - Method in interface pronlo.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Number = 1;
getNumber(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 Number = 1 [packed = true];
getNumber(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 Number = 1 [packed = true];
getNumber(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 Number = 1 [packed = true];
getNumberChennels() - Method in class jhplot.stat.DataSource
Get total numberer of channels
getNumberCount() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 Number = 1 [packed = true];
getNumberCount() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 Number = 1 [packed = true];
getNumberCount() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 Number = 1 [packed = true];
getNumberFactory() - Method in interface org.lsmp.djep.groupJep.GroupI
returns a number factory for creating group elements from strings.
getNumberFactory() - Method in class org.lsmp.djep.groupJep.groups.Group
returns a number factory for creating group elements from strings
getNumberFactory() - Method in class org.nfunk.jep.JEP
Returns the number factory.
getNumberFormat() - Method in class org.jfree.chart.labels.AbstractCategoryItemLabelGenerator
Returns the number formatter.
getNumberFormat() - Method in class org.jfree.chart.labels.AbstractPieItemLabelGenerator
Returns the number formatter.
getNumberFormat() - Method in class org.jfree.chart.labels.StandardCrosshairLabelGenerator
Returns the number formatter.
getNumberFormat() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the formatter used to format the value.
getNumberFormatOverride() - Method in class org.jfree.chart.axis.LogAxis
Returns the number format override.
getNumberFormatOverride() - Method in class org.jfree.chart.axis.NumberAxis
Returns the number format override.
getNumberList() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 Number = 1 [packed = true];
getNumberList() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 Number = 1 [packed = true];
getNumberList() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 Number = 1 [packed = true];
getNumberOfAttemptedUpdates() - Method in class org.apache.commons.math3.ml.neuralnet.Neuron
Retrieves the number of calls to the compareAndSetFeatures method.
getNumberOfBins() - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
getNumberOfCalls() - Method in class org.apache.commons.math3.ml.neuralnet.sofm.KohonenUpdateAction
Retrieves the number of calls to the update method.
getNumberOfColumns() - Method in class jplot.DataFile
Return the number of columns (selected items)
getNumberOfColumns() - Method in class org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D
Gets the number of neurons in each column of this map.
getNumberOfDaughters() - Method in class hep.lcio.implementation.event.IMCParticle
 
getNumberOfDigits() - Method in class org.jfree.chart.util.HexNumberFormat
Returns the number of digits.
getNumberOfElements() - Method in interface hep.lcio.event.LCCollection
Returns the number of elements in the collection.
getNumberOfElements() - Method in class hep.lcio.implementation.event.ILCCollection
 
getNumberOfElements() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Get the number of elements (e.g.
getNumberOfEquations() - Method in class org.apache.commons.math3.ode.FieldEquationsMapper
Get the number of equations mapped.
getNumberOfFailures() - Method in class jhplot.math.num.pdf.Hypergeometric
Access the number of failures.
getNumberOfItems() - Method in class jplot.DataFile
 
getNumberOfParameters() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the number of parameters estimated in the model.
getNumberOfParameters() - Method in class org.nfunk.jep.function.PostfixMathCommand
Return the required number of parameters.
getNumberOfParameters() - Method in interface org.nfunk.jep.function.PostfixMathCommandI
Returns the number of required parameters, or -1 if any number of parameters is allowed.
getNumberOfParents() - Method in class hep.lcio.implementation.event.IMCParticle
 
getNumberOfParticles() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
 
getNumberOfPoints() - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegrator
 
getNumberOfRoots() - Method in class org.apache.commons.math3.complex.RootsOfUnity
Returns the number of roots of unity currently stored.
getNumberOfRows() - Method in class org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D
Gets the number of neurons in each row of this map.
getNumberOfSecondaryStates() - Method in class org.apache.commons.math3.ode.FieldODEState
Get the number of secondary states.
getNumberOfSuccesses() - Method in class jhplot.math.num.pdf.Hypergeometric
Access the number of successes.
getNumberOfSuccesses() - Method in class jhplot.math.num.pdf.NegativeBinomial
Access the number of successes.
getNumberOfSuccesses() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Access the number of successes.
getNumberOfSuccesses() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Access the number of successes for this distribution.
getNumberOfSuccessfulUpdates() - Method in class org.apache.commons.math3.ml.neuralnet.Neuron
Retrieves the number of successful calls to the compareAndSetFeatures method.
getNumberOfTics(int) - Method in class jhplot.HPlot
Returns the number of ticks for the specified axis.
getNumberOfTics(int) - Method in class jplot.GraphSettings
Returns the number of tics for the specfied axis.
getNumberOfTrials() - Method in class jhplot.math.num.pdf.Binomial
Access the number of trials.
getNumberOfTrials() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Access the number of trials for this distribution.
getNumberPoints() - Method in class jminhep.algorithms.FuzzyCMeansAlg
Returns the number of points in each cluster.
getNumberPoints() - Method in class jminhep.algorithms.HierarchicalAlg
Returns the number of points in each cluster
getNumberPoints() - Method in class jminhep.algorithms.KMeansAlg
Returns the number of points in each cluster
getNumberPoints() - Method in class jminhep.algorithms.KMeansExchangeAlg
Returns the number of points in each cluster
getNumBins() - Method in class jhplot.utils.SHisto
Returns the number of bins of the histogram for all bands.
getNumBins(int) - Method in class jhplot.utils.SHisto
Returns the number of bins of the histogram for a specific band.
getNumCols() - Method in class org.lsmp.djep.vectorJep.values.Matrix
 
getNumCommands() - Method in class org.lsmp.djep.mrpe.MRpCommandList
number of commands in list.
getNumCommands() - Method in class org.lsmp.djep.rpe.RpCommandList
 
getNumDigits(double) - Static method in class jplot.GraphGeneral
Return the number of digits required to display the given number.
getNumDigits(double) - Static method in class jplot.Utils
Return the number of digits required to display the given number.
getNumElements() - Method in interface org.apache.commons.math3.util.DoubleArray
Returns the number of elements currently in the array.
getNumElements() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns the number of elements currently in the array.
getNumEles() - Method in class org.lsmp.djep.vectorJep.values.Matrix
 
getNumEles() - Method in interface org.lsmp.djep.vectorJep.values.MatrixValueI
The total number of elements.
getNumEles() - Method in class org.lsmp.djep.vectorJep.values.MVector
 
getNumEles() - Method in class org.lsmp.djep.vectorJep.values.Scaler
 
getNumEles() - Method in class org.lsmp.djep.vectorJep.values.Tensor
 
getNumerator() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the numerator as a BigInteger.
getNumerator() - Method in class org.apache.commons.math3.fraction.Fraction
Access the numerator.
getNumerator() - Method in class org.lsmp.djep.groupJep.values.Rational
Returns the top half of the rational.
getNumeratorAsInt() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the numerator as a int.
getNumeratorAsLong() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the numerator as a long.
getNumeratorDegreesOfFreedom() - Method in class jhplot.math.num.pdf.FDistribution
Access the numerator degrees of freedom.
getNumeratorDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.FDistribution
Access the numerator degrees of freedom.
getNumeratorFormat() - Method in class org.apache.commons.math3.fraction.AbstractFormat
Access the numerator format.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.FDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.GeometricDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.GumbelDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.LevyDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.LogisticDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.NakagamiDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.TDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.FDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.GeometricDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.GumbelDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.LevyDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.LogisticDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.NakagamiDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.TDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumGenerations() - Method in class org.apache.commons.math3.genetics.FixedGenerationCount
Returns the number of generations that have already passed.
getNumOperands() - Method in class jhplot.math.exp4j.operator.Operator
Get the number of operands
getNumParam() - Method in class org.nfunk.jep.evaluation.CommandElement
 
getNumRecords() - Method in class jhplot.io.db.BaseRecordsFile
Returns the number or records in the database.
getNumRecords() - Method in class jhplot.io.db.RecordsFile
Returns the current number of records in the database.
getNumRows() - Method in class org.lsmp.djep.vectorJep.values.Matrix
 
getNumRules() - Method in class org.lsmp.djep.djep.diffRules.ChainRuleDiffRules
Returns the number of rules which should be number of arguments of function
getNumTrials() - Method in class org.apache.commons.math3.ml.clustering.MultiKMeansPlusPlusClusterer
Returns the number of trials this instance will do.
getnVals() - Method in class org.apache.commons.math3.special.BesselJ.BesselJResult
 
getObject(String) - Method in class jhplot.io.FileRoot
Get object associated with the key name in the current directory.
getObject(int) - Method in class jhplot.io.FileRoot
Get object associated with the key name in tthe current directory.
getObject() - Method in class org.jfree.data.KeyedObject
Returns the object.
getObject(int) - Method in class org.jfree.data.KeyedObjects
Returns an object from the list.
getObject(Comparable) - Method in class org.jfree.data.KeyedObjects
Returns the object for a given key.
getObject(int, int) - Method in class org.jfree.data.KeyedObjects2D
Returns the object for a given row and column.
getObject(Comparable, Comparable) - Method in class org.jfree.data.KeyedObjects2D
Returns the object for the given row and column keys.
getObject(String, String) - Method in class org.jlab.groot.data.Directory
returns object
getObject(String) - Method in class org.jlab.groot.data.Directory
 
getObject() - Method in class root.FakeTKey
 
getObjectClass() - Method in class root.FakeTKey
 
getObjectIcon() - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Returns the icon drawn for each data item.
getObjectiveFunction() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.ObjectiveFunction
Gets the function to be optimized.
getObjectiveFunction() - Method in class org.apache.commons.math3.optim.univariate.UnivariateObjectiveFunction
Gets the function to be optimized.
getObjectiveFunctionGradient() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.ObjectiveFunctionGradient
Gets the gradient of the function to be optimized.
getObjectiveFunctionValue() - Method in class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Get the value of the objective function.
getObjectList() - Method in class org.jlab.groot.data.Directory
 
getObjectMap() - Method in class jhplot.io.HFile
Return objects stored in the form of a map.
getObjectMap() - Method in class jhplot.io.HFileXML
Return objects stored in the form of a map.
getObjectMap() - Method in class org.jlab.groot.data.Directory
returns map of the objects in the directory
getObjectMap() - Method in class org.jlab.groot.graphics.EmbeddedCanvas
returns all objects plotted on current canvas
getObjectMap() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getObjectOutputStream() - Method in class jhplot.io.db.RecordWriter
 
getObjectProperty(String) - Method in class hep.lcio.util.SIODump.Resolver
 
getObservations() - Method in class org.apache.commons.math3.fitting.CurveFitter
Deprecated.
Get the observed points.
getObservations() - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated.
Get the observed points.
getObservationSize() - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresAdapter
Get the number of observations (rows in the Jacobian) in this problem.
getObservationSize() - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresProblem
Get the number of observations (rows in the Jacobian) in this problem.
getObservers() - Method in class org.apache.commons.io.monitor.FileAlterationMonitor
Returns the set of FileAlterationObserver registered with this monitor.
getOffset(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Get the offset (oriented distance) of a vector.
getOffset(Point<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Get the offset (oriented distance) of a point.
getOffset(Plane) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the offset (oriented distance) of a parallel plane.
getOffset(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the offset (oriented distance) of a vector.
getOffset(Point<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the offset (oriented distance) of a point.
getOffset(Line) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the offset (oriented distance) of a parallel line.
getOffset(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the offset (oriented distance) of a vector.
getOffset(Point<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the offset (oriented distance) of a point.
getOffset() - Method in class org.apache.commons.math3.geometry.partitioning.BoundaryProjection
Offset of the point with respect to the boundary it is projected on.
getOffset(Point<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Get the offset (oriented distance) of a point.
getOffset(Point<Sphere1D>) - Method in class org.apache.commons.math3.geometry.spherical.oned.LimitAngle
Get the offset (oriented distance) of a point.
getOffset(Point<Sphere2D>) - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Get the offset (oriented distance) of a point.
getOffset(Vector3D) - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Get the offset (oriented distance) of a direction.
getOffset() - Method in class org.jfree.chart.axis.CyclicNumberAxis
The cycle bound is a multiple of the period, plus optionally a start offset.
getOffset(int) - Method in class org.jlab.groot.matrix.SparseIndex
 
getOldestIndex() - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the index of the oldest data item.
getOldestTime() - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the oldest time.
getOLSRegression(double[][]) - Static method in class org.jfree.data.statistics.Regression
Returns the parameters 'a' and 'b' for an equation y = a + bx, fitted to the data using ordinary least squares regression.
getOLSRegression(XYDataset, int) - Static method in class org.jfree.data.statistics.Regression
Returns the parameters 'a' and 'b' for an equation y = a + bx, fitted to the data using ordinary least squares regression.
getOmega() - Method in interface hep.lcio.event.Track
Omega is the signed curvature of the track in [1/mm].
getOmega() - Method in interface hep.lcio.event.TrackState
Omega is the signed curvature of the track in [1/mm].
getOmega() - Method in class hep.lcio.implementation.event.ITrack
 
getOmega() - Method in class hep.lcio.implementation.event.ITrackState
 
getOne() - Method in class org.apache.commons.math3.complex.ComplexField
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math3.dfp.Dfp
Get the constant 1.
getOne() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant 1.
getOne() - Method in interface org.apache.commons.math3.Field
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math3.fraction.BigFractionField
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math3.fraction.FractionField
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math3.util.BigRealField
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math3.util.Decimal64Field
Get the multiplicative identity of the field.
getONE() - Method in class org.lsmp.djep.groupJep.groups.BigReals
 
getONE() - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
getONE() - Method in class org.lsmp.djep.groupJep.groups.Integers
 
getONE() - Method in class org.lsmp.djep.groupJep.groups.Quaternions
 
getONE() - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
getONE() - Method in class org.lsmp.djep.groupJep.groups.Reals
 
getONE() - Method in class org.lsmp.djep.groupJep.groups.Zn
 
getONE() - Method in interface org.lsmp.djep.groupJep.interfaces.RingI
Get multiplicative identity i.e.
getONE() - Method in class org.lsmp.djep.xjep.TreeUtils
 
getOne() - Method in class org.nfunk.jep.type.DoubleNumberFactory
 
getOne() - Method in interface org.nfunk.jep.type.NumberFactory
Return an object representing ONE the multiplicative identity.
getOpen(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the open-value for the specified series and item.
getOpen(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the open-value for the specified series and item.
getOpen() - Method in class org.jfree.data.time.ohlc.OHLC
Returns the open value.
getOpen(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the open-value for an item within a series.
getOpen(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the open-value for one item in a series.
getOpen(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the open value.
getOpen() - Method in class org.jfree.data.xy.OHLCDataItem
Returns the open value.
getOpen(int, int) - Method in interface org.jfree.data.xy.OHLCDataset
Returns the open-value for the specified series and item.
getOpenTickPaint() - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Returns the paint used to draw the ticks for the open values.
getOpenValue(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the open-value (as a double primitive) for an item within a series.
getOpenValue(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the open-value (as a double primitive) for an item within a series.
getOpenValue() - Method in class org.jfree.data.time.ohlc.OHLCItem
Returns the open value.
getOpenValue(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the open-value for an item within a series.
getOpenValue(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the open-value (as a double primitive) for an item within a series.
getOpenValue(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the open-value (as a double primitive) for an item within a series.
getOpenValue(int, int) - Method in interface org.jfree.data.xy.OHLCDataset
Returns the open-value (as a double primitive) for an item within a series.
getOperator() - Method in class jhplot.math.exp4j.tokenizer.OperatorToken
Get the operator for that token
getOperator(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns the operator for a node or null if it is not an operator node.
getOperator() - Method in class org.nfunk.jep.ASTFunNode
Returns the id number of the operator if the node is an operator.
getOperators() - Method in class org.lsmp.djep.matrixJep.MatrixOperatorSet
 
getOperators() - Method in class org.nfunk.jep.OperatorSet
Gets the list of operators.
getOperatorSet() - Method in class org.nfunk.jep.JEP
Returns the operator set.
getOpposite() - Method in class org.jfree.chart.axis.AxisLocation
Returns the location that is opposite to this location.
getOpposite(AxisLocation) - Static method in class org.jfree.chart.axis.AxisLocation
Returns the location that is opposite to the supplied location.
getOptima() - Method in class org.apache.commons.math3.optim.BaseMultiStartMultivariateOptimizer
Gets all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
Gets all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultiStartMultivariateVectorOptimizer
Deprecated.
Gets all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optim.univariate.MultiStartUnivariateOptimizer
Gets all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
Deprecated.
Get all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
Deprecated.
Get all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated.
Get all the optima found during the last call to optimize.
getOption(String) - Static method in class jhepsim.Options
Returns the mapped option string value or empty string if the option is undefined.
getOption() - Method in class jhplot.utils.GHFontChooser
 
getOption(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
getOptions() - Method in class hep.lcio.util.CommandHandler
Options for this command.
GetOptions() - Static method in class jminhep.clcontrol.Global
 
getOptions() - Method in class org.jlab.groot.graphics.FunctionPlotter
 
getOptions() - Method in class org.jlab.groot.graphics.GraphErrorsPlotter
 
getOptions() - Method in class org.jlab.groot.graphics.Histogram2DPlotter
 
getOptions() - Method in class org.jlab.groot.graphics.HistogramPlotter
 
getOptions() - Method in interface org.jlab.groot.graphics.IDataSetPlotter
 
getOptStat() - Method in class org.jlab.groot.base.DatasetAttributes
 
getOptStat() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getOptStat() - Method in class org.jlab.groot.math.Func1D
 
getOr() - Method in class org.nfunk.jep.OperatorSet
 
getOrder() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the derivation order.
getOrder() - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the derivation order.
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince54FieldIntegrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince54Integrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince853FieldIntegrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince853Integrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.HighamHall54FieldIntegrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.HighamHall54Integrator
Get the order of the method.
getOrder() - Method in class org.jfree.data.function.PolynomialFunction2D
Returns the order of the polynomial.
getOrder() - Method in class org.jfree.data.KeyedValueComparator
Returns the sort order.
getOrderOfRegressors() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Gets the order of the regressors, useful if some type of reordering has been called.
getOrientation() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the orientation of the plot.
getOrientation() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns the orientation of the plot.
getOrientation() - Method in interface org.jfree.chart.plot.Pannable
Returns the orientation of the plot.
getOrientation() - Method in class org.jfree.chart.plot.PolarPlot
Returns the orientation of the plot.
getOrientation() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the orientation of the plot.
getOrientation() - Method in class org.jfree.chart.plot.XYPlot
Returns the orientation of the plot.
getOrientation() - Method in interface org.jfree.chart.plot.Zoomable
Returns the orientation of the plot.
getOrigin() - Method in class hep.physics.particle.BasicParticle
 
getOrigin() - Method in interface hep.physics.particle.Particle
Point of origin
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get the line point closest to the origin.
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the origin point of the plane frame.
getOriginal() - Method in class org.apache.commons.math3.geometry.partitioning.BoundaryProjection
Get the original point.
getOriginOffset() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the offset of the origin.
getOriginX() - Method in class hep.physics.particle.BasicParticle
 
getOriginX() - Method in interface hep.physics.particle.Particle
 
getOriginY() - Method in class hep.physics.particle.BasicParticle
 
getOriginY() - Method in interface hep.physics.particle.Particle
 
getOriginZ() - Method in class hep.physics.particle.BasicParticle
 
getOriginZ() - Method in interface hep.physics.particle.Particle
 
getOrthoTolerance() - Method in class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
Gets the value of a tuning parameter.
getOuterRadius() - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Returns the outer radius, relative to the framing rectangle.
getOuterRadius() - Method in class org.jfree.chart.plot.dial.StandardDialRange
Returns the outer radius.
getOuterSeparatorExtension() - Method in class org.jfree.chart.plot.RingPlot
Returns the length of the outer extension of the separator line that is drawn between sections, expressed as a percentage of the depth of the section.
getOutgoing() - Method in class org.apache.commons.math3.geometry.spherical.twod.Vertex
Get outgoing edge.
getOutlierCoefficient() - Method in interface org.jfree.data.statistics.BoxAndWhiskerXYDataset
Returns the value used as the outlier coefficient.
getOutlierCoefficient() - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the value used as the outlier coefficient.
getOutliers(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns a list of outlier values for an item.
getOutliers(Comparable, Comparable) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns a list of outlier values for an item.
getOutliers() - Method in class org.jfree.data.statistics.BoxAndWhiskerItem
Returns a list of outliers.
getOutliers(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerXYDataset
Returns a list of outliers for the specified series and item.
getOutliers(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns a list of outlier values for an item.
getOutliers(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns a list of outlier values for an item.
getOutliers(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns a list of outliers for the specified series and item.
getOutline(PolyhedronsSet) - Method in class org.apache.commons.math3.geometry.euclidean.threed.OutlineExtractor
Extract the outline of a polyhedrons set.
getOutlinePaint() - Method in class org.jfree.chart.annotations.XYPolygonAnnotation
Returns the outline paint.
getOutlinePaint() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the outline paint for the annotation.
getOutlinePaint() - Method in class org.jfree.chart.LegendItem
Returns the outline paint.
getOutlinePaint() - Method in class org.jfree.chart.needle.MeterNeedle
Returns the outline paint.
getOutlinePaint() - Method in class org.jfree.chart.plot.dial.DialCap
Returns the paint used to draw the outline of the cap.
getOutlinePaint() - Method in class org.jfree.chart.plot.dial.DialPointer.Pointer
Returns the outline paint.
getOutlinePaint() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the outline paint.
getOutlinePaint() - Method in class org.jfree.chart.plot.Marker
Returns the outline paint.
getOutlinePaint() - Method in class org.jfree.chart.plot.MeterInterval
Returns the outline paint.
getOutlinePaint() - Method in class org.jfree.chart.plot.Plot
Returns the color used to draw the outline of the plot area.
getOutlinePaint() - Method in class org.jfree.chart.title.LegendGraphic
Returns the outline paint.
getOutlineStroke() - Method in class org.jfree.chart.annotations.XYPolygonAnnotation
Returns the outline stroke.
getOutlineStroke() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the outline stroke for the annotation.
getOutlineStroke() - Method in class org.jfree.chart.LegendItem
Returns the outline stroke.
getOutlineStroke() - Method in class org.jfree.chart.needle.MeterNeedle
Returns the outline stroke.
getOutlineStroke() - Method in class org.jfree.chart.plot.dial.DialCap
Returns the stroke used to draw the outline of the cap.
getOutlineStroke() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the outline stroke.
getOutlineStroke() - Method in class org.jfree.chart.plot.Marker
Returns the outline stroke.
getOutlineStroke() - Method in class org.jfree.chart.plot.MeterInterval
Returns the outline stroke.
getOutlineStroke() - Method in class org.jfree.chart.plot.Plot
Returns the stroke used to outline the plot area.
getOutlineStroke() - Method in class org.jfree.chart.title.LegendGraphic
Returns the outline stroke.
getOutofrange(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double outofrange = 10 [packed = true];
getOutofrange(int) - Method in class promc.io.PBufFile.Record.H2D
repeated double outofrange = 10 [packed = true];
getOutofrange(int) - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double outofrange = 10 [packed = true];
getOutofrangeCount() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double outofrange = 10 [packed = true];
getOutofrangeCount() - Method in class promc.io.PBufFile.Record.H2D
repeated double outofrange = 10 [packed = true];
getOutofrangeCount() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double outofrange = 10 [packed = true];
getOutofrangeList() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double outofrange = 10 [packed = true];
getOutofrangeList() - Method in class promc.io.PBufFile.Record.H2D
repeated double outofrange = 10 [packed = true];
getOutofrangeList() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double outofrange = 10 [packed = true];
getOutputDimsNo() - Method in class jhplot.math.pca.PCA
Get number of dimensions of the output vectors
getOutputStream() - Method in class jhplot.io.db.RecordWriter
 
getOverflow() - Method in class jhplot.H1D
Number of overflow entries
getOverflow() - Method in class jhplot.HProf1D
Number of overflow entries
getOverflow() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double overflow = 14;
getOverflow() - Method in class promc.io.PBufFile.Record.H1D
optional double overflow = 14;
getOverflow() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional double overflow = 14;
getOverflowEntriesX() - Method in class jhplot.H2D
Get overflow entries in Y
getOverflowEntriesX() - Method in class jhplot.HProf2D
Get overflow entries in Y
getOverflowEntriesY() - Method in class jhplot.H2D
Get overflow entries in Y
getOverflowEntriesY() - Method in class jhplot.HProf2D
Get overflow entries in Y
getOverflowHeightX() - Method in class jhplot.H2D
Get overflow entries in Y
getOverflowHeightX() - Method in class jhplot.HProf2D
Get overflow entries in Y
getOverflowHeightY() - Method in class jhplot.H2D
Get overflow height in Y
getOverflowHeightY() - Method in class jhplot.HProf2D
Get overflow height in Y
getOverflowlowHeight() - Method in class jhplot.H1D
Overflow height
getOverflowlowHeight() - Method in class jhplot.HProf1D
Overflow height
getOwner() - Method in class org.jfree.chart.plot.PlotRenderingInfo
Returns the owner (as specified in the constructor).
getP() - Method in class jhplot.math.LUDecomposition
Return pivot permutation vector
getP() - Method in class jhplot.stat.Anova
Returns the p-value that your data is all drawn from a single distribution.
getP() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Returns the P rows permutation matrix.
getP() - Method in class org.apache.commons.math3.linear.LUDecomposition
Returns the P rows permutation matrix.
getP() - Method in class org.apache.commons.math3.linear.RRQRDecomposition
Returns the pivot matrix, P, used in the QR Decomposition of matrix A such that AP = QR.
getP0D(int) - Method in class jhplot.PND
Return a specific column as an array
getP0D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0D p0D = 3;
getP0D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.P0D p0D = 3;
getP0D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.P0D p0D = 3;
getP0DBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0D p0D = 3;
getP0DOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0D p0D = 3;
getP0DOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.P0D p0D = 3;
getP0DOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.P0D p0D = 3;
getP0I(int) - Method in class jhplot.PNI
Return a specific column as an array
getP0I(int[]) - Static method in class jhplot.utils.ColorPixel
Get array list with (R,G,B) from list of pixels.
getP0I() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0I p0I = 2;
getP0I() - Method in class promc.io.PBufFile.Record
optional .promc.Record.P0I p0I = 2;
getP0I() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.P0I p0I = 2;
getP0IBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0I p0I = 2;
getP0IOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0I p0I = 2;
getP0IOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.P0I p0I = 2;
getP0IOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.P0I p0I = 2;
getP1D(int) - Method in class jhplot.io.CFBook
Get P1D object from the index (key)
getP1D(String) - Method in class jhplot.io.FileRoot
Get P1D associated with the key name.
getP1D(int, int) - Method in class jhplot.PND
Return 2 columns as P1D to show as a X-Y plot
getP1D(int, int) - Method in class jhplot.PNI
Return 2 columns as P1D to show as a X-Y plot
getP1D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P1D p1D = 6;
getP1D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.P1D p1D = 6;
getP1D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.P1D p1D = 6;
getP1DBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P1D p1D = 6;
getP1DOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P1D p1D = 6;
getP1DOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.P1D p1D = 6;
getP1DOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.P1D p1D = 6;
getP2D(int, int, int) - Method in class jhplot.PND
Return 3 columns as P2D to show as a X-Y-Z plot
getP2D(int, int, int) - Method in class jhplot.PNI
Return 3 columns as P2D to show as a X-Y-Z plot
getPad(int) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
returns EmbeddedPad object with given index
getPadByXY(int, int) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
getPadding() - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Returns the padding for the band.
getPadding() - Method in class org.jfree.chart.block.AbstractBlock
Returns the padding.
getPadding() - Method in class org.jfree.chart.JFreeChart
Returns the padding between the chart border and the chart drawing area.
getPadding() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the padding for the thermometer.
getPadMargins() - Method in class org.jlab.groot.base.PadAttributes
 
getPaint() - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Returns the paint used to draw the connecting line.
getPaint() - Method in class org.jfree.chart.annotations.TextAnnotation
Returns the paint for the annotation.
getPaint() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the paint for the annotation.
getPaint(double) - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Returns the Paint associated with a value.
getPaint() - Method in class org.jfree.chart.block.BlockBorder
Returns the paint used to draw the border.
getPaint() - Method in class org.jfree.chart.block.ColorBlock
Returns the paint.
getPaint() - Method in class org.jfree.chart.block.LabelBlock
Returns the paint.
getPaint() - Method in class org.jfree.chart.block.LineBorder
Returns the paint.
getPaint() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the paint used to draw or fill shapes (or text).
getPaint(Comparable) - Method in class org.jfree.chart.PaintMap
Returns the paint associated with the specified key, or null.
getPaint(double) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns Paint by mapping a given value to a either a linear or common log palette as controlled by the value logscale.
getPaint() - Method in class org.jfree.chart.plot.Crosshair
Returns the paint for the crosshair line.
getPaint() - Method in class org.jfree.chart.plot.dial.DialBackground
Returns the paint used to fill the background.
getPaint() - Method in class org.jfree.chart.plot.dial.DialPointer.Pin
Returns the paint.
getPaint() - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Returns the paint used to display the label.
getPaint() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the paint.
getPaint() - Method in class org.jfree.chart.plot.dial.StandardDialRange
Returns the paint used to highlight the range.
getPaint() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns the paint used to plot data points.
getPaint() - Method in class org.jfree.chart.plot.Marker
Returns the paint.
getPaint(double) - Method in class org.jfree.chart.renderer.GrayPaintScale
Returns a paint for the specified value.
getPaint(double) - Method in class org.jfree.chart.renderer.LookupPaintScale
Returns the paint associated with the specified value.
getPaint(double) - Method in interface org.jfree.chart.renderer.PaintScale
Returns a Paint instance for the specified value.
getPaint() - Method in class org.jfree.chart.title.TextTitle
Returns the paint used to display the title string.
getPaintScale() - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Returns the paint scale used by the renderer.
getPaintScale() - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Returns the paint scale used by the renderer.
getPalette() - Method in class org.jfree.chart.editor.PaletteSample
Deprecated.
Returns the current palette object being displayed.
getPaletteName() - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns the palette name.
getPalettes() - Method in class net.java.dev.colorchooser.ColorChooser
Get the array of palettes that will be displayed when the user clicks this color chooser component and holds down various keys.
getPane() - Method in class org.jlab.groot.base.AxisAttributes
 
getPane() - Method in class org.jlab.groot.base.DatasetAttributes
 
getPanelSize() - Method in class jhplot.HPlot
Returns the dimensions of the panel used to display the graph.
getPanelSize() - Method in class jplot.GraphSettings
Returns the dimensions of the panel used to display the graph.
getPar(String) - Method in class jhplot.HFitter
Get parameter value
getParam() - Method in class fitter.BFunc
get parameters
getParameter(String) - Method in interface org.apache.commons.math3.ode.ParameterizedODE
Get parameter value from its name.
getParameter(int) - Method in class org.jlab.groot.math.Func1D
 
getParameter(int) - Method in class org.jlab.groot.math.UserParameters
 
getParameterEstimate(int) - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the parameter estimate for the regressor at the given index.
getParameterEstimate() - Method in class org.jlab.groot.math.Func1D
 
getParameterEstimates() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns a copy of the regression parameters estimates.
getParameterRelativeTolerance() - Method in class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
Gets the value of a tuning parameter.
getParameters() - Method in interface hep.lcio.event.LCCollection
Parameters defined for this collection.
getParameters() - Method in interface hep.lcio.event.LCEvent
Parameters defined for this event.
getParameters() - Method in interface hep.lcio.event.LCRunHeader
Parameters defined for this run.
getParameters() - Method in interface hep.lcio.event.ParticleID
Parameters associated with this hypothesis.
getParameters() - Method in interface hep.lcio.event.Vertex
Additional parameters related to this vertex - check/set the collection parameter "VertexParameterNames" for the parameters' meaning.
getParameters() - Method in class hep.lcio.implementation.event.ILCCollection
 
getParameters() - Method in class hep.lcio.implementation.event.ILCEvent
 
getParameters() - Method in class hep.lcio.implementation.event.ILCRunHeader
 
getParameters() - Method in class hep.lcio.implementation.event.IParticleID
 
getParameters() - Method in class hep.lcio.implementation.event.IVertex
 
getParameters() - Method in class org.jlab.groot.math.UserParameters
 
getParameterSize() - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresAdapter
Get the number of parameters (columns in the Jacobian) in this problem.
getParameterSize() - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresProblem
Get the number of parameters (columns in the Jacobian) in this problem.
getParametersNames() - Method in class org.apache.commons.math3.ode.AbstractParameterizable
Get the names of the supported parameters.
getParametersNames() - Method in interface org.apache.commons.math3.ode.Parameterizable
Get the names of the supported parameters.
getParent(int) - Method in class hep.lcio.implementation.event.IMCParticle
 
getParent() - Method in class hephysics.particle.LParticle
Get a parent particle
getParent() - Method in class org.apache.commons.io.monitor.FileEntry
Return the parent entry.
getParent() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Get the parent node.
getParent() - Method in class org.jfree.chart.plot.Plot
Returns the parent plot (or null if this plot is not part of a combined plot).
getParent() - Method in interface org.jfree.data.general.CombinationDataset
Deprecated.
Returns the parent Dataset of this combination.
getParent() - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the parent Dataset of this combination.
getParent() - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the parent Dataset of this combination.
getParent() - Method in class org.jlab.groot.data.Directory
Returns pointer to parent directory.
getParents() - Method in interface hep.lcio.event.MCParticle
Returns the parents of this particle.
getParents() - Method in class hep.lcio.implementation.event.IMCParticle
 
getParents() - Method in class hep.physics.particle.BasicParticle
 
getParents() - Method in interface hep.physics.particle.Particle
Returns a list of the parent(s) of this particle
getParse() - Method in class jhplot.F1D
Return parsed function.
getParse() - Method in class jhplot.F2D
Return parsed function.
getParse() - Method in class jhplot.F3D
Return parsed functional expression.
getParser() - Method in class org.nfunk.jep.JEP
Returns the parse object.
getParserForType() - Method in class proeic.io.ProMC.ProMCEvent.Event
 
getParserForType() - Method in class proeic.io.ProMC.ProMCEvent
 
getParserForType() - Method in class proeic.io.ProMC.ProMCEvent.Particles
 
getParserForType() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
getParserForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
getParserForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getParserForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getParserForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getParserForType() - Method in class proeic.io.ProMCStatFile.ProMCStat
 
getParserForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
getParserForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
getParserForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
getParserForType() - Method in class promc.io.PBufFile.Record.F1D
 
getParserForType() - Method in class promc.io.PBufFile.Record.F2D
 
getParserForType() - Method in class promc.io.PBufFile.Record.FND
 
getParserForType() - Method in class promc.io.PBufFile.Record.FPR
 
getParserForType() - Method in class promc.io.PBufFile.Record
 
getParserForType() - Method in class promc.io.PBufFile.Record.H1D
 
getParserForType() - Method in class promc.io.PBufFile.Record.H2D
 
getParserForType() - Method in class promc.io.PBufFile.Record.P0D
 
getParserForType() - Method in class promc.io.PBufFile.Record.P0I
 
getParserForType() - Method in class promc.io.PBufFile.Record.P1D
 
getParserForType() - Method in class promc.io.PBufFile.Record.PND
 
getParserForType() - Method in class promc.io.PBufFile.Record.PNI
 
getParserForType() - Method in class promc.io.PBufFile.Record.PXY
 
getParserForType() - Method in class promc.io.PBufFile.Record.PXYZ
 
getParserForType() - Method in class promc.io.PEventFile.HEvent.Entry
 
getParserForType() - Method in class promc.io.PEventFile.HEvent
 
getParserForType() - Method in class promc.io.PEventFile.HEvent.Group
 
getParserForType() - Method in class promc.io.ProMC.ProMCEvent.Event
 
getParserForType() - Method in class promc.io.ProMC.ProMCEvent
 
getParserForType() - Method in class promc.io.ProMC.ProMCEvent.Particles
 
getParserForType() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
getParserForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
 
getParserForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getParserForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getParserForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getParserForType() - Method in class promc.io.ProMCStatFile.ProMCStat
 
getParserForType() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
getParserForType() - Method in class pronlo.io.ProMC.ProMCEvent.Event
 
getParserForType() - Method in class pronlo.io.ProMC.ProMCEvent
 
getParserForType() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
 
getParserForType() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
getParserForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
getParserForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getParserForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getParserForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getParserForType() - Method in class pronlo.io.ProMCStatFile.ProMCStat
 
getParserForType() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
getParserForType() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
 
getParserForType() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
 
getParserForType() - Method in class proreco.io.ProMC.ProMCEvent.Event
 
getParserForType() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
 
getParserForType() - Method in class proreco.io.ProMC.ProMCEvent
 
getParserForType() - Method in class proreco.io.ProMC.ProMCEvent.Jets
 
getParserForType() - Method in class proreco.io.ProMC.ProMCEvent.MissingET
 
getParserForType() - Method in class proreco.io.ProMC.ProMCEvent.Muons
 
getParserForType() - Method in class proreco.io.ProMC.ProMCEvent.Particles
 
getParserForType() - Method in class proreco.io.ProMC.ProMCEvent.Photons
 
getParserForType() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
 
getParserForType() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
getParserForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
getParserForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getParserForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getParserForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getParserForType() - Method in class proreco.io.ProMCStatFile.ProMCStat
 
getParserForType() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
getPartialCorrelations(int) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
In the original algorithm only the partial correlations of the regressors is returned to the user.
getPartialDeriv(String, String[]) - Method in class org.lsmp.djep.djep.DSymbolTable
 
getPartialDerivative(int...) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get a partial derivative.
getPartialDerivativeIndex(int...) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the index of a partial derivative in the array.
getPartialDerivativeOrders(int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the derivation orders for a specific index in the array.
getParticle(ProMC.ProMCEvent.Particles, int, int, int) - Static method in class hephysics.hepsim.PromcUtil
For a given momentum unit, create a Lorentz particle object at the position j.
getParticleById(int) - Static method in class j4np.physics.PDGDatabase
 
getParticleByName(String) - Static method in class j4np.physics.PDGDatabase
 
getParticleCont(int) - Method in interface hep.lcio.event.SimCalorimeterHit
Returns the MCParticle that caused the shower responsible for this contribution to the hit.
getParticleCont(int) - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
getParticleData(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleData(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleData(int) - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleData(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleData(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleData(int) - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleData(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleData(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleData(int) - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleData(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleData(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleData(int) - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataBuilderList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataBuilderList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataBuilderList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataBuilderList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataCount() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataList() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilder(int) - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDataOrBuilderList() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
getParticleDList(ProMCHeaderFile.ProMCHeader, ProMC.ProMCEvent.Particles, double, double) - Static method in class hephysics.hepsim.PromcUtil
Fill particles from ProMC from a typical NLO program, and apply some cuts if available.
getParticleDList(double, Mc.VarintPackedParticles, double, double) - Static method in class hephysics.hepsim.PromcUtil
Fill particles from ProIO and apply some cuts if available.
getParticleDList(ProMCHeaderFile.ProMCHeader, ProMC.ProMCEvent.Particles, int, double, double) - Static method in class hephysics.hepsim.PromcUtil
Fill particles from ProMC and apply some cuts if available.
getParticleDList(double, Mc.VarintPackedParticles, int, double, double) - Static method in class hephysics.hepsim.PromcUtil
Fill particles from ProIO and apply some cuts if available.
getParticleFList(ProMCHeaderFile.ProMCHeader, ProMC.ProMCEvent.Particles, int, double, double) - Static method in class hephysics.hepsim.PromcUtil
Fill particles from ProMC and apply some cuts if available.
getParticleFList(ProMCHeaderFile.ProMCHeader, ProMC.ProMCEvent.Particles, double, double) - Static method in class hephysics.hepsim.PromcUtil
Fill particles from ProMC from a typical NLO program, and apply some cuts if available.
getParticleIDs() - Method in interface hep.lcio.event.Cluster
The particle Id's sorted by their likelihood.
getParticleIDs() - Method in interface hep.lcio.event.ReconstructedParticle
The particle Id's sorted by their likelihood.
getParticleIDs() - Method in class hep.lcio.implementation.event.ICluster
 
getParticleIDs() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getParticleIDUsed() - Method in interface hep.lcio.event.ReconstructedParticle
The particle Id used for the kinematics of this particle.
getParticleIDUsed() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getParticleMass(int) - Static method in class j4np.physics.PDGDatabase
 
getParticlePropertyProvider() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Get the particle property provider being used by this generator
getParticlePropertyProvider() - Static method in class hep.physics.particle.properties.ParticlePropertyManager
 
getParticlePropertyProvider(String) - Static method in class hep.physics.particle.properties.ParticlePropertyManager
 
getParticlePropertyProvider() - Method in interface hep.physics.particle.properties.ParticleType
Get the provider of this particle type
getParticles() - Method in interface hep.lcio.event.ReconstructedParticle
The reconstructed particles that have been combined to this particle.
getParticles() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getParticles() - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticles() - Method in class proeic.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
getParticles() - Method in interface proeic.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
getParticles() - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticles() - Method in class promc.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
getParticles() - Method in interface promc.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
getParticles() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticles() - Method in class pronlo.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
getParticles() - Method in interface pronlo.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
getParticles() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticles() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
getParticles() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesBuilder() - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesBuilder() - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesBuilder() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in class proeic.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in interface proeic.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in class promc.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in interface promc.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in class pronlo.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in interface pronlo.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
getParticlesOrBuilder() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
getParticleType() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
 
getPartitionCoefficient() - Method in class jminhep.algorithms.FuzzyCMeansAlg
This method returns the Partition Coefficient measure of cluster validity (see Fuzzy Algorithms With Applications to Image Processing and Pattern Recognition, Zheru Chi, Hong Yan, Tuan Pham, World Scientific, pp.
getPartitionEntropy() - Method in class jminhep.algorithms.FuzzyCMeansAlg
This method returns the Partition Entropy measure of cluster validity (see Fuzzy Algorithms With Applications to Image Processing and Pattern Recognition, Zheru Chi, Hong Yan, Tuan Pham, World Scientific, pp.
getPassCount() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the number of passes through the dataset required by the renderer.
getPassCount() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the number of passes through the dataset required by the renderer.
getPassCount() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
This renderer uses two passes to draw the data.
getPassCount() - Method in class org.jfree.chart.renderer.category.StackedAreaRenderer
Returns the number of passes (2) required by this renderer.
getPassCount() - Method in class org.jfree.chart.renderer.category.StackedBarRenderer
Returns the number of passes (3) required by this renderer.
getPassCount() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the number of passes through the data that the renderer requires in order to draw the chart.
getPassCount() - Method in class org.jfree.chart.renderer.xy.ClusteredXYBarRenderer
Returns the number of passes through the dataset that this renderer requires.
getPassCount() - Method in class org.jfree.chart.renderer.xy.DeviationRenderer
Returns the number of passes (through the dataset) used by this renderer.
getPassCount() - Method in class org.jfree.chart.renderer.xy.SamplingXYLineRenderer
Returns the number of passes through the data that the renderer requires in order to draw the chart.
getPassCount() - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Returns the number of passes required by the renderer.
getPassCount() - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer2
Returns the number of passes required by the renderer.
getPassCount() - Method in class org.jfree.chart.renderer.xy.StackedXYBarRenderer
Returns 3 to indicate that this renderer requires three passes for drawing (shadows are drawn in the first pass, the bars in the second, and item labels are drawn in the third pass so that they always appear in front of all the bars).
getPassCount() - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Returns 2, the number of passes required by the renderer.
getPassCount() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the number of passes through the data required by the renderer.
getPassCount() - Method in class org.jfree.chart.renderer.xy.XYLine3DRenderer
Returns the number of passes through the data that the renderer requires in order to draw the chart.
getPassCount() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns the number of passes through the data that the renderer requires in order to draw the chart.
getPassCount() - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Returns the number of passes required by this renderer.
getPassesRequired() - Method in class org.jfree.chart.plot.PiePlotState
Returns the number of passes required by the renderer.
getPath(String) - Static method in class org.apache.commons.io.FilenameUtils
Gets the path from a full fileName, which excludes the prefix.
getPathCounters() - Method in class org.apache.commons.io.file.CountingPathVisitor
Gets the visitation counts.
getPathLength() - Method in interface hep.lcio.event.SimTrackerHit
The path length of the particle in the sensitive material that resulted in this hit.
getPathLength() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
getPathNoEndSeparator(String) - Static method in class org.apache.commons.io.FilenameUtils
Gets the path from a full fileName, which excludes the prefix, and also excluding the final directory separator.
getPaveTexts() - Method in class org.jlab.groot.ui.PaveText
 
getPct(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(int) - Method in class org.apache.commons.math3.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(long) - Method in class org.apache.commons.math3.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(char) - Method in class org.apache.commons.math3.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPDF1() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float PDF1 = 6;
getPDF1() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float PDF1 = 6;
getPDF1() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float PDF1 = 6;
getPdf1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
getPdf1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf1 = 8;
getPdf1() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf1 = 8;
getPDF1() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float PDF1 = 6;
getPDF1() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float PDF1 = 6;
getPDF1() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float PDF1 = 6;
getPdf1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
getPdf1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf1 = 8;
getPdf1() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf1 = 8;
getPdf1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
getPdf1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf1 = 8;
getPdf1() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf1 = 8;
getPDF1(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF1 = 6 [packed = true];
getPDF1(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float PDF1 = 6 [packed = true];
getPDF1(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float PDF1 = 6 [packed = true];
getPdf1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
getPdf1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf1 = 8;
getPdf1() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf1 = 8;
getPDF1Count() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF1 = 6 [packed = true];
getPDF1Count() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float PDF1 = 6 [packed = true];
getPDF1Count() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float PDF1 = 6 [packed = true];
getPDF1List() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF1 = 6 [packed = true];
getPDF1List() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float PDF1 = 6 [packed = true];
getPDF1List() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float PDF1 = 6 [packed = true];
getPDF2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float PDF2 = 7;
getPDF2() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float PDF2 = 7;
getPDF2() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float PDF2 = 7;
getPdf2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
getPdf2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf2 = 9;
getPdf2() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf2 = 9;
getPDF2() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float PDF2 = 7;
getPDF2() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float PDF2 = 7;
getPDF2() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float PDF2 = 7;
getPdf2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
getPdf2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf2 = 9;
getPdf2() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf2 = 9;
getPdf2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
getPdf2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf2 = 9;
getPdf2() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf2 = 9;
getPDF2(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF2 = 7 [packed = true];
getPDF2(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float PDF2 = 7 [packed = true];
getPDF2(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float PDF2 = 7 [packed = true];
getPdf2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
getPdf2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf2 = 9;
getPdf2() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf2 = 9;
getPDF2Count() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF2 = 7 [packed = true];
getPDF2Count() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float PDF2 = 7 [packed = true];
getPDF2Count() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float PDF2 = 7 [packed = true];
getPDF2List() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF2 = 7 [packed = true];
getPDF2List() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float PDF2 = 7 [packed = true];
getPDF2List() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float PDF2 = 7 [packed = true];
getPdfId1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
getPdfId1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id1 = 3;
getPdfId1() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id1 = 3;
getPdfId1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
getPdfId1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id1 = 3;
getPdfId1() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id1 = 3;
getPdfId1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
getPdfId1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id1 = 3;
getPdfId1() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id1 = 3;
getPdfId1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
getPdfId1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id1 = 3;
getPdfId1() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id1 = 3;
getPdfId2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
getPdfId2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id2 = 4;
getPdfId2() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id2 = 4;
getPdfId2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
getPdfId2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id2 = 4;
getPdfId2() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id2 = 4;
getPdfId2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
getPdfId2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id2 = 4;
getPdfId2() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id2 = 4;
getPdfId2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
getPdfId2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id2 = 4;
getPdfId2() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id2 = 4;
getPDG() - Method in interface hep.lcio.event.MCParticle
Returns the PDG code of the particle.
getPDG() - Method in interface hep.lcio.event.ParticleID
The PDG code of this id - UnknownPDG ( 999999 ) if unknown.
getPDG() - Method in class hep.lcio.implementation.event.IMCParticle
 
getPDG() - Method in class hep.lcio.implementation.event.IParticleID
 
getPdgcode() - Method in class hephysics.particle.HEParticle
Get PDG code
getPDGCont(int) - Method in interface hep.lcio.event.SimCalorimeterHit
Returns the PDG code of the shower particle that caused this contribution.
getPDGCont(int) - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
getPDGID() - Method in class hep.physics.particle.BasicParticle
 
getPDGID() - Method in interface hep.physics.particle.Particle
Convenience method for getting particles PDGID
getPDGID() - Method in interface hep.physics.particle.properties.ParticleType
The particle data group ID
getPDGID() - Method in exception hep.physics.particle.properties.UnknownParticleIDException
 
getPdgId(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgId(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgId(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPdgId(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgId(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgId(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPdgId(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgId(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgId(int) - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPdgId(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgId(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgId(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 pdg_id = 2 [packed = true];
getPdgIdList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 pdg_id = 2 [packed = true];
getPearsonR() - Method in class jhplot.stat.LinReg
Get pearson R
getPenColor() - Method in class jhplot.P3D
Get the color attribute
getPenWidth() - Method in class jhplot.DrawOptions
Return the width of the lines.
getPenWidth() - Method in class jhplot.FPR
Get width of line
getPenWidth() - Method in class jhplot.P3D
Get width of the lines
getPenWidth() - Method in class jplot.LinePars
Return the width of the lines
getPenWidth() - Method in interface jplot3d.SurfaceModel
 
getPenWidth() - Method in class jplot3d.SurfaceModelCanvas
 
getPenWidthAxes() - Method in class jhplot.HPlot3D
Gets the pen width to draw axes.
getPenWidthAxis() - Method in class jhplot.HPlot
Get pen width to draw axis
getPenWidthAxis() - Method in class jplot.GraphSettings
Get pen width to draw axis
getPenWidthErr() - Method in class jplot.LinePars
Return the width of the lines to show errors
getPenWidthErrSys() - Method in class jplot.LinePars
Return the width of the lines to show systematical errors
getPercent() - Method in class org.jfree.chart.event.ChartProgressEvent
Returns the percentage complete.
getPercentComplete(int, int) - Method in interface org.jfree.data.gantt.GanttCategoryDataset
Returns the percent complete for a given item.
getPercentComplete(Comparable, Comparable) - Method in interface org.jfree.data.gantt.GanttCategoryDataset
Returns the percent complete for a given item.
getPercentComplete(int, int, int) - Method in interface org.jfree.data.gantt.GanttCategoryDataset
Returns the percentage complete value of a sub-interval for a given item.
getPercentComplete(Comparable, Comparable, int) - Method in interface org.jfree.data.gantt.GanttCategoryDataset
Returns the percentage complete value of a sub-interval for a given item.
getPercentComplete(Comparable, Comparable) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the percent complete for a given item.
getPercentComplete(Comparable, Comparable, int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the percentage complete value of a sub-interval for a given item.
getPercentComplete(int, int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the percent complete for a given item.
getPercentComplete(int, int, int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the percentage complete value of a sub-interval for a given item.
getPercentComplete() - Method in class org.jfree.data.gantt.Task
Returns the percentage complete for this task.
getPercentComplete(int, int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the percent complete for a given item.
getPercentComplete(Comparable, Comparable) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the percent complete for a given item.
getPercentComplete(int, int, int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the percentage complete value of a sub-interval for a given item.
getPercentComplete(Comparable, Comparable, int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the percentage complete value of a sub-interval for a given item.
getPercentFormat() - Method in class org.jfree.chart.labels.AbstractPieItemLabelGenerator
Returns the percent formatter.
getPercentile(double) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns an estimate for the pth percentile of the stored values.
getPercentileImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured percentile implementation.
getPeriod() - Method in class org.jfree.chart.axis.CyclicNumberAxis
The cycle bound is a multiple of the period, plus optionally a start offset.
getPeriod() - Method in class org.jfree.data.time.ohlc.OHLCItem
Returns the period.
getPeriod(int) - Method in class org.jfree.data.time.ohlc.OHLCSeries
Returns the time period for the specified item.
getPeriod() - Method in class org.jfree.data.time.TimePeriodValue
Returns the time period.
getPeriod() - Method in class org.jfree.data.time.TimeSeriesDataItem
Returns the time period.
getPeriodClass() - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Returns the subclass of RegularTimePeriod that should be used to generate the date labels.
getPfmc() - Method in class org.lsmp.djep.djep.diffRules.ChainRuleDiffRules
returns the PostfixMathCommandI for the function.
getPFMC() - Method in class org.nfunk.jep.ASTFunNode
Returns the math command class associated with this node.
getPFMC() - Method in class org.nfunk.jep.evaluation.CommandElement
 
getPFMC() - Method in class org.nfunk.jep.Operator
 
getPhase(Vector3D) - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Get the phase angle of a direction.
getPhi() - Method in interface hep.lcio.event.Track
Phi of the track at the reference point.
getPhi() - Method in interface hep.lcio.event.TrackState
Phi of the track at the reference point.
getPhi() - Method in class hep.lcio.implementation.event.ITrack
 
getPhi() - Method in class hep.lcio.implementation.event.ITrackState
 
getPhi() - Method in class hephysics.jet.ParticleD
Get cached phi
getPhi() - Method in class hephysics.jet.ParticleF
 
getPhi() - Method in class org.apache.commons.math3.geometry.euclidean.threed.SphericalCoordinates
Get the polar (co-latitude) angle.
getPhi() - Method in class org.apache.commons.math3.geometry.spherical.twod.S2Point
Get the polar angle \( \varphi \).
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.MissingET
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.MissingETOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Phi = 21 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Phi = 21 [packed = true];
getPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Phi = 21 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint64 Phi = 3 [packed = true];
getPhi(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.MissingET
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.MissingETOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Phi = 21 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Phi = 21 [packed = true];
getPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Phi = 21 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint64 Phi = 3 [packed = true];
getPhiCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.MissingET
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.MissingETOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Phi = 21 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Phi = 21 [packed = true];
getPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Phi = 21 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint64 Phi = 3 [packed = true];
getPhiList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint64 Phi = 3 [packed = true];
getPhiOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 PhiOuter = 12 [packed = true];
getPhiOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 PhiOuter = 12 [packed = true];
getPhiOuter(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 PhiOuter = 12 [packed = true];
getPhiOuterCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 PhiOuter = 12 [packed = true];
getPhiOuterCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 PhiOuter = 12 [packed = true];
getPhiOuterCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 PhiOuter = 12 [packed = true];
getPhiOuterList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 PhiOuter = 12 [packed = true];
getPhiOuterList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 PhiOuter = 12 [packed = true];
getPhiOuterList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 PhiOuter = 12 [packed = true];
getPhotons() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Photons photons = 9;
getPhotons() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Photons photons = 9;
getPhotons() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Photons photons = 9;
getPhotonsBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Photons photons = 9;
getPhotonsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Photons photons = 9;
getPhotonsOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Photons photons = 9;
getPhotonsOrBuilder() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Photons photons = 9;
getPi() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant π.
getPicture() - Method in class jhplot.shapes.Picture
Get the image
getPieArea() - Method in class org.jfree.chart.plot.PiePlotState
Returns the pie area.
getPieCenterX() - Method in class org.jfree.chart.plot.PiePlotState
Returns the x-coordinate of the center of the pie chart.
getPieCenterY() - Method in class org.jfree.chart.plot.PiePlotState
Returns the y-coordinate (in Java2D space) of the center of the pie chart.
getPieChart() - Method in class org.jfree.chart.plot.MultiplePiePlot
Returns the pie chart that is used to draw the individual pie plots.
getPieHRadius() - Method in class org.jfree.chart.plot.PiePlotState
Returns the vertical pie radius.
getPieIndex() - Method in class org.jfree.chart.entity.PieSectionEntity
Returns the pie index.
getPieIndex() - Method in class org.jfree.chart.plot.PiePlot
Returns the pie index (this is used by the MultiplePiePlot class to track subplots).
getPieLabelRecord(int) - Method in class org.jfree.chart.plot.AbstractPieLabelDistributor
Returns a label record from the list.
getPieWRadius() - Method in class org.jfree.chart.plot.PiePlotState
Returns the horizontal pie radius.
getPiSplit() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant π split in two pieces.
getPivot() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns a copy of the pivot permutation vector.
getPivot() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns the pivot permutation vector (not a copy of it).
getPivot() - Method in class Jama.LUDecomposition
Return pivot permutation vector
getPivot() - Method in class jhplot.math.kalman.jama.LUDecomposition
Return pivot permutation vector
getPivot() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Returns the pivot permutation vector.
getPivot() - Method in class org.apache.commons.math3.linear.LUDecomposition
Returns the pivot permutation vector.
getPivotingStrategy() - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Get the PivotingStrategyInterface used in KthSelector for computation.
getPivotingStrategy() - Method in class org.apache.commons.math3.util.KthSelector
Get the pivotin strategy.
getPixel(Color) - Static method in class jhplot.utils.ColorPixel
Convert color into compact integer representation of pixel.
getPixel(int, int, int) - Static method in class jhplot.utils.ColorPixel
Convert color (red,green,blue) into compact integer representation of pixel.
getPixel(int[], int[], int[]) - Static method in class jhplot.utils.ColorPixel
Convert arrays with R,G,B into a pixel color as in ImageJ.
getPlot() - Method in class jhplot.HChart
Get XY plot
getPlot() - Method in class org.jfree.chart.axis.Axis
Returns the plot that the axis is assigned to.
getPlot() - Method in class org.jfree.chart.entity.PlotEntity
Returns the plot that occupies the entity area.
getPlot() - Method in class org.jfree.chart.event.PlotChangeEvent
Returns the plot that generated the event.
getPlot() - Method in class org.jfree.chart.JFreeChart
Returns the plot for the chart.
getPlot() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the plot that the renderer has been assigned to (where null indicates that the renderer is not currently assigned to a plot).
getPlot() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the plot that the renderer has been assigned to (where null indicates that the renderer is not currently assigned to a plot).
getPlot() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Return the plot associated with this renderer.
getPlot() - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Returns the plot that this renderer has been assigned to.
getPlot() - Method in class org.jfree.chart.renderer.WaferMapRenderer
Returns the plot.
getPlot() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the plot that the renderer is assigned to.
getPlot() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the plot that this renderer has been assigned to.
getPlotArea() - Method in class org.jfree.chart.plot.PlotRenderingInfo
Returns the plot area (in Java2D space).
getPlotArea() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Returns true if Area is being plotted by the renderer.
getPlotArea() - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Returns true if Area is being plotted by the renderer.
getPlotBackgroundPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the plot background paint.
getPlotColor() - Method in interface jplot3d.SurfaceModel
 
getPlotColor() - Method in class jplot3d.SurfaceModelCanvas
 
getPlotDiscontinuous() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns a flag that controls whether or not the renderer shows discontinuous lines.
getPlotImages() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns true if images are being plotted by the renderer.
getPlotInfo() - Method in class org.jfree.chart.ChartRenderingInfo
Returns the rendering info for the chart's plot.
getPlotLines() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns true if lines are being plotted by the renderer.
getPlotLines() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Returns true if lines are being plotted by the renderer.
getPlotLines() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer2
Deprecated.
This method was included in the API by mistake and serves no useful purpose. It has always returned false.
getPlotOrientation() - Method in class jhplot.HChart
Get current plot orientation.
getPlotOutlinePaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the plot outline paint.
getPlotShapes() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Returns true if shapes are being plotted by the renderer.
getPlotter() - Method in interface jplot3d.SurfaceModel
 
getPlotter() - Method in class jplot3d.SurfaceModelCanvas
 
getPlotType() - Method in interface jplot3d.SurfaceModel
 
getPlotType() - Method in class jplot3d.SurfaceModelCanvas
 
getPlotType() - Method in class org.jfree.chart.plot.CategoryPlot
Returns a string describing the type of plot.
getPlotType() - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Returns a string describing the type of plot.
getPlotType() - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Returns a string describing the type of plot.
getPlotType() - Method in class org.jfree.chart.plot.CompassPlot
Returns a short string describing the type of plot.
getPlotType() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the plot type as a string.
getPlotType() - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the plot type.
getPlotType() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns a short string describing the plot type.
getPlotType() - Method in class org.jfree.chart.plot.MeterPlot
Returns a short string describing the type of plot.
getPlotType() - Method in class org.jfree.chart.plot.MultiplePiePlot
Returns a short string describing the type of plot.
getPlotType() - Method in class org.jfree.chart.plot.PiePlot
Returns a short string describing the type of plot.
getPlotType() - Method in class org.jfree.chart.plot.PiePlot3D
Returns a short string describing the type of plot.
getPlotType() - Method in class org.jfree.chart.plot.Plot
Returns a short string describing the plot type.
getPlotType() - Method in class org.jfree.chart.plot.PolarPlot
Returns the plot type as a string.
getPlotType() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns a short string describing the type of plot.
getPlotType() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns a short string describing the type of plot.
getPlotType() - Method in class org.jfree.chart.plot.WaferMapPlot
Returns the plot type as a string.
getPlotType() - Method in class org.jfree.chart.plot.XYPlot
Returns the plot type as a string.
getPlus() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Get the tree on the plus side of the cut hyperplane.
getPlus() - Method in class org.apache.commons.math3.geometry.partitioning.SubHyperplane.SplitSubHyperplane
Get the part of the sub-hyperplane on the plus side of the splitting hyperplane.
getPlus() - Method in class org.apache.commons.math3.geometry.spherical.oned.ArcsSet.Split
Get the part of the arcs set on the plus side of the splitting arc.
getPlusInside() - Method in class org.apache.commons.math3.geometry.partitioning.BoundaryAttribute
Get the part of the node cut sub-hyperplane that belongs to the boundary and has the inside of the region on the plus side of its underlying hyperplane.
getPlusOutside() - Method in class org.apache.commons.math3.geometry.partitioning.BoundaryAttribute
Get the part of the node cut sub-hyperplane that belongs to the boundary and has the outside of the region on the plus side of its underlying hyperplane.
getPmf() - Method in class org.apache.commons.math3.distribution.EnumeratedDistribution
Return the probability mass function as a list of pairs.
getPND() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PND pND = 13;
getPND() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PND pND = 13;
getPND() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PND pND = 13;
getPNDBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PND pND = 13;
getPNDOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PND pND = 13;
getPNDOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PND pND = 13;
getPNDOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PND pND = 13;
getPNI(int[]) - Static method in class jhplot.utils.ColorPixel
Get array list with (R,G,B) from list of pixels.
getPNI() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PNI pNI = 14;
getPNI() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PNI pNI = 14;
getPNI() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PNI pNI = 14;
getPNIBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PNI pNI = 14;
getPNIOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PNI pNI = 14;
getPNIOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PNI pNI = 14;
getPNIOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PNI pNI = 14;
getPoint(int) - Method in class graph.DataSet
get the data point at the parsed index.
getPoint(int) - Method in class jplot.DataArray
Returns the plot-point of the specified index.
getPoint(int) - Method in class jplot.DataArray2D
Returns the plot-point of the specified index.
getPoint(int) - Method in class jplot.DataArray3D
Returns the plot-point of the specified index.
getPoint() - Method in class jplot.PlotPoint
returns x- and y values.
getPoint() - Method in class jplot.PlotPoint2D
returns x- and y and z values.
getPoint() - Method in class jplot.PlotPoint3D
returns x- and y and z values.
getPoint() - Method in class jplot3d.JPoint
returns x- and y and z values.
getPoint(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegrator
Gets the integration point at the given index.
getPoint() - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresProblem.Evaluation
Get the abscissa (independent variables) of this evaluation.
getPoint() - Method in interface org.apache.commons.math3.ml.clustering.Clusterable
Gets the n-dimensional point.
getPoint() - Method in class org.apache.commons.math3.ml.clustering.DoublePoint
Gets the n-dimensional point.
getPoint(int) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get the simplex point stored at the requested index.
getPoint() - Method in class org.apache.commons.math3.optim.PointValuePair
Gets the point.
getPoint() - Method in class org.apache.commons.math3.optim.PointVectorValuePair
Gets the point.
getPoint() - Method in class org.apache.commons.math3.optim.univariate.UnivariatePointValuePair
Get the point.
getPoint(int) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated.
Get the simplex point stored at the requested index.
getPoint() - Method in class org.apache.commons.math3.optimization.PointValuePair
Deprecated.
Gets the point.
getPoint() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated.
Gets the point.
getPoint() - Method in class org.apache.commons.math3.optimization.univariate.UnivariatePointValuePair
Deprecated.
Get the point.
getPoint() - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
Deprecated.
Get the n-dimensional point in integer space.
getPoint() - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
Deprecated.
Get the n-dimensional point in integer space.
getPoint() - Method in class org.jfree.chart.renderer.Outlier
Returns the xy coordinates of the bounding box containing the outlier ellipse.
getPoint(double) - Method in class org.jlab.groot.math.Dimension1D
 
getPoint(double, double, Dimension2D) - Method in class org.jlab.groot.math.Dimension2D
 
getPoint(float, float) - Method in class org.jlab.groot.ui.GraphicsAxisFrame
 
getPointAt(Vector2D, double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get one point from the 3D-space.
getPointAt(Vector1D, double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get one point from the plane.
getPointAt(double) - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Get a circle point from its phase around the circle.
getPointAt(double) - Method in class org.apache.commons.math3.geometry.spherical.twod.Edge
Get an intermediate point.
getPointerForDataset(int) - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the dial pointer that is associated with the specified dataset, or null.
getPointerIndex(DialPointer) - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the index for the specified pointer.
getPointFrequency() - Method in class jplot.LinePars
Returns the frequency used to draw points in terms of an 'every' parameter.
getPointIndex() - Method in class jplot.GraphSettings
Returns the index of the next point type of the vector of predefined point types.
getPointRef() - Method in class org.apache.commons.math3.optim.PointValuePair
Gets a reference to the point.
getPointRef() - Method in class org.apache.commons.math3.optim.PointVectorValuePair
Gets a reference to the point.
getPointRef() - Method in class org.apache.commons.math3.optimization.PointValuePair
Deprecated.
Gets a reference to the point.
getPointRef() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated.
Gets a reference to the point.
getPoints() - Method in class jhplot.F1D
Get the number of points used for plotting, integration and differentiation.
getPoints() - Method in class jhplot.F2D
Get the number of points for evaluation of a function
getPoints() - Method in class jhplot.F3D
Get the number of points for evaluation of a function
getPoints() - Method in class jhplot.FND
Get the number of points
getPoints() - Method in class jhplot.FProxy
Get the number of points used for plotting, integration and differentiation.
getPoints() - Method in class jminhep.cluster.Partition
Get number of points accosiated with clusters
getPoints(DataArray) - Method in class jplot.GraphXY
 
getPoints() - Method in class org.apache.commons.math3.ml.clustering.Cluster
Get the points contained in the cluster.
getPoints() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get the points of the simplex.
getPoints() - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated.
Get the points of the simplex.
getPoints() - Method in class org.apache.commons.math3.stat.clustering.Cluster
Deprecated.
Get the points contained in the cluster.
getPointsX() - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
getPointsX() - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
getPointsY() - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
getPointsY() - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
getPointsZ() - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
getPointsZ() - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
getPointX(double) - Method in class org.jlab.groot.ui.GraphicsAxisFrame
 
getPointY(double) - Method in class org.jlab.groot.ui.GraphicsAxisFrame
 
getPole() - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Get the pole of the circle.
getPoly() - Method in class org.lsmp.djep.groupJep.groups.AlgebraicExtension
Returns the polynomial defining the algebraic number.
getPolygonColor(float) - Method in class jplot3d.ColorModel
 
getPolygonColor(int, float) - Method in class jplot3d.ColorModelSet
 
getPolygonColor(int, float) - Method in interface jplot3d.SurfaceColor
 
getPolygonCoordinates() - Method in class org.jfree.chart.annotations.XYPolygonAnnotation
Returns the coordinates of the polygon's vertices.
getPolynomialRegression(XYDataset, int, int) - Static method in class org.jfree.data.statistics.Regression
Returns the parameters 'a0', 'a1', 'a2', ..., 'an' for a polynomial function of order n, y = a0 + a1 * x + a2 * x^2 + ...
getPolynomials() - Method in class org.apache.commons.math3.analysis.interpolation.HermiteInterpolator
Compute the interpolation polynomials.
getPolynomials() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Get a copy of the interpolating polynomials array.
getPopulationLimit() - Method in class org.apache.commons.math3.genetics.ListPopulation
Access the maximum population size.
getPopulationLimit() - Method in interface org.apache.commons.math3.genetics.Population
Access the maximum population size.
getPopulationSize() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Access the population size.
getPopulationSize() - Method in class org.apache.commons.math3.genetics.ListPopulation
Access the current population size.
getPopulationSize() - Method in interface org.apache.commons.math3.genetics.Population
Access the current population size.
getPopulationSize() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer.PopulationSize
 
getPopulationSize() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer.PopulationSize
Deprecated.
 
getPopulationVariance() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the population variance of the available values.
getPopulationVariance() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the population variance of the values that have been added.
getPopulationVariance() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the population variance of the values that have been added.
getPopupMenu() - Method in class org.jfree.chart.ChartPanel
Returns the popup menu.
getPosition() - Method in interface hep.lcio.event.CalorimeterHit
Returns the position of the hit in world coordinates.
getPosition() - Method in interface hep.lcio.event.Cluster
Position of the cluster.
getPosition() - Method in interface hep.lcio.event.SimCalorimeterHit
Returns the position of the hit in world coordinates.
getPosition() - Method in interface hep.lcio.event.SimTrackerHit
Returns the hit position in [mm].
getPosition() - Method in interface hep.lcio.event.TrackerHit
The hit position in [mm].
getPosition() - Method in interface hep.lcio.event.Vertex
Position of the vertex
getPosition() - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
getPosition() - Method in class hep.lcio.implementation.event.ICluster
 
getPosition() - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
getPosition() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
getPosition() - Method in class hep.lcio.implementation.event.ITrackerHit
 
getPosition() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getPosition() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getPosition() - Method in class hep.lcio.implementation.event.IVertex
 
getPosition(ProMC.ProMCEvent.Particles, int, int) - Static method in class hephysics.hepsim.PromcUtil
For a given space/time unit, create a particle with postions X, Y,Z,Time.
getPosition() - Method in class hephysics.particle.HEParticle
Get position in X,Y,Z,time
getPosition() - Method in class jhplot.shapes.HShape
Get position of a primitive
getPosition() - Method in class jminhep.algorithms.FuzzyCMeansAlg
This method returns a measure of the progress of the algorithm.
getPosition() - Method in class org.apache.commons.io.input.NullInputStream
Return the current position.
getPosition() - Method in class org.apache.commons.io.input.NullReader
Returns the current position.
getPosition() - Method in class org.jfree.chart.title.Title
Returns the position of the title.
getPosition() - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the x position type (START, MIDDLE or END).
getPositionCoordinate() - Method in class jhplot.HKey
Is the position set?
getPositionCoordinate() - Method in class jhplot.HLabel
Is the position set?
getPositionCoordinate() - Method in class jhplot.HLabelEq
Is the position set?
getPositionCoordinate() - Method in class jhplot.HMLabel
Is the position set?
getPositionCoordinate() - Method in class jhplot.shapes.HShape
Is the position set?
getPositionError() - Method in interface hep.lcio.event.Cluster
Covariance matrix of the position (6 Parameters)
getPositionError() - Method in class hep.lcio.implementation.event.ICluster
 
getPositiveBarPaint() - Method in class org.jfree.chart.renderer.category.WaterfallBarRenderer
Returns the paint used to draw bars with positive values.
getPositiveInfinity() - Method in class org.lsmp.djep.xjep.TreeUtils
 
getPositiveItemLabelPosition(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the item label position for positive values.
getPositiveItemLabelPosition() - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.getSeriesPositiveItemLabelPosition(int) and AbstractRenderer.getBasePositiveItemLabelPosition().
getPositiveItemLabelPosition(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the item label position for positive values.
getPositiveItemLabelPosition() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.getSeriesPositiveItemLabelPosition(int) and CategoryItemRenderer.getBasePositiveItemLabelPosition().
getPositiveItemLabelPosition(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the item label position for positive values.
getPositiveItemLabelPosition() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.getSeriesPositiveItemLabelPosition(int) and XYItemRenderer.getBasePositiveItemLabelPosition().
getPositiveItemLabelPositionFallback() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the fallback position for positive item labels that don't fit within a bar.
getPositiveItemLabelPositionFallback() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the fallback position for positive item labels that don't fit within a bar.
getPositivePaint() - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Returns the paint used to highlight positive differences.
getPositivePolarForm() - Method in class org.apache.commons.math3.complex.Quaternion
Returns the polar form of the quaternion.
getPositivePrefix() - Method in class org.jfree.chart.util.RelativeDateFormat
Returns the string that is prepended to the format if the relative time is positive.
getPower() - Method in class org.nfunk.jep.OperatorSet
 
getPowerN(double[], int) - Static method in class jhplot.math.ArrayMathUtils
Sums all components then puts to power n.
getPowerRegression(double[][]) - Static method in class org.jfree.data.statistics.Regression
Returns the parameters 'a' and 'b' for an equation y = ax^b, fitted to the data using a power regression equation.
getPowerRegression(XYDataset, int) - Static method in class org.jfree.data.statistics.Regression
Returns the parameters 'a' and 'b' for an equation y = ax^b, fitted to the data using a power regression equation.
getPrecedence() - Method in class jhplot.math.exp4j.operator.Operator
Check the precedence value for the operator
getPrecedence() - Method in class org.lsmp.djep.xjep.XOperator
 
getPrecision() - Method in class org.jfree.chart.renderer.xy.XYSplineRenderer
Returns the number of line segments used to approximate the spline curve between data points.
getPrediction() - Method in class jhplot.stat.LinReg
Get prediction lines
getPrediction(Color) - Method in class jhplot.stat.LinReg
Get prediction lines
getPredictionBand() - Method in class jhplot.stat.LinReg
Calculate the prediction band in form of P1D with errors.
getPredictionBand(Color) - Method in class jhplot.stat.LinReg
Calculate the prediction band in form of P1D with errors.
getPredictionBand(Color, double) - Method in class jhplot.stat.LinReg
Calculate the prediction band in form of P1D with errors.
getPredictionBand(int, Color, double) - Method in class jhplot.stat.LinReg
Calculate the prediction band in form of P1D with errors.
getPreferredSize() - Method in class jplot.GraphGeneral
Get the preferred size of this component.
getPreferredSize() - Method in class jplot.LineStyle
 
getPreferredSize() - Method in class jplot.panels.ColorPreview
 
getPreferredSize() - Method in class jplot.SimpleEditor
 
getPreferredSize() - Method in class jplot.SmallColorPreview
 
getPreferredSize() - Method in class jplot3d.JSurface
Returns the preferred size of this object.
getPreferredSize(JComponent) - Method in class net.java.dev.colorchooser.ColorChooserUI
 
getPreferredSize() - Method in class org.jfree.chart.editor.PaletteSample
Deprecated.
Returns the preferred size of the component.
getPrefix(String) - Static method in class org.apache.commons.io.FilenameUtils
Gets the prefix from a full fileName, such as C:/ or ~/.
getPrefix() - Method in class org.apache.commons.math3.geometry.VectorFormat
Get the format prefix.
getPrefix() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format prefix.
getPrefix() - Method in class org.apache.commons.math3.linear.RealVectorFormat
Get the format prefix.
getPrefix() - Method in class org.jfree.chart.urls.TimeSeriesURLGenerator
Returns the prefix string.
getPrefixLength(String) - Static method in class org.apache.commons.io.FilenameUtils
Returns the length of the fileName prefix, such as C:/ or ~/.
getPrevious() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
 
getPrevious() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
Deprecated.
Get the node containing the next smaller or equal element.
getPreviousState() - Method in class org.apache.commons.math3.ode.sampling.AbstractFieldStepInterpolator
Get the state at previous grid point time.
getPreviousState() - Method in interface org.apache.commons.math3.ode.sampling.FieldStepInterpolator
Get the state at previous grid point time.
getPreviousTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the previous soft grid point time.
getPreviousTime() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the previous grid point time.
getPrimary() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get the primary set of differential equations.
getPrimaryMapper() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get an equations mapper for the primary equations set.
getPrimaryState() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get primary part of the current state.
getPrimaryStateDot() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get primary part of the current state derivative.
getPrimitives() - Method in class jplot.GraphSettings
Returns a vector with the graph primitives.
getPrintVisitor() - Method in class org.lsmp.djep.xjep.XJep
Returns the PrintVisitor, used for printing equations.
getProbability() - Method in interface hep.lcio.event.Vertex
Probability of the vertex fit.
getProbability() - Method in class hep.lcio.implementation.event.IVertex
 
getProbability() - Method in class jhplot.H1D
Return q probability distribution derived from a histogram.
getProbability() - Method in class jhplot.H2D
Return q probability distribution derived from a histogram.
getProbabilityCH() - Method in class jhplot.stat.limit.StatConfidence
get probability (Cousins+Highland) for the given limit.
getProbabilityJ() - Method in class jhplot.stat.limit.StatConfidence
Probability (Jeffreys) for the given limit.
getProbabilityOfSuccess() - Method in class jhplot.math.num.pdf.Binomial
Access probability of success.
getProbabilityOfSuccess() - Method in class jhplot.math.num.pdf.Geometric
Access probability of success.
getProbabilityOfSuccess() - Method in class jhplot.math.num.pdf.NegativeBinomial
Access probability of success.
getProbabilityOfSuccess() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Access the probability of success for this distribution.
getProbabilityOfSuccess() - Method in class org.apache.commons.math3.distribution.GeometricDistribution
Access the probability of success for this distribution.
getProbabilityOfSuccess() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Access the probability of success for this distribution.
getProbabilitySWG() - Method in class jhplot.stat.limit.StatConfidence
Get probability (BaBar SWG) for the given limit.
getProcess_noise_cov() - Method in class jhplot.math.kalman.JKalman
Getter
getProcessData(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessData(int) - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessData(int) - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessData(int) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessData(int) - Method in class promc.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessData(int) - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessData(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessData(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessData(int) - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessData(int) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessData(int) - Method in class proreco.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessData(int) - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataBuilder(int) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataBuilder(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataBuilder(int) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataBuilderList() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataBuilderList() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataBuilderList() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataBuilderList() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in class promc.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in class pronlo.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in class proreco.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataCount() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in class promc.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in class pronlo.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in class proreco.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataList() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in class promc.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in class proreco.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilder(int) - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in class proeic.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in class promc.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in class pronlo.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in class proreco.io.ProMCStatFile.ProMCStat
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessDataOrBuilderList() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
repeated .promc.ProMCStat.ProcessData processData = 10;
getProcessID() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
getProcessID() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional int32 Process_ID = 2;
getProcessID() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Process_ID = 2;
getProcessID() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
getProcessID() - Method in class promc.io.ProMC.ProMCEvent.Event
optional int32 Process_ID = 2;
getProcessID() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Process_ID = 2;
getProcessID() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
getProcessID() - Method in class pronlo.io.ProMC.ProMCEvent.Event
optional int32 Process_ID = 2;
getProcessID() - Method in interface pronlo.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Process_ID = 2;
getProcessID(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ProcessID = 2 [packed = true];
getProcessID(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 ProcessID = 2 [packed = true];
getProcessID(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 ProcessID = 2 [packed = true];
getProcessIDCount() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ProcessID = 2 [packed = true];
getProcessIDCount() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 ProcessID = 2 [packed = true];
getProcessIDCount() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 ProcessID = 2 [packed = true];
getProcessIDList() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ProcessID = 2 [packed = true];
getProcessIDList() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated int32 ProcessID = 2 [packed = true];
getProcessIDList() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated int32 ProcessID = 2 [packed = true];
getProcessNoise() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
Returns the process noise matrix.
getProcessNoise() - Method in interface org.apache.commons.math3.filter.ProcessModel
Returns the process noise matrix.
getProcessVisibleItemsOnly() - Method in class org.jfree.chart.renderer.xy.XYItemRendererState
Returns the flag that controls whether the plot passes all data items in each series to the renderer, or just the visible items.
getProductionTime() - Method in class hep.physics.particle.BasicParticle
 
getProductionTime() - Method in interface hep.physics.particle.Particle
Production time
getProfileX() - Method in class org.jlab.groot.data.H2F
 
getProfileY() - Method in class org.jlab.groot.data.H2F
 
getProjected() - Method in class org.apache.commons.math3.geometry.partitioning.BoundaryProjection
Projected point.
getProjector() - Method in class jplot3d.JSurface
Get projector
getProjector() - Method in interface jplot3d.SurfaceModel
 
getProjector() - Method in class jplot3d.SurfaceModelCanvas
 
getProjector() - Method in class jplot3d.SurfaceVertex
 
getPrompt() - Method in class org.lsmp.djepExamples.Console
Prints the prompt string.
getPrompt() - Method in class org.lsmp.djepExamples.DJepConsole
 
getPrompt() - Method in class org.lsmp.djepExamples.GroupConsole
 
getPrompt() - Method in class org.lsmp.djepExamples.MatrixConsole
 
getPrompt() - Method in class org.lsmp.djepExamples.SJepConsole
 
getPrompt() - Method in class org.lsmp.djepExamples.VectorConsole
 
getPrompt() - Method in class org.lsmp.djepExamples.XJepConsole
 
getProperInstance() - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
Returns the default complex format for the current locale.
getProperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
Returns the default complex format for the given locale.
getProperInstance() - Static method in class org.apache.commons.math3.fraction.FractionFormat
Returns the default complex format for the current locale.
getProperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.FractionFormat
Returns the default complex format for the given locale.
getProperties() - Method in class Jampack.Zdiagmat
Sets the public parameters.
getProperties() - Method in class Jampack.Zmat
Sets the public parameters.
getProperty(String) - Static method in class jhepsim.Options
Elementary property function.
getPropertyDescriptors() - Method in class net.java.dev.colorchooser.ColorChooserBeanInfo
Gets the bean's PropertyDescriptors.
getPropertyName() - Method in enum jplot3d.SurfaceModel.PlotColor
 
getPropertyName() - Method in enum jplot3d.SurfaceModel.PlotType
 
getPt() - Method in class hephysics.jet.ParticleD
Get cached Pt.
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 PT = 19 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint64 PT = 19 [packed = true];
getPT(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 PT = 19 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated uint64 PT = 1 [packed = true];
getPT(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated uint64 PT = 1 [packed = true];
getPt2() - Method in class hephysics.jet.ParticleD
Get cached perp**2.
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 PT = 19 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint64 PT = 19 [packed = true];
getPTCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 PT = 19 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated uint64 PT = 1 [packed = true];
getPTCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTileThreshold(double) - Method in class jhplot.utils.SHisto
Calculates the p-tile threshold.
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in interface proreco.io.ProMC.ProMCEvent.ElectronsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Muons
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in interface proreco.io.ProMC.ProMCEvent.MuonsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 PT = 19 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint64 PT = 19 [packed = true];
getPTList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 PT = 19 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Photons
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in interface proreco.io.ProMC.ProMCEvent.PhotonsOrBuilder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated uint64 PT = 1 [packed = true];
getPTList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated uint64 PT = 1 [packed = true];
getPtSizePct() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the ptSizePct.
getPX() - Method in class hep.physics.particle.BasicParticle
 
getPX() - Method in interface hep.physics.particle.Particle
X component of momentum
getPx(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Px = 5 [packed = true];
getPx(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Px = 5 [packed = true];
getPx(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Px = 5 [packed = true];
getPx(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
getPx(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 Px = 5 [packed = true];
getPx(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Px = 5 [packed = true];
getPx(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 4 [packed = true];
getPx(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Px = 4 [packed = true];
getPx(int) - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Px = 4 [packed = true];
getPx(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
getPx(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Px = 5 [packed = true];
getPx(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Px = 5 [packed = true];
getPxCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Px = 5 [packed = true];
getPxCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Px = 5 [packed = true];
getPxCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Px = 5 [packed = true];
getPxCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
getPxCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 Px = 5 [packed = true];
getPxCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Px = 5 [packed = true];
getPxCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 4 [packed = true];
getPxCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Px = 4 [packed = true];
getPxCount() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Px = 4 [packed = true];
getPxCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
getPxCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Px = 5 [packed = true];
getPxCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Px = 5 [packed = true];
getPxList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Px = 5 [packed = true];
getPxList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Px = 5 [packed = true];
getPxList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Px = 5 [packed = true];
getPxList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
getPxList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 Px = 5 [packed = true];
getPxList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Px = 5 [packed = true];
getPxList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 4 [packed = true];
getPxList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Px = 4 [packed = true];
getPxList() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Px = 4 [packed = true];
getPxList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
getPxList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Px = 5 [packed = true];
getPxList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Px = 5 [packed = true];
getPXY() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXY pXY = 4;
getPXY() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PXY pXY = 4;
getPXY() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PXY pXY = 4;
getPXYBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXY pXY = 4;
getPXYOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXY pXY = 4;
getPXYOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PXY pXY = 4;
getPXYOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PXY pXY = 4;
getPXYZ() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXYZ pXYZ = 5;
getPXYZ() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PXYZ pXYZ = 5;
getPXYZ() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PXYZ pXYZ = 5;
getPXYZBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXYZ pXYZ = 5;
getPXYZOrBuilder() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXYZ pXYZ = 5;
getPXYZOrBuilder() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PXYZ pXYZ = 5;
getPXYZOrBuilder() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PXYZ pXYZ = 5;
getPY() - Method in class hep.physics.particle.BasicParticle
 
getPY() - Method in interface hep.physics.particle.Particle
Y component of momentum
getPy(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Py = 6 [packed = true];
getPy(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Py = 6 [packed = true];
getPy(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Py = 6 [packed = true];
getPy(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
getPy(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 Py = 6 [packed = true];
getPy(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Py = 6 [packed = true];
getPy(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 5 [packed = true];
getPy(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Py = 5 [packed = true];
getPy(int) - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Py = 5 [packed = true];
getPy(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
getPy(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Py = 6 [packed = true];
getPy(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Py = 6 [packed = true];
getPyCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Py = 6 [packed = true];
getPyCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Py = 6 [packed = true];
getPyCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Py = 6 [packed = true];
getPyCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
getPyCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 Py = 6 [packed = true];
getPyCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Py = 6 [packed = true];
getPyCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 5 [packed = true];
getPyCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Py = 5 [packed = true];
getPyCount() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Py = 5 [packed = true];
getPyCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
getPyCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Py = 6 [packed = true];
getPyCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Py = 6 [packed = true];
getPyList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Py = 6 [packed = true];
getPyList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Py = 6 [packed = true];
getPyList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Py = 6 [packed = true];
getPyList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
getPyList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 Py = 6 [packed = true];
getPyList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Py = 6 [packed = true];
getPyList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 5 [packed = true];
getPyList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Py = 5 [packed = true];
getPyList() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Py = 5 [packed = true];
getPyList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
getPyList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Py = 6 [packed = true];
getPyList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Py = 6 [packed = true];
getPZ() - Method in class hep.physics.particle.BasicParticle
 
getPZ() - Method in interface hep.physics.particle.Particle
Z component of momentum
getPz(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Pz = 7 [packed = true];
getPz(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Pz = 7 [packed = true];
getPz(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Pz = 7 [packed = true];
getPz(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
getPz(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 Pz = 7 [packed = true];
getPz(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Pz = 7 [packed = true];
getPz(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 6 [packed = true];
getPz(int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Pz = 6 [packed = true];
getPz(int) - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Pz = 6 [packed = true];
getPz(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
getPz(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Pz = 7 [packed = true];
getPz(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Pz = 7 [packed = true];
getPzCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Pz = 7 [packed = true];
getPzCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Pz = 7 [packed = true];
getPzCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Pz = 7 [packed = true];
getPzCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
getPzCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 Pz = 7 [packed = true];
getPzCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Pz = 7 [packed = true];
getPzCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 6 [packed = true];
getPzCount() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Pz = 6 [packed = true];
getPzCount() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Pz = 6 [packed = true];
getPzCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
getPzCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Pz = 7 [packed = true];
getPzCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Pz = 7 [packed = true];
getPzList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Pz = 7 [packed = true];
getPzList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Pz = 7 [packed = true];
getPzList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Pz = 7 [packed = true];
getPzList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
getPzList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint64 Pz = 7 [packed = true];
getPzList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Pz = 7 [packed = true];
getPzList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 6 [packed = true];
getPzList() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
repeated sint64 Pz = 6 [packed = true];
getPzList() - Method in interface pronlo.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Pz = 6 [packed = true];
getPzList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
getPzList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint64 Pz = 7 [packed = true];
getPzList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint64 Pz = 7 [packed = true];
getQ() - Method in class cern.colt.matrix.linalg.QRDecomposition
Generates and returns the (economy-sized) orthogonal factor Q.
getQ() - Method in class Jama.QRDecomposition
Generate and return the (economy-sized) orthogonal factor
getQ() - Method in class jhplot.math.kalman.jama.QRDecomposition
Generate and return the (economy-sized) orthogonal factor
getQ() - Method in class jhplot.math.QRDecomposition
Generate and return the (economy-sized) orthogonal factor
getQ() - Method in class org.apache.commons.math3.linear.QRDecomposition
Returns the matrix Q of the decomposition.
getQ0() - Method in class org.apache.commons.math3.complex.Quaternion
Gets the first component of the quaternion (scalar part).
getQ0() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the scalar coordinate of the quaternion.
getQ0() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the scalar coordinate of the quaternion.
getQ1() - Method in class org.apache.commons.math3.complex.Quaternion
Gets the second component of the quaternion (first component of the vector part).
getQ1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the first coordinate of the vectorial part of the quaternion.
getQ1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the first coordinate of the vectorial part of the quaternion.
getQ1() - Method in class org.jfree.data.statistics.BoxAndWhiskerItem
Returns the first quartile.
getQ1Value(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the q1median value for an item.
getQ1Value(Comparable, Comparable) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the q1median value for an item.
getQ1Value(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerXYDataset
Returns the Q1 median-value for the specified series and item.
getQ1Value(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the first quartile value.
getQ1Value(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the first quartile value.
getQ1Value(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the Q1 median-value for the specified series and item.
getQ2() - Method in class org.apache.commons.math3.complex.Quaternion
Gets the third component of the quaternion (second component of the vector part).
getQ2() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the second coordinate of the vectorial part of the quaternion.
getQ2() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the second coordinate of the vectorial part of the quaternion.
getQ2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Q2 = 16;
getQ2() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float Q2 = 16;
getQ2() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float Q2 = 16;
getQ3() - Method in class org.apache.commons.math3.complex.Quaternion
Gets the fourth component of the quaternion (third component of the vector part).
getQ3() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the third coordinate of the vectorial part of the quaternion.
getQ3() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the third coordinate of the vectorial part of the quaternion.
getQ3() - Method in class org.jfree.data.statistics.BoxAndWhiskerItem
Returns the third quartile.
getQ3Value(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the q3median value for an item.
getQ3Value(Comparable, Comparable) - Method in interface org.jfree.data.statistics.BoxAndWhiskerCategoryDataset
Returns the q3median value for an item.
getQ3Value(int, int) - Method in interface org.jfree.data.statistics.BoxAndWhiskerXYDataset
Returns the Q3 median-value for the specified series and item.
getQ3Value(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the third quartile value.
getQ3Value(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the third quartile value.
getQ3Value(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the Q3 median-value for the specified series and item.
getQT() - Method in class org.apache.commons.math3.linear.QRDecomposition
Returns the transpose of the matrix Q of the decomposition.
getQuadrantOrigin() - Method in class org.jfree.chart.plot.XYPlot
Returns the origin for the quadrants that can be displayed on the plot.
getQuadrantPaint(int) - Method in class org.jfree.chart.plot.XYPlot
Returns the paint used for the specified quadrant.
getQuadraticMean() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the quadratic mean, a.k.a.
getQuadraticMean() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the quadratic mean, a.k.a.
getQuadraticMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the quadratic mean, a.k.a.
getQuadraticMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the quadratic mean, a.k.a.
getQuality() - Method in interface hep.lcio.event.SimTrackerHit
The quality bit flag of the hit
getQuality() - Method in interface hep.lcio.event.TPCHit
Deprecated.
Returns a quality flag for the hit.
getQuality() - Method in interface hep.lcio.event.TrackerHit
The quality bit flag of the hit
getQuality() - Method in interface hep.lcio.event.TrackerPulse
The quality bit flag of the pulse - check/set collection parameters TrackerPulseQualityNames and TrackerPulseQualityNamesValues.
getQuality() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
getQuality() - Method in class hep.lcio.implementation.event.ITPCHit
 
getQuality() - Method in class hep.lcio.implementation.event.ITrackerHit
 
getQuality() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getQuality() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getQuality() - Method in class hep.lcio.implementation.event.ITrackerPulse
 
getQuality() - Method in interface org.jfree.chart.encoders.ImageEncoder
Get the quality of the image encoding.
getQuality() - Method in class org.jfree.chart.encoders.KeypointPNGEncoderAdapter
Get the quality of the image encoding.
getQuality() - Method in class org.jfree.chart.encoders.SunJPEGEncoderAdapter
Returns the quality of the image encoding, which is a number in the range 0.0f to 1.0f (higher values give better quality output, but larger file sizes).
getQuality() - Method in class org.jfree.chart.encoders.SunPNGEncoderAdapter
Get the quality of the image encoding (always 0.0).
getQuantile() - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns the value of the quantile field (determines what percentile is computed when evaluate() is called with no quantile argument).
getQuarter() - Method in class org.jfree.data.time.Quarter
Returns the quarter.
getQuick(int, int) - Method in class cern.colt.bitvector.BitMatrix
Returns from the receiver the value of the bit at the specified coordinate; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.bitvector.BitVector
Returns from the bitvector the value of the bit with the specified index; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.BooleanArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.ByteArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.CharArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.DistinctNumberList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.DoubleArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.FloatArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.IntArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.LongArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.MinMaxNumberList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.ObjectArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.ShortArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.DoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int, int) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int) - Method in class cern.colt.matrix.ObjectMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.ObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuickX(int) - Method in class jhplot.P1D
Return a specific X-value quickly (no bound check).
getQuickY(int) - Method in class jhplot.P1D
Return a specific Y-value quickly (no bound check).
getR() - Method in class cern.colt.matrix.linalg.QRDecomposition
Returns the upper triangular factor, R.
getR() - Method in class Jama.QRDecomposition
Return the upper triangular factor
getR() - Method in class jhplot.math.kalman.jama.QRDecomposition
Return the upper triangular factor
getR() - Method in class jhplot.math.QRDecomposition
Return the upper triangular factor
getR() - Method in class org.apache.commons.math3.geometry.euclidean.threed.SphericalCoordinates
Get the radius.
getR() - Method in class org.apache.commons.math3.linear.QRDecomposition
Returns the matrix R of the decomposition.
getR() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
getRadius() - Method in class jhplot.shapes.Circle
Get the radius
getRadius() - Method in class org.apache.commons.math3.geometry.enclosing.EnclosingBall
Get the radius of the ball.
getRadius() - Method in class org.jfree.chart.plot.dial.DialCap
Returns the radius of the cap, as a percentage of the dial's framing rectangle.
getRadius() - Method in class org.jfree.chart.plot.dial.DialPointer
Returns the radius of the pointer, as a percentage of the dial's framing rectangle.
getRadius() - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Returns the radius used to calculate the anchor point.
getRadius() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the radius.
getRadius() - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Returns the radius, relative to the framing rectangle.
getRadius() - Method in class org.jfree.chart.renderer.Outlier
Returns the radius of the outlier ellipse.
getRadiusGridlinePaint() - Method in class org.jfree.chart.plot.PolarPlot
Returns the paint for the grid lines (if any) plotted against the radius axis.
getRadiusGridlineStroke() - Method in class org.jfree.chart.plot.PolarPlot
Returns the stroke for the grid lines (if any) plotted against the radius axis.
getRadiusOfInnermostHit() - Method in interface hep.lcio.event.Track
The radius of the innermost hit that has been used in the track fit.
getRadiusOfInnermostHit() - Method in class hep.lcio.implementation.event.ITrack
 
getRadiusX() - Method in class jhplot.shapes.Ellipse
Get the radius in X.
getRadiusY() - Method in class jhplot.shapes.Ellipse
Get the radius in Y.
getRadixDigits() - Method in class org.apache.commons.math3.dfp.Dfp
Get the number of radix digits of the instance.
getRadixDigits() - Method in class org.apache.commons.math3.dfp.DfpField
Get the number of radix digits of the Dfp instances built by this factory.
getRandMinMax(double, double) - Static method in class org.jlab.groot.math.FunctionFactory
 
getRandom() - Method in class org.jlab.groot.math.UserParameter
 
getRandomAccessFile() - Method in class org.apache.commons.io.input.RandomAccessFileInputStream
Gets the underlying file.
getRandomGenerator() - Method in class cern.jet.random.sampling.RandomSamplingAssistant
Returns the used random generator.
getRandomGenerator() - Static method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the (static) random generator.
getRandomGenerator() - Method in class org.apache.commons.math3.ml.clustering.FuzzyKMeansClusterer
Returns the random generator this instance will use.
getRandomGenerator() - Method in class org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer
Returns the random generator this instance will use.
getRandomGenerator() - Method in class org.apache.commons.math3.random.RandomDataGenerator
Returns the RandomGenerator used to generate non-secure random data.
getRange() - Method in class graph.Contour
Return the range of the grid
getRange() - Method in class jplot.Contour
Return the range of the grid
getRange() - Method in class org.jfree.chart.axis.ValueAxis
Returns the range for the axis.
getRange() - Method in class org.jfree.chart.plot.MeterInterval
Returns the range.
getRange() - Method in class org.jfree.chart.plot.MeterPlot
Returns the overall range for the dial.
getRange() - Method in class org.jlab.groot.base.AxisAttributes
 
getRange(double) - Method in class org.jlab.groot.base.ColorPalette
 
getRange() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getRange() - Method in class org.jlab.groot.math.Func1D
 
getRange() - Method in class org.jlab.groot.ui.GraphicsAxis
 
getRangeAxis() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the range axis for the plot.
getRangeAxis(int) - Method in class org.jfree.chart.plot.CategoryPlot
Returns a range axis.
getRangeAxis() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the range axis for the plot.
getRangeAxis() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns the range axis for the plot.
getRangeAxis() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the range axis.
getRangeAxis() - Method in class org.jfree.chart.plot.XYPlot
Returns the range axis for the plot.
getRangeAxis(int) - Method in class org.jfree.chart.plot.XYPlot
Returns the range axis with the specified index, or null if there is no axis with that index.
getRangeAxisCount() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the number of range axes.
getRangeAxisCount() - Method in class org.jfree.chart.plot.XYPlot
Returns the number of range axes.
getRangeAxisEdge() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the edge where the primary range axis is located.
getRangeAxisEdge(int) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the edge for a range axis.
getRangeAxisEdge() - Method in class org.jfree.chart.plot.XYPlot
Returns the edge for the primary range axis.
getRangeAxisEdge(int) - Method in class org.jfree.chart.plot.XYPlot
Returns the edge for a range axis.
getRangeAxisForDataset(int) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the range axis for a dataset.
getRangeAxisForDataset(int) - Method in class org.jfree.chart.plot.XYPlot
Returns the range axis for a dataset.
getRangeAxisIndex(ValueAxis) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the index of the specified axis, or -1 if the axis is not assigned to the plot.
getRangeAxisIndex() - Method in class org.jfree.chart.plot.CrosshairState
Deprecated.
As of version 1.0.11, the domain axis should be determined using the dataset index.
getRangeAxisIndex(ValueAxis) - Method in class org.jfree.chart.plot.XYPlot
Returns the index of the given range axis.
getRangeAxisLocation() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the range axis location.
getRangeAxisLocation(int) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the location for a range axis.
getRangeAxisLocation() - Method in class org.jfree.chart.plot.XYPlot
Returns the location of the primary range axis.
getRangeAxisLocation(int) - Method in class org.jfree.chart.plot.XYPlot
Returns the location for a range axis.
getRangeBase() - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Returns the value on the range axis which defines the 'lower' border of the area.
getRangeBounds(List, boolean) - Method in interface org.jfree.data.category.CategoryRangeInfo
Returns the range of the values in this dataset's range.
getRangeBounds(boolean) - Method in class org.jfree.data.jdbc.JDBCXYDataset
Returns the range of the values in this dataset's range.
getRangeBounds(boolean) - Method in interface org.jfree.data.RangeInfo
Returns the range of the values in this dataset's range.
getRangeBounds(boolean) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the range of the values in this dataset's range.
getRangeBounds(boolean) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the range of the values in this dataset's range.
getRangeBounds(boolean) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns the range of the values in this dataset's range.
getRangeBounds(boolean) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the bounds of the values in this dataset's y-values.
getRangeBounds(boolean) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the value range.
getRangeBounds(boolean) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the bounds for the y-values in the dataset.
getRangeBounds(List, Range, boolean) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the bounds for the y-values in the dataset.
getRangeBounds(List, Range, boolean) - Method in interface org.jfree.data.xy.XYRangeInfo
Returns the range of the values in this dataset's range.
getRangeBounds(boolean) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the range of the values in this dataset's range.
getRangeCopy(double[], int, int) - Static method in class jhplot.math.DoubleArray
Extract a section of an array.
getRangeCopy(int[], int, int) - Static method in class jhplot.math.IntegerArray
 
getRangeCrosshairPaint() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the paint used to draw the range crosshair.
getRangeCrosshairPaint() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the range crosshair color.
getRangeCrosshairPaint() - Method in class org.jfree.chart.plot.XYPlot
Returns the range crosshair paint.
getRangeCrosshairs() - Method in class org.jfree.chart.panel.CrosshairOverlay
Returns a new list containing the range crosshairs for this overlay.
getRangeCrosshairStroke() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the pen-style (Stroke) used to draw the crosshair (if visible).
getRangeCrosshairStroke() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the Stroke used to draw the crosshair (if visible).
getRangeCrosshairStroke() - Method in class org.jfree.chart.plot.XYPlot
Returns the stroke used to draw the crosshair (if visible).
getRangeCrosshairValue() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the range crosshair value.
getRangeCrosshairValue() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the range crosshair value.
getRangeCrosshairValue() - Method in class org.jfree.chart.plot.XYPlot
Returns the range crosshair value.
getRangeDescription() - Method in class org.jfree.data.time.TimePeriodValues
Returns the range description.
getRangeDescription() - Method in class org.jfree.data.time.TimeSeries
Returns the range description.
getRangeGridlinePaint() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the paint used to draw the grid-lines against the range axis.
getRangeGridlinePaint() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns the paint for the grid lines (if any) plotted against the range axis.
getRangeGridlinePaint() - Method in class org.jfree.chart.plot.XYPlot
Returns the paint for the grid lines (if any) plotted against the range axis.
getRangeGridlinePaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the range grid line paint.
getRangeGridlineStroke() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the stroke used to draw the grid-lines against the range axis.
getRangeGridlineStroke() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns the stroke for the grid lines (if any) plotted against the range axis.
getRangeGridlineStroke() - Method in class org.jfree.chart.plot.XYPlot
Returns the stroke for the grid lines (if any) plotted against the range axis.
getRangeLowerBound(boolean) - Method in class org.jfree.data.jdbc.JDBCXYDataset
Returns the minimum y-value in the dataset.
getRangeLowerBound(boolean) - Method in interface org.jfree.data.RangeInfo
Returns the minimum y-value in the dataset.
getRangeLowerBound(boolean) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the minimum y-value in the dataset.
getRangeLowerBound(boolean) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the minimum y-value in the dataset.
getRangeLowerBound(boolean) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns the minimum y-value in the dataset.
getRangeLowerBound(boolean) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the minimum y-value in the dataset.
getRangeLowerBound(boolean) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the minimum range value.
getRangeLowerBound(boolean) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the minimum y-value in the dataset.
getRangeMarkers(Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the list of range markers (read only) for the specified layer.
getRangeMarkers(int, Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Returns a collection of range markers for a particular renderer and layer.
getRangeMarkers(Layer) - Method in class org.jfree.chart.plot.XYPlot
Returns the list of range markers (read only) for the specified layer.
getRangeMarkers(int, Layer) - Method in class org.jfree.chart.plot.XYPlot
Returns a collection of range markers for a particular renderer and layer.
getRangeMinorGridlinePaint() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the paint for the minor grid lines (if any) plotted against the range axis.
getRangeMinorGridlinePaint() - Method in class org.jfree.chart.plot.XYPlot
Returns the paint for the minor grid lines (if any) plotted against the range axis.
getRangeMinorGridlineStroke() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the stroke for the minor grid lines (if any) plotted against the range axis.
getRangeMinorGridlineStroke() - Method in class org.jfree.chart.plot.XYPlot
Returns the stroke for the minor grid lines (if any) plotted against the range axis.
getRanges() - Method in class jplot3d.JSurface
Gets the current x, y, and z ranges.
getRangeTickBandPaint() - Method in class org.jfree.chart.plot.XYPlot
Returns the paint used for the range tick bands.
getRangeType() - Method in class org.jfree.chart.axis.NumberAxis
Returns the axis range type.
getRangeUpperBound(boolean) - Method in class org.jfree.data.jdbc.JDBCXYDataset
Returns the maximum y-value in the dataset.
getRangeUpperBound(boolean) - Method in interface org.jfree.data.RangeInfo
Returns the maximum y-value in the dataset.
getRangeUpperBound(boolean) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the maximum y-value in the dataset.
getRangeUpperBound(boolean) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the maximum y-value in the dataset.
getRangeUpperBound(boolean) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns the maximum y-value in the dataset.
getRangeUpperBound(boolean) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the maximum y-value in the dataset.
getRangeUpperBound(boolean) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the maximum range value.
getRangeUpperBound(boolean) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the maximum y-value in the dataset.
getRangeZeroBaselinePaint() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the paint for the zero baseline (if any) plotted against the range axis.
getRangeZeroBaselinePaint() - Method in class org.jfree.chart.plot.XYPlot
Returns the paint for the zero baseline (if any) plotted against the range axis.
getRangeZeroBaselineStroke() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the stroke used for the zero baseline against the range axis.
getRangeZeroBaselineStroke() - Method in class org.jfree.chart.plot.XYPlot
Returns the stroke used for the zero baseline against the range axis.
getRank() - Method in class org.apache.commons.math3.linear.RectangularCholeskyDecomposition
Get the rank of the symmetric positive semidefinite matrix.
getRank(double) - Method in class org.apache.commons.math3.linear.RRQRDecomposition
Return the effective numerical matrix rank.
getRank() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Return the effective numerical matrix rank.
getRank() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Get the rank of the covariance matrix.
getRank() - Method in class org.jlab.groot.matrix.SparseIndex
 
getRankCorrelation() - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Returns a PearsonsCorrelation instance constructed from the ranked input data.
getRankingThreshold() - Method in class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
Gets the value of a tuning parameter.
getRapidity() - Method in class hephysics.jet.ParticleD
Get cached rapidity
getRatio() - Method in class org.apache.commons.math3.genetics.UniformCrossover
Returns the mixing ratio used by this CrossoverPolicy.
getRawDataWord(int) - Method in interface hep.lcio.event.TPCHit
Deprecated.
Return the raw data (32-bit) word at i.
getRawDataWord(int) - Method in class hep.lcio.implementation.event.ITPCHit
 
getRawHit() - Method in interface hep.lcio.event.CalorimeterHit
The RawCalorimeterHit.
getRawHit() - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
getRawHits() - Method in interface hep.lcio.event.TrackerHit
The raw data hits.
getRawHits() - Method in class hep.lcio.implementation.event.ITrackerHit
 
getRawHits() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getRawHits() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getRe() - Method in class Jampack.Zmat
Returns a copy of the real part of a Zmat.
getReader() - Method in class jhplot.io.FileRoot
Returns RootFileReader
getReal() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the real value of the number.
getReal() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Get the real value of the number.
getReal() - Method in class org.apache.commons.math3.complex.Complex
Access the real part.
getReal(int) - Method in class org.apache.commons.math3.complex.RootsOfUnity
Get the real part of the k-th n-th root of unity.
getReal() - Method in class org.apache.commons.math3.dfp.Dfp
Get the real value of the number.
getReal() - Method in interface org.apache.commons.math3.RealFieldElement
Get the real value of the number.
getReal() - Method in class org.apache.commons.math3.util.Decimal64
Get the real value of the number.
getRealEigenvalue(int) - Method in class org.apache.commons.math3.linear.EigenDecomposition
Returns the real part of the ith eigenvalue of the original matrix.
getRealEigenvalues() - Method in class cern.colt.matrix.linalg.EigenvalueDecomposition
Returns the real parts of the eigenvalues.
getRealEigenvalues() - Method in class Jama.EigenvalueDecomposition
Return the real parts of the eigenvalues
getRealEigenvalues() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets a copy of the real parts of the eigenvalues of the original matrix.
getRealFormat() - Method in class org.apache.commons.math3.complex.ComplexFormat
Access the realFormat.
getRecords() - Method in class jhplot.io.HDataBase
Returns the current number of records in the database.
getReducedFraction(int, int) - Static method in class org.apache.commons.math3.fraction.BigFraction
Creates a BigFraction instance with the 2 parts of a fraction Y/Z.
getReducedFraction(int, int) - Static method in class org.apache.commons.math3.fraction.Fraction
Creates a Fraction instance with the 2 parts of a fraction Y/Z.
getRef() - Method in class org.lsmp.djep.rpe.RpCommand
 
getReferencePoint() - Method in interface hep.lcio.event.ReconstructedParticle
Reference point of the reconstructedParticle parameters.
getReferencePoint() - Method in interface hep.lcio.event.Track
Reference point of the track parameters.
getReferencePoint() - Method in interface hep.lcio.event.TrackState
Reference point of the track parameters, e.g.
getReferencePoint() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getReferencePoint() - Method in class hep.lcio.implementation.event.ITrack
 
getReferencePoint() - Method in class hep.lcio.implementation.event.ITrackState
 
getRefreshBuffer() - Method in class org.jfree.chart.ChartPanel
Returns the flag that controls whether or not the offscreen buffer needs to be refreshed.
getRegion(String, int, int, int, int) - Method in class org.jlab.groot.data.H2F
Specifies the region in the 2D histogram with those attributes
getRegressionSumSquares() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the sum of squared deviations of the predicted y values about their mean (which equals the mean of y).
getRegressionSumSquares() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the sum of squared deviations of the predicted y values about their mean (which equals the mean of y).
getRegularFont() - Method in class org.jfree.chart.StandardChartTheme
Returns the regular font.
getRelation() - Method in class jminhep.cluster.DataHolder
Get name of the data holder (i.e.
getRelationship() - Method in class org.apache.commons.math3.optim.linear.LinearConstraint
Gets the relationship between left and right hand sides.
getRelationship() - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated.
Get the relationship between left and right hand sides.
getRelativeAccuracy() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the relative accuracy.
getRelativeAccuracy() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the relative accuracy.
getRelativeAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Get the relative accuracy of the solver.
getRelativeAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Get the relative accuracy of the solver.
getRelativeAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BracketedRealFieldUnivariateSolver
Get the relative accuracy of the solver.
getRelativeAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the relative accuracy.
getRelativeAccuracy() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Deprecated.
Get the relative accuracy.
getRelativeError() - Method in interface jhplot.math.num.IterativeMethod.IterativeState
Access the current relative error in the evaluation.
getRelativeThreshold() - Method in class org.apache.commons.math3.optim.AbstractConvergenceChecker
 
getRelativeThreshold() - Method in class org.apache.commons.math3.optimization.AbstractConvergenceChecker
Deprecated.
 
getRemainingRegion() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Get the remaining region of the hyperplane.
getRenderAsPercentages() - Method in class org.jfree.chart.renderer.category.StackedAreaRenderer
Returns true if the renderer displays each item value as a percentage (so that the stacked areas add to 100%), and false otherwise.
getRenderAsPercentages() - Method in class org.jfree.chart.renderer.category.StackedBarRenderer
Returns true if the renderer displays each item value as a percentage (so that the stacked bars add to 100%), and false otherwise.
getRenderAsPercentages() - Method in class org.jfree.chart.renderer.category.StackedBarRenderer3D
Returns true if the renderer displays each item value as a percentage (so that the stacked bars add to 100%), and false otherwise.
getRenderAsPercentages() - Method in class org.jfree.chart.renderer.xy.StackedXYBarRenderer
Returns true if the renderer displays each item value as a percentage (so that the stacked bars add to 100%), and false otherwise.
getRenderer() - Method in class org.jfree.chart.event.RendererChangeEvent
Returns the renderer that generated the event.
getRenderer() - Method in class org.jfree.chart.plot.CategoryPlot
Returns a reference to the renderer for the plot.
getRenderer(int) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the renderer at the given index.
getRenderer() - Method in class org.jfree.chart.plot.PolarPlot
Returns the primary renderer.
getRenderer(int) - Method in class org.jfree.chart.plot.PolarPlot
Returns the renderer at the specified index, if there is one.
getRenderer() - Method in class org.jfree.chart.plot.XYPlot
Returns the renderer for the primary dataset.
getRenderer(int) - Method in class org.jfree.chart.plot.XYPlot
Returns the renderer with the specified index, or null.
getRendererCount() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the number of renderer slots for this plot.
getRendererCount() - Method in class org.jfree.chart.plot.XYPlot
Returns the number of renderer slots for this plot.
getRendererForDataset(CategoryDataset) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the renderer for the specified dataset.
getRendererForDataset(XYDataset) - Method in class org.jfree.chart.plot.XYPlot
Returns the renderer for the specified dataset (this is either the renderer with the same index as the dataset or, if there isn't a renderer with the same index, the default renderer).
getRendererIndex() - Method in class org.jfree.chart.entity.XYAnnotationEntity
Returns the renderer index.
getRenderingHint(RenderingHints.Key) - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the current value for the specified hint.
getRenderingHints() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns a copy of the rendering hints.
getRenderingHints() - Method in class org.jfree.chart.JFreeChart
Returns the collection of rendering hints for the chart.
getRenderingInfo() - Method in class org.jfree.chart.fx.ChartCanvas
Returns the rendering info from the most recent drawing of the chart.
getRenderingInfo() - Method in class org.jfree.chart.fx.ChartViewer
Returns the rendering info from the most recent drawing of the chart.
getRenderingInfo() - Method in class org.jfree.chart.fx.ChartViewerSkin
Returns the rendering info from the most recent drawing of the chart.
getRepresentation() - Method in class hep.physics.vec.SpacePoint
 
getRepresentation() - Method in class hephysics.vec.SpacePoint
 
getRequestedEvents() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
getRequestedEvents() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double requested_events = 21;
getRequestedEvents() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double requested_events = 21;
getRequestedEvents() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
getRequestedEvents() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double requested_events = 21;
getRequestedEvents() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double requested_events = 21;
getRequestedEvents() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
getRequestedEvents() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double requested_events = 21;
getRequestedEvents() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double requested_events = 21;
getRequestedEvents() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
getRequestedEvents() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double requested_events = 21;
getRequestedEvents() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double requested_events = 21;
getReservedFileNames() - Method in enum org.apache.commons.io.FileSystem
Gets a cloned copy of the reserved file names.
getReshowDelay() - Method in class org.jfree.chart.ChartPanel
Returns the reshow tooltip delay value used inside this chart panel.
getResidual() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Returns the residual.
getResidual() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Returns the residual.
getResiduals() - Method in class jhplot.stat.LinReg
Get residuals
getResiduals() - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresProblem.Evaluation
Get the weighted residuals.
getResourcePaths() - Static method in class jminhep.utils.ResourceLoader
 
getResourceStream(String) - Static method in class jminhep.utils.ResourceLoader
 
getResourceURL(String) - Static method in class jminhep.utils.ResourceLoader
 
getResult(double, double, double) - Method in class graph.ParseFunction
Return the solution of the function given the independent values
getResult(double, double) - Method in class graph.ParseFunction
Return the solution of the function given the independent values
getResult(double) - Method in class graph.ParseFunction
Return the solution of the function given the independent values
getResult() - Method in class graph.ParseFunction
Return the solution of the function if it has no independent values or they have already been set using the set methods
getResult() - Method in class jhplot.HFitter
Get result of the fit.
getResult() - Method in class jhplot.stat.LinReg
Get the linear regression result
getResult() - Method in class jhplot.stat.LinRegWeighted
Get the fit results
getResult() - Method in class jminhep.algorithms.HierarchicalAlg
Get cluster results (should be called after run method)
getResult() - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Returns the value of the statistic based on the values that have been added.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
Get the covariance matrix.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
Get the mean vector.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile
Returns the current value of the Statistic.
getResult() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Returns the current value of the Statistic.
getResultCode() - Method in class hep.lcio.util.ObjectComparator
 
getResults(int, double[]) - Method in class graph.ParseFunction
Return an array of solutions given an array of x values
getResults(int, double[], double[]) - Method in class graph.ParseFunction
Return an array of solutions given an array of x values and y values
getResults(int, double[], double[], double[]) - Method in class graph.ParseFunction
Return an array of solutions given an array of x values, y values and z values.
getResults(String) - Method in class jhplot.stat.ConfidenceLevel
Display sort of a "canonical" -2lnQ plot.
getResults() - Method in class jhplot.stat.Moments
Get results in form of P1D.
getResults() - Method in class jhplot.stat.MomentsFac
Get results in form of P1D.
getResults() - Method in class jhplot.stat.MomentsNorm
Get results in form of P1D.
getResults() - Method in class org.jlab.groot.data.DatasetOperations
 
getResultString() - Method in class hep.lcio.util.ObjectComparator
 
getReverse() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the reverse of the instance.
getReverse() - Method in class org.apache.commons.math3.geometry.spherical.oned.LimitAngle
Get the reverse of the instance.
getReverse() - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Get the reverse of the instance.
getRevolutionDistance() - Method in class org.jfree.chart.plot.CompassPlot
Gets the count to complete one revolution.
getRGB(int) - Static method in class jhplot.utils.ColorPixel
Get (R,G,B) from a pixel color.
getRGB(int[]) - Static method in class jhplot.utils.ColorPixel
Get array list with (R,G,B) from list of pixels.
getRHeight(VectorGraphics) - Method in class graph.RTextLine
The height of the text after it has been rotated.
getRight() - Method in class org.jfree.chart.axis.AxisSpace
Returns the space reserved for axes at the right of the plot area.
getRightArrow() - Method in class org.jfree.chart.axis.ValueAxis
Returns a shape that can be displayed as an arrow pointing right at the end of an axis line.
getRightEdge(VectorGraphics) - Method in class graph.RTextLine
Return the right edge of the rotated text.
getRightEdge(VectorGraphics, int) - Method in class graph.RTextLine
Return the right edge of the rotated text.
getRightHandSideVector() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Returns the current right-hand side of the linear system to be solved.
getRightHandSideVector() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Returns the current right-hand side of the linear system to be solved.
getRightMargin() - Method in class jplot.GraphSettings
Returns the distance between the right-border of the panel and the right Y-axis.
getRightMargin() - Method in class org.jlab.groot.base.PadMargins
 
getRMS() - Method in class org.apache.commons.math3.fitting.leastsquares.AbstractEvaluation
Get the normalized cost.
getRMS() - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresProblem.Evaluation
Get the normalized cost.
getRMS() - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Deprecated.
Gets the root-mean-square (RMS) value.
getRMS() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated.
Get the Root Mean Square value.
getRMS() - Method in class org.jlab.groot.data.DataVector
 
getRMS() - Method in class org.jlab.groot.data.H1F
Calculates the root mean square of the histogram data
getRms() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double rms = 15;
getRms() - Method in class promc.io.PBufFile.Record.H1D
optional double rms = 15;
getRms() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional double rms = 15;
getRmses(int) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double rmses = 5 [packed = true];
getRmses(int) - Method in class promc.io.PBufFile.Record.H1D
repeated double rmses = 5 [packed = true];
getRmses(int) - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double rmses = 5 [packed = true];
getRmsesCount() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double rmses = 5 [packed = true];
getRmsesCount() - Method in class promc.io.PBufFile.Record.H1D
repeated double rmses = 5 [packed = true];
getRmsesCount() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double rmses = 5 [packed = true];
getRmsesList() - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double rmses = 5 [packed = true];
getRmsesList() - Method in class promc.io.PBufFile.Record.H1D
repeated double rmses = 5 [packed = true];
getRmsesList() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
repeated double rmses = 5 [packed = true];
getRmsesX(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesX = 5 [packed = true];
getRmsesX(int) - Method in class promc.io.PBufFile.Record.H2D
repeated double rmsesX = 5 [packed = true];
getRmsesX(int) - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double rmsesX = 5 [packed = true];
getRmsesXCount() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesX = 5 [packed = true];
getRmsesXCount() - Method in class promc.io.PBufFile.Record.H2D
repeated double rmsesX = 5 [packed = true];
getRmsesXCount() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double rmsesX = 5 [packed = true];
getRmsesXList() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesX = 5 [packed = true];
getRmsesXList() - Method in class promc.io.PBufFile.Record.H2D
repeated double rmsesX = 5 [packed = true];
getRmsesXList() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double rmsesX = 5 [packed = true];
getRmsesY(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesY = 8 [packed = true];
getRmsesY(int) - Method in class promc.io.PBufFile.Record.H2D
repeated double rmsesY = 8 [packed = true];
getRmsesY(int) - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double rmsesY = 8 [packed = true];
getRmsesYCount() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesY = 8 [packed = true];
getRmsesYCount() - Method in class promc.io.PBufFile.Record.H2D
repeated double rmsesY = 8 [packed = true];
getRmsesYCount() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double rmsesY = 8 [packed = true];
getRmsesYList() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesY = 8 [packed = true];
getRmsesYList() - Method in class promc.io.PBufFile.Record.H2D
repeated double rmsesY = 8 [packed = true];
getRmsesYList() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double rmsesY = 8 [packed = true];
getRmsX() - Method in class jhplot.H2D
Get RMS on X
getRmsX() - Method in class jhplot.HProf2D
Get RMS on X
getRmsY() - Method in class jhplot.H2D
Get RMS on Y
getRmsY() - Method in class jhplot.HProf2D
Get RMS on Y
getRollCount() - Method in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of version 1.0.13, use the DateTickUnit.getRollMultiple()
getRollMultiple() - Method in class org.jfree.chart.axis.DateTickUnit
Returns the roll unit multiple.
getRollUnit() - Method in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of version 1.0.13, use DateTickUnit.getRollUnitType().
getRollUnitType() - Method in class org.jfree.chart.axis.DateTickUnit
Returns the roll unit type.
getRoot() - Method in class org.jlab.groot.data.Directory
 
getRoot() - Method in class org.lsmp.djep.djep.PartialDerivative
Every partial derivative has a root variable for instance the root variable of dy/dx is y.
getRoot() - Method in class root.RootHistogramTreeModel
 
getRootClass() - Method in class root.FakeTKey
 
getRootMatrix() - Method in class org.apache.commons.math3.linear.RectangularCholeskyDecomposition
Get the root of the covariance matrix.
getRootMatrix() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Get the root of the covariance matrix.
getRootNode() - Method in class org.jlab.groot.tree.Tree
 
getRootOp() - Method in class org.lsmp.djep.xjep.XOperator
 
getRootPlot() - Method in class org.jfree.chart.plot.Plot
Returns the root plot.
getRootVal() - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
Returns an approximation to the value of the root as a complex number.
getRoseCenterPaint() - Method in class org.jfree.chart.plot.CompassPlot
Returns the paint used to fill the inner background area of the compass.
getRoseHighlightPaint() - Method in class org.jfree.chart.plot.CompassPlot
Returns the paint used to draw the circles, symbols and labels on the compass.
getRosePaint() - Method in class org.jfree.chart.plot.CompassPlot
Returns the paint used to fill the outer circle of the compass.
getRotateX() - Method in class org.jfree.chart.needle.MeterNeedle
Returns the scalar used for determining the rotation x value.
getRotateY() - Method in class org.jfree.chart.needle.MeterNeedle
Returns the scalar used for determining the rotation y value.
getRotation() - Method in class graph.RTextLine
 
getRotation() - Method in class jhplot.gui.GHMargin
Get the rotation angle of the text in degrees.
getRotation() - Method in class jhplot.HKey
Returns the rotation angle.
getRotation() - Method in class jhplot.HLabel
Returns the rotation angle.
getRotation() - Method in class jhplot.HMLabel
Returns the rotation angle.
getRotation() - Method in class jhplot.shapes.HShape
Get rotation angle theta.
getRotation() - Method in class jplot.GraphLabel
Returns the rotation angle.
getRotationAnchor() - Method in class org.jfree.chart.annotations.TextAnnotation
Returns the rotation anchor.
getRotationAnchor() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the rotation anchor.
getRotationAnchor() - Method in class org.jfree.chart.axis.CategoryLabelPosition
Returns the rotation anchor point.
getRotationAnchor() - Method in class org.jfree.chart.axis.Tick
Returns the text anchor that defines the point around which the label is rotated.
getRotationAnchor() - Method in class org.jfree.chart.labels.ItemLabelPosition
Returns the rotation anchor point.
getRotationAngle() - Method in class jhplot.HPlot3D
Get the rotation angle
getRotationAngle() - Method in class jplot3d.Projector
Gets current rotation angle.
getRotationAngle() - Method in class jplot3d.SurfaceModelCanvas
 
getRotationAngle() - Method in class org.jfree.chart.annotations.TextAnnotation
Returns the rotation angle in radians.
getRotationAngle() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the rotation angle.
getRoundingMode() - Method in class org.apache.commons.math3.dfp.DfpField
Get the current rounding mode.
getRoundingMode() - Method in class org.apache.commons.math3.util.BigReal
Gets the rounding mode for division operations The default is RoundingMode.HALF_UP
getRoundXCoordinates() - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer2
Returns the flag that controls whether or not the x-coordinates (in Java2D space) are rounded to integer values.
getRoundXCoordinates() - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Returns the flag that controls whether or not the x-coordinates (in Java2D space) are rounded to integer values.
getRow(int) - Method in class jhplot.PND
Return a specific row as array
getRow(int) - Method in class jhplot.PNI
Return a specific row as array
getRow(int) - Method in class jminhep.cluster.DataHolder
Get DataPoint at the position n
getRow(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the entries in row number row as an array.
getRow(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entries at the given row index.
getRow(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get the entries in row number row as an array.
getRow(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entries at the given row index.
getRow(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the entries in row number row as an array.
getRow() - Method in exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
 
getRow() - Method in exception org.apache.commons.math3.linear.NonSymmetricMatrixException
 
getRow(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entries at the given row index.
getRow() - Method in class org.apache.commons.math3.ml.neuralnet.twod.util.LocationFinder.Location
 
getRow() - Method in class org.jlab.groot.tree.TreeTextFile
 
getRowCopy(double[][], int) - Static method in class jhplot.math.DoubleArray
Extract a row from a matrix.
getRowCopy(int[][], int) - Static method in class jhplot.math.IntegerArray
 
getRowCount() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the number of rows in the dataset.
getRowCount() - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns the number of rows in the table.
getRowCount() - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the number of series in the dataset (possibly zero).
getRowCount() - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the number of rows in the table.
getRowCount() - Method in class org.jfree.data.DefaultKeyedValues2D
Returns the row count.
getRowCount() - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the number of rows in the table.
getRowCount() - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the number of rows (series) in the collection.
getRowCount() - Method in class org.jfree.data.KeyedObjects2D
Returns the row count.
getRowCount() - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the number of rows in the table.
getRowCount() - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns the number of rows in the table.
getRowCount() - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the number of rows in the table.
getRowCount() - Method in class org.jfree.data.time.TimeSeriesTableModel
Returns the number of rows in the table model.
getRowCount() - Method in interface org.jfree.data.Values2D
Returns the number of rows in the table.
getRowCount() - Method in class org.jfree.data.xy.MatrixSeries
Returns the number of rows in this matrix series.
getRowCount() - Method in class org.jfree.data.xy.XYDatasetTableModel
Returns the number of rows.
getRowDimension() - Method in class Jama.Matrix
Get row dimension.
getRowDimension() - Method in class jhplot.math.kalman.jama.Matrix
Get row dimension.
getRowDimension() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the number of rows of this matrix.
getRowDimension() - Method in interface org.apache.commons.math3.linear.AnyMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns the number of rows of this matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the number of rows of this matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the number of rows of this matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.JacobiPreconditioner
Returns the dimension of the codomain of this operator.
getRowDimension() - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Returns the number of rows of this matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.RealLinearOperator
Returns the dimension of the codomain of this operator.
getRowDimension() - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Returns the number of rows in the matrix.
getRowIndex(Comparable) - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns the row index for a given key.
getRowIndex(Comparable) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns a row index.
getRowIndex(Comparable) - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the row index for a given key.
getRowIndex(Comparable) - Method in class org.jfree.data.DefaultKeyedValues2D
Returns the row index for a given key.
getRowIndex(Comparable) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the row index for a given key.
getRowIndex(Comparable) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the row index for the given row key.
getRowIndex(Comparable) - Method in class org.jfree.data.KeyedObjects2D
Returns the row index for a given key, or -1 if the key is not recognised.
getRowIndex(Comparable) - Method in interface org.jfree.data.KeyedValues2D
Returns the row index for a given key.
getRowIndex(Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the row index for a given key.
getRowIndex(Comparable) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns the row index for a given key.
getRowIndex(Comparable) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the row index for a given key.
getRowKey() - Method in class org.jfree.chart.entity.CategoryItemEntity
Returns the row key.
getRowKey() - Method in class org.jfree.chart.plot.CategoryCrosshairState
Returns the row key.
getRowKey(int) - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns the key for the specified row.
getRowKey(int) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the name of the specified series.
getRowKey(int) - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the row key for a given index.
getRowKey(int) - Method in class org.jfree.data.DefaultKeyedValues2D
Returns the key for a given row.
getRowKey(int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the row key for a given index.
getRowKey(int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the key for a row.
getRowKey(int) - Method in class org.jfree.data.KeyedObjects2D
Returns the key for a given row.
getRowKey(int) - Method in interface org.jfree.data.KeyedValues2D
Returns the row key for a given index.
getRowKey(int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns a row key.
getRowKey(int) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns a row key.
getRowKey(int) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns a row key.
getRowKeys() - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns the row keys.
getRowKeys() - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns a list of the series in the dataset.
getRowKeys() - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the row keys.
getRowKeys() - Method in class org.jfree.data.DefaultKeyedValues2D
Returns the row keys in an unmodifiable list.
getRowKeys() - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the row keys.
getRowKeys() - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the row keys.
getRowKeys() - Method in class org.jfree.data.KeyedObjects2D
Returns the row keys.
getRowKeys() - Method in interface org.jfree.data.KeyedValues2D
Returns the row keys.
getRowKeys() - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the row keys.
getRowKeys() - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns the row keys.
getRowKeys() - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the row keys.
getRowMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the entries in row number row as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entries at the given row index as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get the entries in row number row as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entries at the given row index as a row matrix.
getRowMatrix(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the entries in row number row as a row matrix.
getRowMatrix(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entries at the given row index as a row matrix.
getRowP0D(int) - Method in class jhplot.PND
Return a specific row as P0D
getRowP0D(int) - Method in class jhplot.PNI
Return a specific row as P0D
getRowPackedCopy() - Method in class Jama.Matrix
Make a one-dimensional row packed copy of the internal array.
getRowPackedCopy() - Method in class jhplot.math.kalman.jama.Matrix
Make a one-dimensional row packed copy of the internal array.
getRowPrefix() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format prefix.
getRowRenderingOrder() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the order in which the rows should be rendered.
getRows(String, int, int) - Method in class jhplot.PND
Get rows : min is inxluded, max is not;
getRows(String, int, int) - Method in class jhplot.PNI
Get rows : min is inxluded, max is not;
getRows() - Method in class org.jlab.groot.group.DataGroup
 
getRows() - Method in class org.jlab.groot.group.DataGroupDescriptor
 
getRowsCopy(double[][], int...) - Static method in class jhplot.math.DoubleArray
Extract specific rows from a matrix.
getRowsCopy(int[][], int...) - Static method in class jhplot.math.IntegerArray
 
getRowSeparator() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format separator between rows of the matrix.
getRowsRangeCopy(double[][], int, int) - Static method in class jhplot.math.DoubleArray
Extract a range of rows from a matrix.
getRowsRangeCopy(int[][], int, int) - Static method in class jhplot.math.IntegerArray
 
getRowSuffix() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format suffix.
getRowVector(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the entries in row number row as a vector.
getRowVector(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the entries in row number row as a vector.
getRowVector(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get the entries in row number row as a vector.
getRowVector(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the entries in row number row as a vector.
getRowVector(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the entries in row number row as a vector.
getRowVector(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the entries in row number row as a vector.
getRSquare() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the coefficient of determination, usually denoted r-square.
getRSquared() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the coefficient of multiple determination, usually denoted r-square.
getRule(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.BaseRuleFactory
Gets a copy of the quadrature rule with the given number of integration points.
getRule(int) - Method in class org.lsmp.djep.djep.diffRules.ChainRuleDiffRules
returns the i-th rule as an expression tree.
getRunNumber() - Method in interface hep.lcio.event.LCEvent
Return the run number off this event.
getRunNumber() - Method in interface hep.lcio.event.LCRunHeader
Returns the run number.
getRunNumber() - Method in class hep.lcio.implementation.event.ILCEvent
 
getRunNumber() - Method in class hep.lcio.implementation.event.ILCRunHeader
 
getRunNumber() - Method in class hep.physics.event.BaseEvent
 
getRunNumber() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
 
getRunNumber() - Method in interface hep.physics.event.HEPEvent
 
getRuntimeClass() - Method in class org.apache.commons.math3.complex.ComplexField
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in class org.apache.commons.math3.dfp.DfpField
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in interface org.apache.commons.math3.Field
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in class org.apache.commons.math3.fraction.BigFractionField
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in class org.apache.commons.math3.fraction.FractionField
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in class org.apache.commons.math3.util.BigRealField
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in class org.apache.commons.math3.util.Decimal64Field
Returns the runtime class of the FieldElement.
getRWidth(VectorGraphics) - Method in class graph.RTextLine
The width of the text after it has been rotated.
getS() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the diagonal matrix of singular values.
getS() - Method in class Jama.SingularValueDecomposition
Return the diagonal matrix of singular values
getS() - Method in class jhplot.math.SingularValueDecomposition
Return the diagonal matrix of singular values
getS() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the diagonal matrix Σ of the decomposition.
getS() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
getS() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double s = 11;
getS() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double s = 11;
getS() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
getS() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double s = 11;
getS() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double s = 11;
getS() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
getS() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double s = 11;
getS() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double s = 11;
getS() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
getS() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double s = 11;
getS() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double s = 11;
getSafety() - Method in class org.apache.commons.math3.ode.MultistepFieldIntegrator
Get the safety factor for stepsize control.
getSafety() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Get the safety factor for stepsize control.
getSafety() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Get the safety factor for stepsize control.
getSafety() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the safety factor for stepsize control.
getSampleSize() - Method in class jhplot.math.num.pdf.Hypergeometric
Access the sample size.
getSampleSize() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Access the sample size.
getSampleStats() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Returns a StatisticalSummary describing this distribution.
getScalarPart() - Method in class org.apache.commons.math3.complex.Quaternion
Gets the scalar part of the quaternion.
getScale() - Method in class jhplot.math.num.pdf.Cauchy
Access the scale parameter.
getScale() - Method in class jhplot.math.num.pdf.Laplace
Access the scale.
getScale() - Method in class jhplot.math.num.pdf.Logistic
Access the scale parameter.
getScale() - Method in class jhplot.math.num.pdf.Rayleigh
Access the scale parameter.
getScale() - Method in class jhplot.math.num.pdf.Weibull
Access the scale parameter.
getScale() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Access the scale parameter.
getScale() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Returns the scale parameter of this distribution.
getScale() - Method in class org.apache.commons.math3.distribution.GumbelDistribution
Access the scale parameter, beta.
getScale() - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
Access the scale parameter, beta.
getScale() - Method in class org.apache.commons.math3.distribution.LevyDistribution
Get the scale parameter of the distribution.
getScale() - Method in class org.apache.commons.math3.distribution.LogisticDistribution
Access the scale parameter, s.
getScale() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Returns the scale parameter of this distribution.
getScale() - Method in class org.apache.commons.math3.distribution.NakagamiDistribution
Access the scale parameter, omega.
getScale() - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Returns the scale parameter of this distribution.
getScale() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Access the scale parameter, beta.
getScale() - Method in class org.apache.commons.math3.util.BigReal
Sets the scale for division operations.
getScale(int) - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the scale at the given index.
getScale() - Method in class org.jfree.chart.title.PaintScaleLegend
Returns the scale used to convert values to colors.
getScale() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Scale = 12;
getScale() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float Scale = 12;
getScale() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float Scale = 12;
getScale() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Scale = 12;
getScale() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float Scale = 12;
getScale() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float Scale = 12;
getScale(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float Scale = 12;
getScale(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float Scale = 12;
getScale(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float Scale = 12;
getScaleCount() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float Scale = 12;
getScaleCount() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float Scale = 12;
getScaleCount() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float Scale = 12;
getScaledPosition(double, double) - Method in class jhplot.shapes.HShape
Scale the positions
getScaleFactor() - Method in class graph.VectorSet
return the current scaling factor.
getScaleFactor() - Method in class org.jfree.data.xy.NormalizedMatrixSeries
Returns the factor that multiplies each item in this series when observed using getItem mehtod.
getScaleForDataset(int) - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the dial scale for a specific dataset.
getScaleIndex() - Method in class org.jfree.chart.plot.dial.StandardDialRange
Returns the scale index.
getScaleList() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float Scale = 12;
getScaleList() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float Scale = 12;
getScaleList() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float Scale = 12;
getScalePDF() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Scale_PDF = 10;
getScalePDF() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float Scale_PDF = 10;
getScalePDF() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float Scale_PDF = 10;
getScalepdf() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
getScalepdf() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double scalepdf = 7;
getScalepdf() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double scalepdf = 7;
getScalePDF() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Scale_PDF = 10;
getScalePDF() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float Scale_PDF = 10;
getScalePDF() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float Scale_PDF = 10;
getScalepdf() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
getScalepdf() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double scalepdf = 7;
getScalepdf() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double scalepdf = 7;
getScalepdf() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
getScalepdf() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double scalepdf = 7;
getScalepdf() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double scalepdf = 7;
getScalePDF(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float ScalePDF = 10;
getScalePDF(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float ScalePDF = 10;
getScalePDF(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float ScalePDF = 10;
getScalepdf() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
getScalepdf() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double scalepdf = 7;
getScalepdf() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double scalepdf = 7;
getScalePDFCount() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float ScalePDF = 10;
getScalePDFCount() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float ScalePDF = 10;
getScalePDFCount() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float ScalePDF = 10;
getScalePDFList() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float ScalePDF = 10;
getScalePDFList() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float ScalePDF = 10;
getScalePDFList() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float ScalePDF = 10;
getScaleType() - Method in class org.jfree.chart.renderer.xy.XYBubbleRenderer
Returns the scale type that was set when the renderer was constructed.
getScaleX() - Method in class org.jfree.chart.ChartPanel
Returns the X scale factor for the chart.
getScaleY() - Method in class org.jfree.chart.ChartPanel
Returns the Y scale factory for the chart.
getScaling() - Method in class jhplot.HPlot3D
Get the scaling
getScanResults() - Method in class org.jlab.groot.tree.Tree
returns a list of data vectors stores after the last scan was done.
getScreenDataArea() - Method in class org.jfree.chart.ChartPanel
Returns the data area for the chart (the area inside the axes) with the current scaling applied (that is, the area as it appears on screen).
getScreenDataArea(int, int) - Method in class org.jfree.chart.ChartPanel
Returns the data area (the area inside the axes) for the plot or subplot, with the current scaling applied.
getScriptFont(Font) - Method in class graph.TextLine
 
getScrollPane() - Method in class jhepsim.mainGUI
Return editor
getSecond() - Method in class org.apache.commons.math3.genetics.ChromosomePair
Access the second chromosome.
getSecond() - Method in class org.apache.commons.math3.util.Pair
Get the second element of the pair.
getSecond() - Method in class org.jfree.data.time.Millisecond
Returns the second.
getSecond() - Method in class org.jfree.data.time.Second
Returns the second within the minute.
getSecondaryDerivative(int) - Method in class org.apache.commons.math3.ode.FieldODEStateAndDerivative
Get derivative of the secondary state at time.
getSecondaryMappers() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get the equations mappers for the secondary equations sets.
getSecondaryState(int) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get secondary part of the current state.
getSecondaryState(int) - Method in class org.apache.commons.math3.ode.FieldODEState
Get secondary state at time.
getSecondaryStateDimension(int) - Method in class org.apache.commons.math3.ode.FieldODEState
Get secondary state dimension.
getSecondaryStateDot(int) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get secondary part of the current state derivative.
getSecondMoment() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns a statistic related to the Second Central Moment.
getSecondMoment() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns a statistic related to the Second Central Moment.
getSecondPolygonColor(float) - Method in class jplot3d.ColorModelSet
 
getSecondPolygonColor(float) - Method in interface jplot3d.SurfaceColor
 
getSecondSuffix() - Method in class org.jfree.chart.util.RelativeDateFormat
Returns the string that is appended to the second count.
getSectionDepth() - Method in class org.jfree.chart.plot.RingPlot
Returns the depth of each section, expressed as a percentage of the plot radius.
getSectionIndex() - Method in class org.jfree.chart.entity.PieSectionEntity
Returns the section index.
getSectionKey() - Method in class org.jfree.chart.entity.PieSectionEntity
Returns the section key.
getSectionOutlinePaint(Comparable) - Method in class org.jfree.chart.plot.PiePlot
Returns the outline paint associated with the specified key, or null if there is no paint associated with the key.
getSectionOutlinePaint() - Method in class org.jfree.chart.plot.PiePlot
Deprecated.
getSectionOutlinePaint(int) - Method in class org.jfree.chart.plot.PiePlot
getSectionOutlineStroke(Comparable) - Method in class org.jfree.chart.plot.PiePlot
Returns the outline stroke associated with the specified key, or null if there is no stroke associated with the key.
getSectionOutlineStroke() - Method in class org.jfree.chart.plot.PiePlot
Deprecated.
getSectionOutlineStroke(int) - Method in class org.jfree.chart.plot.PiePlot
getSectionOutlinesVisible() - Method in class org.jfree.chart.plot.PiePlot
Returns the flag that controls whether or not the outline is drawn for each pie section.
getSectionPaint() - Method in class org.jfree.chart.plot.PiePlot
Deprecated.
getSectionPaint(Comparable) - Method in class org.jfree.chart.plot.PiePlot
Returns the paint associated with the specified key, or null if there is no paint associated with the key.
getSectionPaint(int) - Method in class org.jfree.chart.plot.PiePlot
Deprecated.
getSeed() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
 
getSeed() - Method in class jminhep.algorithms.KMeansAlg
Return seeds
getSeedAtRowColumn(int, int) - Static method in class cern.jet.random.engine.RandomSeedTable
Returns a deterministic seed from a (seemingly gigantic) matrix of predefined seeds.
getSeedHolder() - Method in class jminhep.algorithms.KMeansAlg
Get positions of seeds
getSeedHolder() - Method in class jminhep.algorithms.KMeansExchangeAlg
Returns seed centers
getSeeds() - Method in class jminhep.cluster.Partition
Get seeds
getSegment(long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns a segment that contains a domainValue.
getSegment(Date) - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns a segment that contains a date.
getSegmentCount() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns always one (the number of segments contained in this segment).
getSegmentEnd() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Gets the end of this segment in ms.
getSegmentNumber() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns the segment number of this segment.
getSegments() - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubLine
Get the endpoints of the sub-line.
getSegments() - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Get the endpoints of the sub-line.
getSegmentsExcluded() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns the number of segments excluded per segment group.
getSegmentsExcludedSize() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns the size in milliseconds of the segments excluded per segment group.
getSegmentsGroupSize() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns the size in milliseconds of a segment group.
getSegmentsIncluded() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns the number of segments included per segment group.
getSegmentsIncludedSize() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns the size in ms of the segments included per segment group.
getSegmentSize() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns the size of one segment in ms.
getSegmentStart() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Gets the start of this segment in ms.
getSelectedBin() - Method in class org.jlab.groot.matrix.SparseIndexPane
 
getSelectedColor() - Method in class jplot.panels.PanelColor
 
getSelectedColor() - Method in class jplot.panels.PanelFonts
 
getSelectedFileWithExtension(JFileChooser) - Static method in class jhplot.io.images.ExportVGraphics
Returns the selected file from a JFileChooser, including the extension from the file filter.
getSelectedFont() - Method in class jhplot.utils.ShowFonts
Retrieve the selected font, or null
getSelectedFont() - Method in class jplot.panels.PanelFonts
 
getSelectedIndex() - Method in class jplot.SmallScrollPane
Returns the selected index of the scroll pane.
getSelectedItem() - Method in class jplot.Utils.LabeledComboBox
 
getSelectedName() - Method in class jhplot.utils.ShowFonts
Retrieve the selected font name.
getSelectedOrder() - Method in class org.jlab.groot.matrix.SparseIndexPane
 
getSelectedSize() - Method in class jhplot.utils.ShowFonts
Retrieve the selected size
getSelectedValue() - Method in class jhepsim.FontChooser.NwList
 
getSelectedValue() - Method in class jminhep.gui.FontChooser.NwList
 
getSelectionPolicy() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the selection policy.
getSelector() - Method in class org.jlab.groot.tree.Tree
returns default tree selector.
getSelectorCuts() - Method in class org.jlab.groot.tree.TreeSelector
 
getSensitivity() - Method in class jhplot.stat.limit.StatConfidence
Get sensitivity
getSensitivityError() - Method in class jhplot.stat.limit.StatConfidence
Get error on sensitivity
getSeparation() - Method in class jhplot.HKey
Return vertical separation between different keys.
getSeparator() - Method in class org.apache.commons.math3.geometry.VectorFormat
Get the format separator between components.
getSeparator() - Method in class org.apache.commons.math3.linear.RealVectorFormat
Get the format separator between components.
getSeparatorPaint() - Method in class org.jfree.chart.plot.RingPlot
Returns the separator paint.
getSeparatorStroke() - Method in class org.jfree.chart.plot.RingPlot
Returns the separator stroke.
getSeparatorsVisible() - Method in class org.jfree.chart.plot.RingPlot
Returns a flag that indicates whether or not separators are drawn between the sections in the chart.
getSerialDate() - Method in class org.jfree.data.time.Day
Returns the day as a SerialDate.
getSerialIndex() - Method in class org.jfree.data.time.Day
Returns a serial index number for the day.
getSerialIndex() - Method in class org.jfree.data.time.FixedMillisecond
Returns a serial index number for the millisecond.
getSerialIndex() - Method in class org.jfree.data.time.Hour
Returns a serial index number for the hour.
getSerialIndex() - Method in class org.jfree.data.time.Millisecond
Returns a serial index number for the millisecond.
getSerialIndex() - Method in class org.jfree.data.time.Minute
Returns a serial index number for the minute.
getSerialIndex() - Method in class org.jfree.data.time.Month
Returns a serial index number for the month.
getSerialIndex() - Method in class org.jfree.data.time.Quarter
Returns a serial index number for the quarter.
getSerialIndex() - Method in class org.jfree.data.time.RegularTimePeriod
Returns a serial index number for the time unit.
getSerialIndex() - Method in class org.jfree.data.time.Second
Returns a serial index number for the minute.
getSerialIndex() - Method in class org.jfree.data.time.Week
Returns a serial index number for the week.
getSerialIndex() - Method in class org.jfree.data.time.Year
Returns a serial index number for the year.
getSerializedSize() - Method in class proeic.io.ProMC.ProMCEvent.Event
 
getSerializedSize() - Method in class proeic.io.ProMC.ProMCEvent
 
getSerializedSize() - Method in class proeic.io.ProMC.ProMCEvent.Particles
 
getSerializedSize() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
getSerializedSize() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
getSerializedSize() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getSerializedSize() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getSerializedSize() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getSerializedSize() - Method in class proeic.io.ProMCStatFile.ProMCStat
 
getSerializedSize() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
getSerializedSize() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
getSerializedSize() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.F1D
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.F2D
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.FND
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.FPR
 
getSerializedSize() - Method in class promc.io.PBufFile.Record
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.H1D
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.H2D
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.P0D
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.P0I
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.P1D
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.PND
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.PNI
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.PXY
 
getSerializedSize() - Method in class promc.io.PBufFile.Record.PXYZ
 
getSerializedSize() - Method in class promc.io.PEventFile.HEvent.Entry
 
getSerializedSize() - Method in class promc.io.PEventFile.HEvent
 
getSerializedSize() - Method in class promc.io.PEventFile.HEvent.Group
 
getSerializedSize() - Method in class promc.io.ProMC.ProMCEvent.Event
 
getSerializedSize() - Method in class promc.io.ProMC.ProMCEvent
 
getSerializedSize() - Method in class promc.io.ProMC.ProMCEvent.Particles
 
getSerializedSize() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
getSerializedSize() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
 
getSerializedSize() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getSerializedSize() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getSerializedSize() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getSerializedSize() - Method in class promc.io.ProMCStatFile.ProMCStat
 
getSerializedSize() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
getSerializedSize() - Method in class pronlo.io.ProMC.ProMCEvent.Event
 
getSerializedSize() - Method in class pronlo.io.ProMC.ProMCEvent
 
getSerializedSize() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
 
getSerializedSize() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
getSerializedSize() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
getSerializedSize() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getSerializedSize() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getSerializedSize() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getSerializedSize() - Method in class pronlo.io.ProMCStatFile.ProMCStat
 
getSerializedSize() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
getSerializedSize() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
 
getSerializedSize() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
 
getSerializedSize() - Method in class proreco.io.ProMC.ProMCEvent.Event
 
getSerializedSize() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
 
getSerializedSize() - Method in class proreco.io.ProMC.ProMCEvent
 
getSerializedSize() - Method in class proreco.io.ProMC.ProMCEvent.Jets
 
getSerializedSize() - Method in class proreco.io.ProMC.ProMCEvent.MissingET
 
getSerializedSize() - Method in class proreco.io.ProMC.ProMCEvent.Muons
 
getSerializedSize() - Method in class proreco.io.ProMC.ProMCEvent.Particles
 
getSerializedSize() - Method in class proreco.io.ProMC.ProMCEvent.Photons
 
getSerializedSize() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
 
getSerializedSize() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
getSerializedSize() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
getSerializedSize() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getSerializedSize() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getSerializedSize() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getSerializedSize() - Method in class proreco.io.ProMCStatFile.ProMCStat
 
getSerializedSize() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
getSeries() - Method in class org.jfree.chart.entity.CategoryItemEntity
Deprecated.
As of 1.0.6, you can derive this information from the CategoryItemEntity.getRowKey() method.
getSeries() - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
getSeries(Comparable) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns a series from the collection.
getSeries(int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns a series from the collection.
getSeries(int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns a series from the collection.
getSeries(int) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns a series.
getSeries() - Method in class org.jfree.data.time.TimeSeriesCollection
Returns a list of all the series in the collection.
getSeries(int) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns a series.
getSeries(Comparable) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the series with the specified key, or null if there is no such series.
getSeries(int) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns a series.
getSeries(int) - Method in class org.jfree.data.xy.MatrixSeriesCollection
Returns the series having the specified index.
getSeries(int) - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns a series from the collection.
getSeries(int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns a series from the collection.
getSeries(int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns a series from the collection.
getSeries() - Method in class org.jfree.data.xy.XYSeriesCollection
Returns a list of all the series in the collection.
getSeries(int) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns a series from the collection.
getSeries(Comparable) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns a series from the collection.
getSeries(int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns a series from the collection.
getSeriesBarWidth(int) - Method in class org.jfree.chart.renderer.category.LayeredBarRenderer
Returns the bar width for a series, or Double.NaN if no width has been set.
getSeriesCount() - Method in class org.jfree.chart.plot.PolarPlot
Deprecated.
Since 1.0.14, grab a reference to the dataset and check the series count directly.
getSeriesCount() - Method in class org.jfree.chart.plot.XYPlot
Returns the number of series in the primary dataset for this plot.
getSeriesCount() - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the number of series in the dataset (possibly zero).
getSeriesCount() - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the number of series.
getSeriesCount() - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.general.AbstractSeriesDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the number of series in the dataset.
getSeriesCount() - Method in interface org.jfree.data.general.SeriesDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.jdbc.JDBCXYDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.statistics.HistogramDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the number of series in the dataset (always 1 for this dataset).
getSeriesCount() - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the series count.
getSeriesCount() - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.xy.DefaultWindDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.xy.DefaultXYDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.xy.MatrixSeriesCollection
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.xy.XYBarDataset
Returns the number of series in the dataset.
getSeriesCount() - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the number of series in the collection.
getSeriesCount() - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the number of series in the collection.
getSeriesCreateEntities(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the flag that controls whether entities are created for a series.
getSeriesFillPaint(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the paint used to fill an item drawn by the renderer.
getSeriesIndex() - Method in class org.jfree.chart.entity.LegendItemEntity
Deprecated.
As of 1.0.6, use the LegendItemEntity.getSeriesKey() method.
getSeriesIndex() - Method in class org.jfree.chart.entity.XYItemEntity
Returns the series index.
getSeriesIndex() - Method in class org.jfree.chart.LegendItem
Returns the series index for this legend item.
getSeriesIndex() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer.State
Returns the series index for the current path.
getSeriesIndex() - Method in class org.jfree.chart.title.LegendItemBlockContainer
Returns the series index.
getSeriesIndex(Comparable) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns a series index.
getSeriesIndex(Comparable) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the index of the series with the specified key, or -1 if no series has that key.
getSeriesIndex(Comparable) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the index of the series with the specified key, or -1 if no series has that key.
getSeriesItemLabelFont(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the font for all the item labels in a series.
getSeriesItemLabelFont(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the font for all the item labels in a series.
getSeriesItemLabelFont(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the font for all the item labels in a series.
getSeriesItemLabelGenerator(int) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the item label generator for a series.
getSeriesItemLabelGenerator(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the item label generator for a series.
getSeriesItemLabelGenerator(int) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the item label generator for a series.
getSeriesItemLabelGenerator(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the item label generator for a series.
getSeriesItemLabelPaint(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the paint used to draw the item labels for a series.
getSeriesItemLabelPaint(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the paint used to draw the item labels for a series.
getSeriesItemLabelPaint(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the paint used to draw the item labels for a series.
getSeriesItemURLGenerator(int) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the URL generator for a series.
getSeriesItemURLGenerator(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the item URL generator for a series.
getSeriesKey() - Method in class org.jfree.chart.entity.LegendItemEntity
Returns the series key that identifies the legend item.
getSeriesKey() - Method in class org.jfree.chart.LegendItem
Returns the series key.
getSeriesKey() - Method in class org.jfree.chart.title.LegendItemBlockContainer
Returns the series key.
getSeriesKey(int) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the name of the specified series.
getSeriesKey(int) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the name of the specified series.
getSeriesKey(int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the name of a series.
getSeriesKey(int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the name of a series.
getSeriesKey(int) - Method in class org.jfree.data.general.AbstractSeriesDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the key for a series.
getSeriesKey(int) - Method in interface org.jfree.data.general.SeriesDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.jdbc.JDBCXYDataset
Returns the key for the specified series.
getSeriesKey(int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the name of the series stored in this dataset.
getSeriesKey(int) - Method in class org.jfree.data.statistics.HistogramDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the key for the series stored in this dataset.
getSeriesKey(int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the series key.
getSeriesKey(int) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.DefaultWindDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.DefaultXYDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.MatrixSeriesCollection
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the key for a series.
getSeriesKey(int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the key for a series.
getSeriesLinesVisible(int) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the flag used to control whether or not the lines for a series are visible.
getSeriesLinesVisible(int) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns the flag used to control whether or not the lines for a series are visible.
getSeriesNegativeItemLabelPosition(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the item label position for all negative values in a series.
getSeriesNegativeItemLabelPosition(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the item label position for all negative values in a series.
getSeriesNegativeItemLabelPosition(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the item label position for all negative values in a series.
getSeriesOutlinePaint() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the outline paint for ALL series in the plot.
getSeriesOutlinePaint(int) - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the paint for the specified series.
getSeriesOutlinePaint(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the paint used to outline an item drawn by the renderer.
getSeriesOutlinePaint(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the paint used to outline an item drawn by the renderer.
getSeriesOutlinePaint(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the paint used to outline an item drawn by the renderer.
getSeriesOutlineStroke() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the outline stroke for ALL series in the plot.
getSeriesOutlineStroke(int) - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the stroke for the specified series.
getSeriesOutlineStroke(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the stroke used to outline the items in a series.
getSeriesOutlineStroke(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the stroke used to outline the items in a series.
getSeriesOutlineStroke(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the stroke used to outline the items in a series.
getSeriesPaint() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the paint for ALL series in the plot.
getSeriesPaint(int) - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the paint for the specified series.
getSeriesPaint(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the paint used to color an item drawn by the renderer.
getSeriesPaint(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the paint used to fill an item drawn by the renderer.
getSeriesPaint(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the paint used to color an item drawn by the renderer.
getSeriesParameterName() - Method in class org.jfree.chart.urls.TimeSeriesURLGenerator
Returns the series parameter name.
getSeriesPositiveItemLabelPosition(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the item label position for all positive values in a series.
getSeriesPositiveItemLabelPosition(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the item label position for all positive values in a series.
getSeriesPositiveItemLabelPosition(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the item label position for all positive values in a series.
getSeriesRenderingOrder() - Method in class org.jfree.chart.plot.XYPlot
Returns the series rendering order.
getSeriesRunningTotal() - Method in class org.jfree.chart.renderer.category.CategoryItemRendererState
Returns the series running total.
getSeriesShape(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns a shape used to represent the items in a series.
getSeriesShape(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns a shape used to represent the items in a series.
getSeriesShape(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns a shape used to represent the items in a series.
getSeriesShapesFilled(int) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the flag used to control whether or not the shapes for a series are filled.
getSeriesShapesFilled(int) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Returns the flag used to control whether or not the shapes for a series are filled.
getSeriesShapesFilled(int) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Returns the flag used to control whether or not the shapes for a series are filled.
getSeriesShapesFilled(int) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns the flag used to control whether or not the shapes for a series are filled.
getSeriesShapesVisible(int) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the flag used to control whether or not the shapes for a series are visible.
getSeriesShapesVisible(int) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns the flag used to control whether or not the shapes for a series are visible.
getSeriesStroke(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the stroke used to draw the items in a series.
getSeriesStroke(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the stroke used to draw the items in a series.
getSeriesStroke(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the stroke used to draw the items in a series.
getSeriesToolTipGenerator(int) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the tool tip generator for the specified series (a "layer 1" generator).
getSeriesToolTipGenerator(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the tool tip generator for the specified series (a "layer 1" generator).
getSeriesToolTipGenerator(int) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns the tool tip generator for the specified series.
getSeriesToolTipGenerator(int) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Returns the tool tip generator for a series.
getSeriesToolTipGenerator(int) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the tool tip generator for a series.
getSeriesToolTipGenerator(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the tool tip generator for a series.
getSeriesVisibilityChanged() - Method in class org.jfree.chart.event.RendererChangeEvent
Returns the flag that indicates whether or not the event relates to a change in series visibility.
getSeriesVisible(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the flag that controls whether a series is visible.
getSeriesVisible() - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.getSeriesVisible(int) and AbstractRenderer.getBaseSeriesVisible().
getSeriesVisible() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.getSeriesVisible(int) and CategoryItemRenderer.getBaseSeriesVisible().
getSeriesVisible(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the flag that controls whether a series is visible.
getSeriesVisible(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the flag that controls whether a series is visible.
getSeriesVisible() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.getSeriesVisible(int) and XYItemRenderer.getBaseSeriesVisible().
getSeriesVisibleInLegend(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the flag that controls whether a series is visible in the legend.
getSeriesVisibleInLegend() - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.getSeriesVisibleInLegend(int) and AbstractRenderer.getBaseSeriesVisibleInLegend().
getSeriesVisibleInLegend() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.getSeriesVisibleInLegend(int) and CategoryItemRenderer.getBaseSeriesVisibleInLegend().
getSeriesVisibleInLegend(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the flag that controls whether a series is visible in the legend.
getSeriesVisibleInLegend(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the flag that controls whether a series is visible in the legend.
getSeriesVisibleInLegend() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.getSeriesVisibleInLegend(int) and XYItemRenderer.getBaseSeriesVisibleInLegend().
getSeriesWidth() - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the width of the interval for each series this dataset.
getSettings() - Method in class fitter.Fitter
Get all settings
getSettings() - Method in class fitter.SEditor
 
getSettings(XMLWrite) - Method in class jhplot.shapes.HShape
Returns the settings of the primitive in a XML instance.
GetSettings() - Static method in class jminhep.clcontrol.Global
 
getSettings(XMLWrite, String) - Method in class jplot.DataFile
Adds the settings of this panel to the XML settings toolbox.
getSettings(XMLWrite) - Method in class jplot.GraphLabel
Returns the settings of the current label in a XML instance.
getSettings(XMLWrite) - Method in class jplot.GraphSettings
Writes the current parameter settings to a File stream.
getSettings(XMLWrite) - Method in class jplot.LinePars
This function is called when writing a script file of the current settings.
getSettings() - Method in class jplot.XMLWrite
Returns the settings currently added to the buffer in a string
getShadow() - Method in class jhplot.HPlot
Returns whether or not a shadow will be drawn at the panel border.
getShadowColor() - Method in class org.jfree.chart.util.DefaultShadowGenerator
Returns the shadow color.
getShadowGenerator() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the shadow generator for the plot, if any.
getShadowGenerator() - Method in class org.jfree.chart.plot.PiePlot
Returns the shadow generator for the plot, if any.
getShadowGenerator() - Method in class org.jfree.chart.plot.XYPlot
Returns the shadow generator for the plot, if any.
getShadowOpacity() - Method in class org.jfree.chart.util.DefaultShadowGenerator
Returns the shadow opacity.
getShadowPaint() - Method in class org.jfree.chart.plot.PiePlot
Returns the shadow paint.
getShadowPaint() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the shadow paint.
getShadowPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the shadow paint.
getShadowSize() - Method in class org.jfree.chart.util.DefaultShadowGenerator
Returns the shadow size.
getShadowsVisible() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the flag that controls whether or not shadows are drawn for the bars.
getShadowsVisible() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the flag that controls whether or not shadows are drawn for the bars.
getShadowXOffset() - Method in class org.jfree.chart.plot.PiePlot
Returns the x-offset for the shadow effect.
getShadowXOffset() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the shadow x-offset.
getShadowXOffset() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the shadow x-offset.
getShadowYOffset() - Method in class org.jfree.chart.plot.PiePlot
Returns the y-offset for the shadow effect.
getShadowYOffset() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the shadow y-offset.
getShadowYOffset() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns the shadow y-offset.
getShape() - Method in interface hep.lcio.event.Cluster
Shape parameters - check/set collection parameter ClusterShapeParameters for size and names of parameters.
getShape() - Method in class hep.lcio.implementation.event.ICluster
 
getShape() - Method in class jhplot.math.num.pdf.Weibull
Access the shape parameter.
getShape() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Returns the shape parameter of this distribution.
getShape() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Returns the shape parameter of this distribution.
getShape() - Method in class org.apache.commons.math3.distribution.NakagamiDistribution
Access the shape parameter, mu.
getShape() - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Returns the shape parameter of this distribution.
getShape() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Access the shape parameter, alpha.
getShape() - Method in class org.jfree.chart.LegendItem
Returns the shape used to label the series represented by this legend item.
getShape() - Method in class org.jfree.chart.title.LegendGraphic
Returns the shape.
getShapeAnchor() - Method in class org.jfree.chart.title.LegendGraphic
Returns the shape anchor.
getShapeCoords() - Method in class org.jfree.chart.entity.ChartEntity
Returns the shape coordinates as a string.
getShapeLocation() - Method in class org.jfree.chart.title.LegendGraphic
Returns the shape location.
getShapePaint() - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Returns the paint used for rendering shapes, or null if using series paints.
getShapesFilled() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Deprecated.
As of 1.0.7 (the override facility is unnecessary, just use the per-series and base (default) settings).
getShapesFilled() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Deprecated.
As of 1.0.8, you should avoid using this method and rely on just the per-series (StandardXYItemRenderer.getSeriesShapesFilled(int)) and base-level (StandardXYItemRenderer.getBaseShapesFilled()) settings.
getShapeStroke() - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Returns the stroke used for rendering shapes, or null if using series strokes.
getShapesVisible() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Deprecated.
As of 1.0.7 (the override facility is unnecessary, just use the per-series and base (default) settings).
getShapesVisible() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns true if a shape will be drawn for every item, or false if not.
getShapesVisible() - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Returns a flag that controls whether or not shapes are drawn for each data value.
getShapesVisible() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Deprecated.
As of 1.0.7, use the per-series and base level settings.
getShapesVisible() - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Returns true if shapes are being plotted by the renderer.
getShapeType() - Method in class org.jfree.chart.entity.ChartEntity
Returns a string describing the entity area.
getSharedAxisStates() - Method in class org.jfree.chart.plot.PlotState
Returns a map containing the shared axis states.
getShortProperty(String) - Method in class hep.lcio.util.SIODump.Resolver
 
getShowAxisLocation() - Method in class org.jfree.chart.plot.JThermometer
Returns the location for the axis.
getShowValueLines() - Method in class org.jfree.chart.plot.ThermometerPlot
Deprecated.
This flag doesn't do anything useful/visible. Deprecated as of version 1.0.6.
getShowZeroDays() - Method in class org.jfree.chart.util.RelativeDateFormat
Returns the flag that controls whether or not zero day counts are shown in the formatted output.
getShowZeroHours() - Method in class org.jfree.chart.util.RelativeDateFormat
Returns the flag that controls whether or not zero hour counts are shown in the formatted output.
getSide() - Method in class org.apache.commons.math3.geometry.partitioning.SubHyperplane.SplitSubHyperplane
Get the side of the split sub-hyperplane with respect to its splitter.
getSide() - Method in class org.apache.commons.math3.geometry.spherical.oned.ArcsSet.Split
Get the side of the split arc with respect to its splitter.
getSigma(double) - Method in class org.apache.commons.math3.fitting.leastsquares.AbstractEvaluation
Get an estimate of the standard deviation of the parameters.
getSigma(double) - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresProblem.Evaluation
Get an estimate of the standard deviation of the parameters.
getSigma() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer.Sigma
 
getSigma() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer.Sigma
Deprecated.
 
getSigma() - Method in class org.apache.commons.math3.random.ValueServer
Returns the standard deviation used when operating in ValueServer.GAUSSIAN_MODE.
getSigmaSlices() - Method in class org.jlab.groot.fitter.ParallelSliceFitter
 
getSignal() - Method in class jhplot.stat.DataSource
Get data for signal
getSignificance() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the significance level of the slope (equiv) correlation.
getSignificantFigures(List<Double>) - Method in class org.jlab.groot.graphics.GraphicsAxis.GraphicsAxisTicks
 
getSignificantFigures(List<Double>) - Method in class org.jlab.groot.ui.GraphicsAxisLabels
calculates significant figures between two end points.
getSimpleLabelOffset() - Method in class org.jfree.chart.plot.PiePlot
Returns the offset used for the simple labels, if they are displayed.
getSimpleLabels() - Method in class org.jfree.chart.plot.PiePlot
Returns the flag that controls whether simple or extended labels are displayed on the plot.
getSimulatorStatus() - Method in interface hep.lcio.event.MCParticle
Returns the status for particles from the simulation, e.g.
getSimulatorStatus() - Method in class hep.lcio.implementation.event.IMCParticle
 
getSinElevationAngle() - Method in class jplot3d.Projector
Gets the sine of elevation angle.
getSingularValues() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the diagonal of S, which is a one-dimensional array of singular values
getSingularValues() - Method in class Jama.SingularValueDecomposition
Return the one-dimensional array of singular values
getSingularValues() - Method in class jhplot.math.SingularValueDecomposition
Return the one-dimensional array of singular values
getSingularValues() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the diagonal elements of the matrix Σ of the decomposition.
getSinRotationAngle() - Method in class jplot3d.Projector
Gets the sine of rotation angle.
getSize() - Method in class jhplot.math.num.DoubleArray
Access the size of this array.
getSize() - Method in class jhplot.stat.DataKeeper
Get the size of container
getSize() - Method in class jminhep.algorithms.FuzzyCMeansAlg
This method returns the estimated size (steps) for this task.
getSize() - Method in class jminhep.algorithms.KMeansAlg
This method returns the estimated size (steps) for this task.
getSize() - Method in class jminhep.cluster.DataHolder
Get size of the data holder
getSize() - Method in class net.java.dev.colorchooser.Palette
Get the on-screen size of this palette
getSize() - Method in class org.apache.commons.io.input.NullInputStream
Return the size this InputStream emulates.
getSize() - Method in class org.apache.commons.io.input.NullReader
Returns the size this Reader emulates.
getSize() - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the array size required for holding partial derivatives data.
getSize() - Method in class org.apache.commons.math3.analysis.interpolation.InterpolatingMicrosphere
Get the size of the sphere.
getSize() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Get the size of the interval.
getSize() - Method in class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
Get the size of the instance.
getSize() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Get the size of the instance.
getSize() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Get the size of the instance.
getSize() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Get the size of the instance.
getSize() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Get the size of the instance.
getSize() - Method in class org.apache.commons.math3.geometry.spherical.oned.Arc
Get the angular size of the arc.
getSize() - Method in class org.apache.commons.math3.geometry.spherical.oned.SubLimitAngle
Get the size of the instance.
getSize() - Method in class org.apache.commons.math3.ml.neuralnet.Neuron
Gets the length of the feature set.
getSize() - Method in class org.apache.commons.math3.ml.neuralnet.oned.NeuronString
Gets the number of neurons.
getSize() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get simplex size.
getSize() - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated.
Get simplex size.
getSize() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Get the total number of elements.
getSize() - Method in class org.jfree.chart.axis.TickUnit
Returns the size of the tick unit.
getSize() - Method in class org.jfree.chart.needle.MeterNeedle
Returns the size.
getSize() - Method in class org.jlab.groot.data.DataVector
Returns the number of entries in the vector
getSize(Graphics2D, boolean) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getSize(Graphics2D, boolean) - Method in class org.jlab.groot.ui.GraphicsAxis
 
getSizes() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Get the number of multidimensional counter slots in each dimension.
getSizeX() - Method in class jhplot.gui.GHMargin
Get the size of this margin panel in X
getSizeX() - Method in class jhplot.gui.GHPanel
Get the width of the main panel which keeps all margins and the central panel (in pixels)
getSizeY() - Method in class jhplot.gui.GHMargin
Get the size of this margin in Y
getSizeY() - Method in class jhplot.gui.GHPanel
Get the height of the main panel which keeps all margins and the central panel (in pixels)
getSkewness() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the skewness of the available values.
getSkewnessImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured skewness implementation.
getSlicesCardinals() - Method in class jhplot.math.Slicing
 
getSlicesCenters() - Method in class jhplot.math.Slicing
 
getSlicesIndexes() - Method in class jhplot.math.Slicing
 
getSlicesWidths() - Method in class jhplot.math.Slicing
 
getSlicesX() - Method in class org.jlab.groot.data.H2F
 
getSlicesY() - Method in class org.jlab.groot.data.H2F
 
getSlicingMatrix() - Method in class jhplot.math.Slicing
 
getSlope() - Method in class jhplot.stat.LinReg
Get slope
getSlope() - Method in class jhplot.stat.LinRegWeighted
Get slope
getSlope() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the slope of the estimated regression line.
getSlope() - Method in class org.jfree.data.function.LineFunction2D
Returns the 'b' coefficient that was specified in the constructor.
getSlope(Number[], Number[]) - Static method in class org.jfree.data.statistics.Statistics
Finds the slope of a regression line using least squares.
getSlopeConfidenceInterval() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the half-width of a 95% confidence interval for the slope estimate.
getSlopeConfidenceInterval(double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the half-width of a (100-100*alpha)% confidence interval for the slope estimate.
getSlopeError() - Method in class jhplot.stat.LinReg
Get the standard error on slope
getSlopeError() - Method in class jhplot.stat.LinRegWeighted
Get the standard error on slope
getSlopeStdErr() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the standard error of the slope estimate, usually denoted s(b1).
getSmallest() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Deprecated.
Get the node whose element is the smallest one in the tree.
getSmallestValue() - Method in class org.jfree.chart.axis.LogAxis
Returns the smallest value represented by the axis.
getSmallFont() - Method in class org.jfree.chart.StandardChartTheme
Returns the small font.
getSmoothed(boolean, int) - Method in class jhplot.utils.SHisto
Computes a smoothed version of the histogram.
getSolution() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Returns the current estimate of the solution to the linear system to be solved.
getSolution() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Returns the current estimate of the solution to the linear system to be solved.
getSolution() - Method in class org.apache.commons.math3.optim.linear.SolutionCallback
Retrieve the best solution found so far.
getSolver() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in class org.apache.commons.math3.linear.LUDecomposition
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in class org.apache.commons.math3.linear.QRDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - Method in class org.apache.commons.math3.linear.RRQRDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSortedValues() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the current set of values in an array of double primitives, sorted in ascending order.
getSortOrder() - Method in class org.jfree.chart.title.LegendTitle
Gets the order used to display legend items.
getSourceDirectory() - Method in class org.apache.commons.io.file.CopyDirectoryVisitor
Gets the source directory.
getSources() - Method in class org.jfree.chart.title.LegendTitle
Returns the legend item sources.
getSourceString() - Method in class org.apache.commons.math3.exception.util.DummyLocalizable
Gets the source (non-localized) string.
getSourceString() - Method in interface org.apache.commons.math3.exception.util.Localizable
Gets the source (non-localized) string.
getSourceString() - Method in enum org.apache.commons.math3.exception.util.LocalizedFormats
Gets the source (non-localized) string.
getSpace() - Method in class org.apache.commons.io.input.buffer.CircularByteBuffer
Returns the number of bytes, that can currently be added to the buffer.
getSpace() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the space to which the point belongs.
getSpace() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the space to which the point belongs.
getSpace() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the space to which the point belongs.
getSpace() - Method in interface org.apache.commons.math3.geometry.Point
Get the space to which the point belongs.
getSpace() - Method in class org.apache.commons.math3.geometry.spherical.oned.S1Point
Get the space to which the point belongs.
getSpace() - Method in class org.apache.commons.math3.geometry.spherical.twod.S2Point
Get the space to which the point belongs.
getSpaceparity() - Method in class hephysics.particle.HEParticle
get P space parity
getSpaces(int) - Static method in class jminhep.algorithms.HierarchicalAlg
 
getSpaces(int) - Static method in class jminhep.utils.VEC
 
getSparsity() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
 
getSpin() - Method in interface hep.lcio.event.MCParticle
Returns the spin (helicity) vector of the particle.
getSpin() - Method in class hep.lcio.implementation.event.IMCParticle
 
getSpin() - Method in class hephysics.particle.HEParticle
Get J total spin
getSplitters() - Method in class org.apache.commons.math3.geometry.partitioning.BoundaryAttribute
Get the sub-hyperplanes that were used to split the boundary part.
getSqr2() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant √2.
getSqr2Reciprocal() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant √2 / 2.
getSqr2Split() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant √2 split in two pieces.
getSqr3() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant √3.
getSqr3Reciprocal() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant √3 / 3.
getSquareRoot() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Computes the square-root of the matrix.
getSSE() - Method in class jhplot.stat.LinReg
Get SSE value
getSSR() - Method in class jhplot.stat.LinReg
Ger SSR value
getStagger() - Method in class org.jfree.chart.renderer.category.CategoryStepRenderer
Returns the flag that controls whether the series steps are staggered.
getStandardDeviation() - Method in class jhplot.math.num.pdf.LogNormal
Access the standard deviation.
getStandardDeviation() - Method in class jhplot.math.num.pdf.Normal
Access the standard deviation.
getStandardDeviation() - Method in class jhplot.utils.SHisto
Returns the standard deviation for all bands of the histogram.
getStandardDeviation() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Access the standard deviation.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the standard deviation of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getStandardDeviation() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the standard deviation of the ith entries of the arrays that correspond to each multivariate sample
getStandardDeviation() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the standard deviation of the values that have been added.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the standard deviation of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the standard deviation of the values that have been added.
getStandardDeviation() - Method in class org.jfree.data.function.NormalDistributionFunction2D
Returns the standard deviation for the function.
getStandardDeviation() - Method in class org.jfree.data.statistics.MeanAndStandardDeviation
Returns the standard deviation.
getStandardDeviations() - Method in class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Gets the square root of each element on the diagonal of the covariance matrix.
getStandardDeviationValue() - Method in class org.jfree.data.statistics.MeanAndStandardDeviation
Returns the standard deviation as a double primitive.
getStandardTickUnits() - Method in class org.jfree.chart.axis.ValueAxis
Returns the source for obtaining standard tick units for the axis.
getStart() - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresAdapter
Gets the initial guess.
getStart() - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresProblem
Gets the initial guess.
getStart() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Segment
Get the start point of the segment.
getStart() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Segment
Get the start point of the segment.
getStart() - Method in class org.apache.commons.math3.geometry.spherical.twod.Edge
Get start vertex.
getStart() - Method in class org.jfree.data.time.RegularTimePeriod
Returns the date/time that marks the start of the time period.
getStart() - Method in class org.jfree.data.time.SimpleTimePeriod
Returns the start date/time.
getStart() - Method in interface org.jfree.data.time.TimePeriod
Returns the start date/time.
getStartAngle() - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Returns the start angle.
getStartAngle() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the start angle for the scale (in degrees using the same orientation as Java's Arc2D class).
getStartAngle() - Method in class org.jfree.chart.plot.PiePlot
Returns the start angle for the first pie section.
getStartAngle() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the start angle for the first radar axis.
getStartBoundary() - Method in class org.jfree.data.statistics.HistogramBin
Returns the start boundary.
getStartColor() - Method in class jplot.LinePars
Returns the start color of the pen.
getStarterIntegrator() - Method in class org.apache.commons.math3.ode.MultistepFieldIntegrator
Get the starter integrator.
getStarterIntegrator() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Get the starter integrator.
getStartMillis() - Method in class org.jfree.data.time.SimpleTimePeriod
Returns the start date/time in milliseconds.
getStartPercent() - Method in class org.jfree.chart.renderer.category.GanttRenderer
Returns the position of the start of the progress indicator, as a percentage of the bar width.
getStartPoint() - Method in class org.apache.commons.math3.optim.BaseMultivariateOptimizer
Gets the initial guess.
getStartPoint() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.
 
getStartPoint() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated.
Gets the initial values of the optimized parameters.
getStartTime() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns the start time for the timeline.
getStartValue() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
 
getStartValue() - Method in class org.apache.commons.math3.optim.univariate.SearchInterval
Gets the start value.
getStartValue() - Method in class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
 
getStartValue() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.
 
getStartValue() - Method in class org.jfree.chart.plot.IntervalMarker
Returns the start value for the interval.
getStartValue(Comparable, Comparable) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the start data value for one category in a series.
getStartValue(int, int) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the start data value for one category in a series.
getStartValue(int, int) - Method in interface org.jfree.data.category.IntervalCategoryDataset
Returns the start value for the interval for a given series and category.
getStartValue(Comparable, Comparable) - Method in interface org.jfree.data.category.IntervalCategoryDataset
Returns the start value for the interval for a given series and category.
getStartValue(int, int, int) - Method in interface org.jfree.data.gantt.GanttCategoryDataset
Returns the start value of a sub-interval for a given item.
getStartValue(Comparable, Comparable, int) - Method in interface org.jfree.data.gantt.GanttCategoryDataset
Returns the start value of a sub-interval for a given item.
getStartValue(Comparable, Comparable, int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the start value of a sub-interval for a given item.
getStartValue(int, int, int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the start value of a sub-interval for a given item.
getStartValue(Comparable, Comparable) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the start value for the interval for a given series and category.
getStartValue(int, int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the start value for the interval for a given series and category.
getStartValue(Comparable, Comparable) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the start value for a task.
getStartValue(int, int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the start value for a task.
getStartValue(int, int, int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the start value of a sub-interval for a given item.
getStartValue(Comparable, Comparable, int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the start value of a sub-interval for a given item.
getStartVertex() - Method in interface hep.lcio.event.ReconstructedParticle
The start vertex associated to this particle
getStartVertex() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getStartX(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the starting date/time for the specified item (task) in the given series, measured in milliseconds since 1-Jan-1970 (as in java.util.Date).
getStartX(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the starting X value for the specified series and item.
getStartX(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the starting X value for the specified series and item.
getStartX(int, int) - Method in class org.jfree.data.statistics.HistogramDataset
Returns the start value for a bin.
getStartX(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the starting X value for the specified series and item.
getStartX(int, int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the start x-value.
getStartX(int, int) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the starting X value for the specified series and item.
getStartX(int, int) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the starting X value for the specified series and item.
getStartX(int, int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the starting X value for the specified series and item.
getStartX(int, int) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the starting X value for the specified series and item.
getStartX(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the starting x-value for an item within a series.
getStartX(int, int) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the starting X value for the specified series and item.
getStartX(int, int) - Method in interface org.jfree.data.xy.IntervalXYDataset
Returns the lower bound of the x-interval for the specified series and item.
getStartX(int, int) - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns the start value of the x-interval for an item within a series.
getStartX(int, int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the start x-value for an item within a series.
getStartX(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the starting X value for the specified series and item.
getStartX(int, int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the start x-value for an item within a series.
getStartX(int, int) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the starting X value for the specified series and item.
getStartX(int, int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the start x-value for an item within a series.
getStartXValue(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the starting date/time for the specified item (task) in the given series, measured in milliseconds since 1-Jan-1970 (as in java.util.Date).
getStartXValue(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the start x-value (as a double primitive) for an item within a series.
getStartXValue(int, int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the start x-value (as a double primitive) for an item within a series.
getStartXValue(int, int) - Method in class org.jfree.data.xy.AbstractIntervalXYDataset
Returns the start x-value (as a double primitive) for an item within a series.
getStartXValue(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the starting x-value for an item within a series.
getStartXValue(int, int) - Method in interface org.jfree.data.xy.IntervalXYDataset
Returns the lower bound of the x-interval (as a double primitive) for the specified series and item.
getStartXValue(int, int) - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns the start value of the x-interval for an item within a series.
getStartXValue(int, int) - Method in interface org.jfree.data.xy.IntervalXYZDataset
Returns the starting X value for the specified series and item.
getStartXValue(int, int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the start x-value (as a double primitive) for an item within a series.
getStartXValue(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the starting x-value (as a double primitive) for an item within a series.
getStartXValue(int, int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the start x-value (as a double primitive) for an item within a series.
getStartY(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the starting value of the y-interval for an item in the given series.
getStartY(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the starting Y value for the specified series and item.
getStartY(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the starting Y value for the specified series and item.
getStartY(int, int) - Method in class org.jfree.data.statistics.HistogramDataset
Returns the start y-value for a bin (which is the same as the y-value, this method exists only to support the general form of the IntervalXYDataset interface).
getStartY(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the starting Y value for the specified series and item.
getStartY(int, int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the start y-value.
getStartY(int, int) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the starting Y value for the specified series and item.
getStartY(int, int) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the starting Y value for the specified series and item.
getStartY(int, int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the starting Y value for the specified series and item.
getStartY(int, int) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the starting Y value for the specified series and item.
getStartY(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the starting y-value for an item within a series.
getStartY(int, int) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the starting Y value for the specified series and item.
getStartY(int, int) - Method in interface org.jfree.data.xy.IntervalXYDataset
Returns the lower bound of the y-interval for the specified series and item.
getStartY(int, int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the start y-value for an item within a series.
getStartY(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the starting Y value for the specified series and item.
getStartY(int, int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the start y-value for an item within a series.
getStartY(int, int) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the starting Y value for the specified series and item.
getStartY(int, int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the start y-value for an item within a series.
getStartYValue(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the starting value of the y-interval for an item in the given series.
getStartYValue(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the start y-value (as a double primitive) for an item within a series.
getStartYValue(int, int) - Method in class org.jfree.data.xy.AbstractIntervalXYDataset
Returns the start y-value (as a double primitive) for an item within a series.
getStartYValue(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the starting y-value for an item within a series.
getStartYValue(int, int) - Method in interface org.jfree.data.xy.IntervalXYDataset
Returns the lower bound of the y-interval (as a double primitive) for the specified series and item.
getStartYValue(int, int) - Method in interface org.jfree.data.xy.IntervalXYZDataset
Returns the starting Y value for the specified series and item.
getStartYValue(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the starting y-value (as a double primitive) for an item within a series.
getStartYValue(int, int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the start y-value (as a double primitive) for an item within a series.
getStartYValue(int, int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the start y-value (as a double primitive) for an item within a series.
getStartZValue(int, int) - Method in interface org.jfree.data.xy.IntervalXYZDataset
Returns the starting Z value for the specified series and item.
getStat() - Method in class jhplot.H1D
Calculate complete statistics for this histogram.
getStat() - Method in class jhplot.H2D
Calculate complete statistics for this histogram for the X or Y Unlike other methods (like mean or rms), it performs calculations on the existing histogram, thus the method is somewhat slow.
getStat() - Method in class jhplot.P0D
Get complete statistics for this container.
getStat() - Method in class jhplot.P0I
Get complete statistics for this container.
getStat(int) - Method in class jhplot.P1D
Get complete statistics for this container for a given axis.
getStatBox() - Method in class org.jlab.groot.data.GraphErrors
 
getStatBox() - Method in class org.jlab.groot.data.H1F
 
getStatBox() - Method in class org.jlab.groot.data.H2F
 
getStatBox() - Method in interface org.jlab.groot.data.IDataSet
 
getStatBox() - Method in class org.jlab.groot.math.Func1D
 
getStatBoxFont() - Method in class org.jlab.groot.base.PadAttributes
 
getStatBoxFontSize() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getStatBoxOffsetX() - Method in class org.jlab.groot.base.PadAttributes
 
getStatBoxOffsetY() - Method in class org.jlab.groot.base.PadAttributes
 
getState() - Method in class org.apache.commons.math3.ode.FieldODEState
Get main state at time.
getState_post() - Method in class jhplot.math.kalman.JKalman
 
getState_pre() - Method in class jhplot.math.kalman.JKalman
Getter
getStateDimension() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns the dimension of the state estimation vector.
getStateDimension() - Method in class org.apache.commons.math3.ode.FieldODEState
Get main state dimension.
getStateEstimation() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns the current state estimation vector.
getStateEstimationVector() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns a copy of the current state estimation vector.
getStateTransitionMatrix() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
Returns the state transition matrix.
getStateTransitionMatrix() - Method in interface org.apache.commons.math3.filter.ProcessModel
Returns the state transition matrix.
getStatistic() - Method in class jhplot.stat.ConfidenceLevel
 
getStatisticsDHistory() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
 
getStatisticsDHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
 
getStatisticsFitnessHistory() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
 
getStatisticsFitnessHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
 
getStatisticsMeanHistory() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
 
getStatisticsMeanHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
 
getStatisticsSigmaHistory() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
 
getStatisticsSigmaHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.
 
getStatParameters() - Method in class jhplot.H1D
Get statistical parameters of a Histogram as a list of strings
getStatString() - Method in class jhplot.P0D
Returns a string representing statistics.
getStatString() - Method in class jhplot.P0I
Get string with all statistics
getStatText() - Method in class org.jlab.groot.data.H1F
 
getStatus() - Method in class hephysics.particle.HEParticle
Status Monte Carlo code
getStatus(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
getStatus(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 status = 3 [packed = true];
getStatus(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 status = 3 [packed = true];
getStatus(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
getStatus(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 status = 3 [packed = true];
getStatus(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 status = 3 [packed = true];
getStatus(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
getStatus(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 status = 3 [packed = true];
getStatus(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 status = 3 [packed = true];
getStatusCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
getStatusCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 status = 3 [packed = true];
getStatusCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 status = 3 [packed = true];
getStatusCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
getStatusCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 status = 3 [packed = true];
getStatusCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 status = 3 [packed = true];
getStatusCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
getStatusCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 status = 3 [packed = true];
getStatusCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 status = 3 [packed = true];
getStatusList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
getStatusList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated uint32 status = 3 [packed = true];
getStatusList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 status = 3 [packed = true];
getStatusList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
getStatusList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 status = 3 [packed = true];
getStatusList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 status = 3 [packed = true];
getStatusList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
getStatusList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 status = 3 [packed = true];
getStatusList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 status = 3 [packed = true];
getStd(int) - Method in class jhplot.stat.PCA
Get standard deviations
getStdDev(Number[]) - Static method in class org.jfree.data.statistics.Statistics
Returns the standard deviation of a set of numbers.
getStdDevValue(int, int) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the standard deviation value for an item.
getStdDevValue(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the standard deviation value for an item.
getStdDevValue(int, int) - Method in interface org.jfree.data.statistics.StatisticalCategoryDataset
Returns the standard deviation value for an item.
getStdDevValue(Comparable, Comparable) - Method in interface org.jfree.data.statistics.StatisticalCategoryDataset
Returns the standard deviation value for an item.
getStdErrorOfEstimate(int) - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the standard error of the parameter estimate at index, usually denoted s(bindex).
getStdErrorOfEstimates() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the standard error of the parameter estimates, usually denoted s(bi).
getStep() - Method in class org.jlab.groot.math.UserParameter
 
getStepHandlers() - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Get all the step handlers that have been added to the integrator.
getStepHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get all the step handlers that have been added to the integrator.
getStepHandlers() - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Get all the step handlers that have been added to the integrator.
getStepHandlers() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get all the step handlers that have been added to the integrator.
getStepPoint() - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Returns the fraction of the domain position between two points on which the step is drawn.
getStepPoint() - Method in class org.jfree.chart.renderer.xy.XYStepRenderer
Returns the fraction of the domain position between two points on which the step is drawn.
getStepPosition(int) - Method in interface hep.lcio.event.SimCalorimeterHit
Returns the position where the energy deposited (step) occurred optional, only if bit LCIO::CHBIT_STEP is set.
getStepPosition(int) - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
getStepSize() - Method in class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Get the step size.
getStepX() - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
getStepX() - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
getStepY() - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
getStepY() - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
getStirlingError(double) - Static method in class jhplot.math.num.pdf.SaddlePoint
Compute the error of Stirling's series at the given value.
getStream(String) - Static method in class jhplot.io.ArrayReaderWriter
Create a stream to the file specified by filename.
getStrict() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
 
getStrictValuesFlag() - Method in class org.jfree.chart.axis.LogarithmicAxis
Returns the 'strictValuesFlag' flag; if true and 'allowNegativesFlag' is false then this axis will throw a runtime exception if any of its values are less than or equal to zero; if false then the axis will adjust for values less than or equal to zero as needed.
getString() - Method in class jhplot.gui.GHMargin
Get the title of this panel
getString(String, String) - Static method in class jminhep.utils.ResourceLoader
 
getString(String, String) - Method in class jplot.XMLRead
Returns the value of a string element.
getString(AttributeType) - Method in class org.jlab.groot.base.Attributes
 
getStringKeys() - Method in interface hep.lcio.event.LCParameters
Returns a list of all keys of string parameters.
getStringKeys() - Method in class hep.lcio.implementation.event.ILCParameters
 
getStringPositionX() - Method in class jhplot.gui.GHMargin
Get the text position in X relative to widths
getStringPositionY() - Method in class jhplot.gui.GHMargin
Get the text position in Y relative to the frame height.
getStringProperty(String) - Method in class hep.lcio.util.SIODump.Resolver
 
getStringVal(String) - Method in interface hep.lcio.event.LCParameters
Returns the first string value for the given key.
getStringVal(String) - Method in class hep.lcio.implementation.event.ILCParameters
 
getStringVals(String) - Method in interface hep.lcio.event.LCParameters
Returns values for the given key.
getStringVals(String) - Method in class hep.lcio.implementation.event.ILCParameters
 
getStringValues() - Method in class jhplot.P0D
Return all values as a string.
getStringValues() - Method in class jhplot.P0I
Return all values as a string.
getStripOutlinePaint() - Method in class org.jfree.chart.title.PaintScaleLegend
Returns the paint used to draw the outline of the paint strip.
getStripOutlineStroke() - Method in class org.jfree.chart.title.PaintScaleLegend
Returns the stroke used to draw the outline around the paint strip.
getStripWidth() - Method in class org.jfree.chart.title.PaintScaleLegend
Returns the width of the paint strip, in Java2D units.
getStroke() - Method in class jhplot.shapes.HShape
Get the Stroke to a specific value
getStroke() - Method in class jplot.DataArray
Returns the stroke used to plot these points.
getStroke(String, BasicStroke) - Method in class jplot.XMLRead
Returns Stroke
getStroke() - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Returns the stroke used to draw the connecting line.
getStroke() - Method in class org.jfree.chart.block.LineBorder
Returns the stroke.
getStroke() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the current stroke (this attribute is used when drawing shapes).
getStroke() - Method in class org.jfree.chart.plot.Crosshair
Returns the stroke for the crosshair line.
getStroke() - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Returns the stroke.
getStroke() - Method in class org.jfree.chart.plot.dial.DialPointer.Pin
Returns the stroke.
getStroke() - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Returns the stroke for the frame.
getStroke() - Method in class org.jfree.chart.plot.Marker
Returns the stroke.
getStroke(Comparable) - Method in class org.jfree.chart.StrokeMap
Returns the stroke associated with the specified key, or null.
getStroke(int) - Static method in class org.jlab.groot.base.GStyle
 
getStyle() - Static method in class org.jlab.groot.base.TStyle
 
getStyleChooser() - Method in class jplot.JPlot
 
getSubdetectorEnergies() - Method in interface hep.lcio.event.Cluster
A vector that holds the energy observed in a particular subdetectors.
getSubdetectorEnergies() - Method in class hep.lcio.implementation.event.ICluster
 
getSubdetectorHitNumbers() - Method in interface hep.lcio.event.Track
A vector that holds the number of hits in particular subdetectors.
getSubdetectorHitNumbers() - Method in class hep.lcio.implementation.event.ITrack
 
getSubdivisionCount() - Method in class org.jfree.chart.title.PaintScaleLegend
Returns the number of subdivisions used to draw the scale.
getSubHandlers() - Method in class org.jfree.data.xml.RootHandler
Returns the stack of sub handlers.
getSubIntervalCount(int, int) - Method in interface org.jfree.data.gantt.GanttCategoryDataset
Returns the number of sub-intervals for a given item.
getSubIntervalCount(Comparable, Comparable) - Method in interface org.jfree.data.gantt.GanttCategoryDataset
Returns the number of sub-intervals for a given item.
getSubIntervalCount(Comparable, Comparable) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the number of sub-intervals for a given item.
getSubIntervalCount(int, int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the number of sub-intervals for a given item.
getSubIntervalCount(int, int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the number of sub-intervals for a given item.
getSubIntervalCount(Comparable, Comparable) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the number of sub-intervals for a given item.
getSubLabelFont() - Method in class org.jfree.chart.axis.ExtendedCategoryAxis
Returns the font for the sublabels.
getSubLabelFont() - Method in class org.jfree.chart.axis.SubCategoryAxis
Returns the font used to display the sub-category labels.
getSubLabelPaint() - Method in class org.jfree.chart.axis.ExtendedCategoryAxis
Returns the paint for the sublabels.
getSubLabelPaint() - Method in class org.jfree.chart.axis.SubCategoryAxis
Returns the paint used to display the sub-category labels.
getSubMatrix(Matrix, int, int, int, int) - Static method in class hep.physics.matrix.MatrixOp
Extract part of a matrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get a submatrix.
getSubMatrix(int[], int[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get a submatrix.
getSubMatrix(int[], int[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get a submatrix.
getSubMatrix(int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Gets a submatrix.
getSubMatrixRangeCopy(double[][], int, int, int, int) - Static method in class jhplot.math.DoubleArray
Carve out a submatrix from the input matrix and return a copy.
getSubMatrixRangeCopy(int[][], int, int, int, int) - Static method in class jhplot.math.IntegerArray
 
getSubplotCount() - Method in class org.jfree.chart.plot.PlotRenderingInfo
Returns the number of subplots (possibly zero).
getSubplotIndex(Point2D) - Method in class org.jfree.chart.plot.PlotRenderingInfo
Returns the index of the subplot that contains the specified (x, y) point (the "source" point).
getSubplotInfo(int) - Method in class org.jfree.chart.plot.PlotRenderingInfo
Returns the info for a subplot.
getSubplots() - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Returns the list of subplots.
getSubplots() - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Returns the list of subplots.
getSubplots() - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Returns the list of subplots.
getSubplots() - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Returns the list of subplots.
getSubrangePaint(int) - Method in class org.jfree.chart.plot.ThermometerPlot
Gets the paint used for a particular subrange.
getSubSpace() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D
Get the n-1 dimension subspace of this space.
getSubSpace() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Euclidean3D
Get the n-1 dimension subspace of this space.
getSubSpace() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Euclidean2D
Get the n-1 dimension subspace of this space.
getSubSpace() - Method in interface org.apache.commons.math3.geometry.Space
Get the n-1 dimension subspace of this space.
getSubSpace() - Method in class org.apache.commons.math3.geometry.spherical.oned.Sphere1D
Get the n-1 dimension subspace of this space.
getSubSpace() - Method in class org.apache.commons.math3.geometry.spherical.twod.Sphere2D
Get the n-1 dimension subspace of this space.
getSubsPoly() - Method in class org.lsmp.djep.groupJep.groups.AlgebraicExtension
Returns the polynomial -a_(n-1) t^(n-1) + ...
getSubtask(int) - Method in class org.jfree.data.gantt.Task
Returns a sub-task.
getSubtaskCount() - Method in class org.jfree.data.gantt.Task
Returns the sub-task count.
getSubTicLength(int) - Method in class jhplot.HPlot
Returns the length of the sub-ticks.
getSubTicLength(int) - Method in class jplot.GraphSettings
Returns the subtic length of the tics.
getSubTicNumber(int) - Method in class jhplot.HPlot
Get the number of subticks for a given axis
getSubTicNumber(int) - Method in class jplot.GraphSettings
Returns the number of subtics.
getSubtitle(int) - Method in class org.jfree.chart.JFreeChart
Returns a chart subtitle.
getSubtitleCount() - Method in class org.jfree.chart.JFreeChart
Returns the number of titles for the chart.
getSubtitlePaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the subtitle paint.
getSubtitles() - Method in class org.jfree.chart.JFreeChart
Returns the list of subtitles for the chart.
getSubTotal(int, int, int) - Method in class jhplot.utils.SHisto
Returns the total bin count for the specified sub-range (via "min" and "max" bin) of the indicated band.
getSubtract() - Method in class org.nfunk.jep.OperatorSet
 
getSubVector(int, int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in interface org.apache.commons.math3.linear.FieldVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in class org.apache.commons.math3.linear.RealVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Get a subvector from consecutive elements.
GetSuffix(int) - Method in class jplot3dp.MathParser.SimpleCharStream
 
getSuffix() - Method in class org.apache.commons.math3.geometry.VectorFormat
Get the format suffix.
getSuffix() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format suffix.
getSuffix() - Method in class org.apache.commons.math3.linear.RealVectorFormat
Get the format suffix.
GetSuffix(int) - Method in class org.nfunk.jep.JavaCharStream
 
getSum() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the sum of the values that have been added to Univariate.
getSum() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the sum of the values that have been added to Univariate.
getSum() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSum() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the sum of the ith entries of the arrays that correspond to each multivariate sample
getSum() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the sum of the values that have been added to Univariate.
getSum() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getSum() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the sum of the values that have been added
getSum() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the sum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSum() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the sum of the values that have been added
getSumFreq() - Method in class org.apache.commons.math3.stat.Frequency
Returns the sum of all frequencies.
getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured sum implementation.
getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured Sum implementation
getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured Sum implementation
getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured Sum implementation
getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured Sum implementation
getSumLog() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of logs of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumLog() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the sum of logs of the ith entries of the arrays that correspond to each multivariate sample
getSumLog() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the sum of logs of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured sum of logs implementation
getSummary() - Method in class jhplot.stat.PCA
Return projection vectors and information per projection vector.
getSummary() - Method in class jhplot.stat.StatShape
Return all shape parameters
getSummary() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Return a StatisticalSummaryValues instance reporting current aggregate statistics.
getSummary() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Return a StatisticalSummaryValues instance reporting current statistics.
getSummary() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Return a StatisticalSummaryValues instance reporting current statistics.
getSummary(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double summary = 9 [packed = true];
getSummary(int) - Method in class promc.io.PBufFile.Record.H2D
repeated double summary = 9 [packed = true];
getSummary(int) - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double summary = 9 [packed = true];
getSummaryCount() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double summary = 9 [packed = true];
getSummaryCount() - Method in class promc.io.PBufFile.Record.H2D
repeated double summary = 9 [packed = true];
getSummaryCount() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double summary = 9 [packed = true];
GetSummaryData(int, int, double[][]) - Static method in class jminhep.utils.VEC
 
getSummaryList() - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double summary = 9 [packed = true];
getSummaryList() - Method in class promc.io.PBufFile.Record.H2D
repeated double summary = 9 [packed = true];
getSummaryList() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
repeated double summary = 9 [packed = true];
getSumOfCrossProducts() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the sum of crossproducts, xi*yi.
getSumOfLogs() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the sum of the logs of all the aggregated data.
getSumOfLogs() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the sum of the logs of the values that have been added.
getSumsq() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the sum of the squares of all the aggregated data.
getSumsq() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the sum of the squares of the available values.
getSumSq() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of squares of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumSq() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the sum of squares of the ith entries of the arrays that correspond to each multivariate sample
getSumsq() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the sum of the squares of the values that have been added.
getSumSq() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the sum of squares of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumsq() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the sum of the squares of the values that have been added.
getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured sum of squares implementation.
getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured sum of squares implementation
getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured sum of squares implementation
getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured sum of squares implementation
getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured sum of squares implementation
getSumSquaredErrors() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the sum of squared errors (SSE) associated with the regression model.
getSumXSquared() - Method in class jhplot.stat.LinReg
Get sun of the square
getSup() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Get the upper bound of the interval.
getSup() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Get the highest value belonging to the instance.
getSup() - Method in class org.apache.commons.math3.geometry.spherical.oned.Arc
Get the upper angular bound of the arc.
getSupport() - Method in class org.apache.commons.math3.geometry.enclosing.EnclosingBall
Get the support points used to define the ball.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.FDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.GeometricDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.GumbelDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.LevyDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.LogisticDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.NakagamiDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.TDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Access the lower bound of the support.
getSupportSize() - Method in class org.apache.commons.math3.geometry.enclosing.EnclosingBall
Get the number of support points used to define the ball.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.FDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.GeometricDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.GumbelDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.LevyDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.LogisticDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.NakagamiDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.TDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Access the upper bound of the support.
getSurfaceColor() - Method in class jplot3d.JSurface
 
getSurfaceModel() - Method in class jhplot.HPlot3D
Get current surface
getSurfaceModel() - Method in class jplot3d.JSurface
Get model
getSurfaceVertex() - Method in interface jplot3d.SurfaceModel
 
getSurfaceVertex() - Method in class jplot3d.SurfaceModelCanvas
 
getSurroundingItems(int, long) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the indices of the two data items surrounding a particular millisecond value.
getSxx() - Method in class jhplot.stat.LinReg
Get Sxx value: sumXsquared - sumX * sumX / n
getSymbol() - Method in class jhplot.DrawOptions
Get current symbol.
getSymbol() - Method in class jhplot.math.exp4j.operator.Operator
Get the operator symbol
getSymbol() - Method in class jplot.LinePars
Returns the symbol type (symbolic constant)
getSymbol() - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
Returns the symbol used to denote the generator.
getSymbol() - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
getSymbol() - Method in class org.nfunk.jep.Operator
returns the symbol used by this operator.
getSymbolColor() - Method in class jhplot.P2D
Get color attribute
getSymbolColor() - Method in class jplot3d.JPoint
Get color.
getSymbols() - Method in class org.jfree.chart.axis.SymbolAxis
Returns an array of the symbols for the axis.
getSymbolShape() - Method in class jhplot.DrawOptions
Return symbol shape as a string.
getSymbolSize() - Method in class jhplot.DrawOptions
Get the size of the symbols
getSymbolSize() - Method in class jhplot.P2D
Get size of the symbols
getSymbolSize() - Method in class jplot.LinePars
Returns the size of the symbol in points
getSymbolSize() - Method in class jplot3d.JPoint
Get symbol size
getSymbolTable() - Method in class org.nfunk.jep.JEP
Returns the symbol table (the list of all variables that the parser recognizes).
getSymbolTable() - Method in class org.nfunk.jep.SymbolTable.StObservable
 
getSys(P1D[]) - Method in class jhplot.P1D
Return P1D array which contains 2nd level errors (or systematic errors) evaluated from an array of P1D data holders.
getSystemFonts() - Static method in class org.jlab.groot.base.FontProperties
 
getSystemFontsArray() - Static method in class org.jlab.groot.base.FontProperties
 
getSyy() - Method in class jhplot.stat.LinReg
Get SYY value: sumYsquared - sumY * sumY / n
getT() - Method in class hephysics.vec.HepLorentzVector
Get time (as t())
getT(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float T = 16 [packed = true];
getT(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float T = 16 [packed = true];
getT(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float T = 16 [packed = true];
getT(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
getT(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 T = 16 [packed = true];
getT(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 T = 16 [packed = true];
getT(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
getT(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 T = 16 [packed = true];
getT(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 T = 16 [packed = true];
getTable() - Static method in class org.jlab.groot.ui.LatexTextTools
 
getTableCellEditorComponent(JTable, Object, boolean, int, int) - Method in class jplot.panels.PanelPlot.ButtonEditor
 
getTableCellRendererComponent(JTable, Object, boolean, boolean, int, int) - Method in class jplot.panels.PanelPlot.LineStyleButtonRenderer
 
getTag() - Method in exception org.apache.commons.io.TaggedIOException
Returns the serializable tag object.
getTags() - Method in class hep.physics.event.BaseEvent
 
getTags() - Method in interface hep.physics.event.HEPEvent
An arbitrary set of tags that can be associated with the event.
getTanLambda() - Method in interface hep.lcio.event.Track
Lambda is the dip angle of the track in r-z at the reference point.
getTanLambda() - Method in interface hep.lcio.event.TrackState
Lambda is the dip angle of the track in r-z at the reference point.
getTanLambda() - Method in class hep.lcio.implementation.event.ITrack
 
getTanLambda() - Method in class hep.lcio.implementation.event.ITrackState
 
getTarget() - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultivariateVectorOptimizer
Deprecated.
Gets the observed values to be matched by the objective vector function.
getTarget() - Method in class org.apache.commons.math3.optim.nonlinear.vector.Target
Deprecated.
Gets the initial guess.
getTarget() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated.
Gets the observed values to be matched by the objective vector function.
getTarget() - Method in class org.apache.commons.math3.optimization.Target
Deprecated.
Gets the initial guess.
getTargetDirectory() - Method in class org.apache.commons.io.file.CopyDirectoryVisitor
Gets the target directory.
getTargetSize() - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultivariateVectorOptimizer
Deprecated.
Gets the number of observed values.
getTasks() - Method in class org.jfree.data.gantt.TaskSeries
Returns an unmodifialble list of the tasks in the series.
getTasks() - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the underlying task series collection that was supplied to the constructor.
getTauTag(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 TauTag = 6 [packed = true];
getTauTag(int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 TauTag = 6 [packed = true];
getTauTag(int) - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 TauTag = 6 [packed = true];
getTauTag(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 TauTag = 6 [packed = true];
getTauTag(int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 TauTag = 6 [packed = true];
getTauTag(int) - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 TauTag = 6 [packed = true];
getTautag(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Tautag = 6 [packed = true];
getTautag(int) - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 Tautag = 6 [packed = true];
getTautag(int) - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 Tautag = 6 [packed = true];
getTauTagCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 TauTag = 6 [packed = true];
getTauTagCount() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 TauTag = 6 [packed = true];
getTauTagCount() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 TauTag = 6 [packed = true];
getTauTagCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 TauTag = 6 [packed = true];
getTauTagCount() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 TauTag = 6 [packed = true];
getTauTagCount() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 TauTag = 6 [packed = true];
getTautagCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Tautag = 6 [packed = true];
getTautagCount() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 Tautag = 6 [packed = true];
getTautagCount() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 Tautag = 6 [packed = true];
getTauTagList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 TauTag = 6 [packed = true];
getTauTagList() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
repeated sint32 TauTag = 6 [packed = true];
getTauTagList() - Method in interface proreco.io.ProMC.ProMCEvent.BLJetsOrBuilder
repeated sint32 TauTag = 6 [packed = true];
getTauTagList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 TauTag = 6 [packed = true];
getTauTagList() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
repeated sint32 TauTag = 6 [packed = true];
getTauTagList() - Method in interface proreco.io.ProMC.ProMCEvent.GenJetsOrBuilder
repeated sint32 TauTag = 6 [packed = true];
getTautagList() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Tautag = 6 [packed = true];
getTautagList() - Method in class proreco.io.ProMC.ProMCEvent.Jets
repeated sint32 Tautag = 6 [packed = true];
getTautagList() - Method in interface proreco.io.ProMC.ProMCEvent.JetsOrBuilder
repeated sint32 Tautag = 6 [packed = true];
getTCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float T = 16 [packed = true];
getTCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float T = 16 [packed = true];
getTCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float T = 16 [packed = true];
getTCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
getTCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 T = 16 [packed = true];
getTCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 T = 16 [packed = true];
getTCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
getTCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 T = 16 [packed = true];
getTCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 T = 16 [packed = true];
getTdsFactor() - Method in class jplot.GraphSettings
Returns the factor used to plot a TDS circle.
getTempDirectory() - Static method in class org.apache.commons.io.FileUtils
Returns a File representing the system temporary directory.
getTempDirectoryPath() - Static method in class org.apache.commons.io.FileUtils
Returns the path to the system temporary directory.
getTempFilePrefix() - Static method in class org.jfree.chart.servlet.ServletUtilities
Returns the prefix for the temporary file names generated by this class.
getTemplateValue() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the template value.
getTempOneTimeFilePrefix() - Static method in class org.jfree.chart.servlet.ServletUtilities
Returns the prefix for "one time" temporary file names generated by this class.
getText() - Method in class graph.TextLine
 
getText() - Method in class jhepsim.mainGUI
Get text from this editor.
getText() - Method in class jhplot.HKey
Get the text of the label.
getText() - Method in class jhplot.HLabel
Get the text of the label.
getText() - Method in class jhplot.HLabelEq
Get the equation text of the label.
getText() - Method in class jhplot.HMLabel
Get text of the label.
getText() - Method in interface jhplot.math.io.StringPrintable
 
getText() - Method in class jhplot.shapes.Text
Get a string with the text.
getText() - Method in class jplot.GraphLabel
 
getText() - Method in class jplot.Utils.CheckBoxWithText
 
getText() - Method in class jplot.Utils.LabeledTextField
 
getText() - Method in class org.jfree.chart.annotations.TextAnnotation
Returns the text for the annotation.
getText() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the text for the annotation.
getText() - Method in class org.jfree.chart.axis.Tick
Returns the text version of the tick value.
getText() - Method in class org.jfree.chart.title.TextTitle
Returns the title text.
getText() - Method in class org.jlab.groot.ui.LatexText
 
getTextAlignment() - Method in class org.jfree.chart.title.TextTitle
Returns the text alignment.
getTextAnchor() - Method in class org.jfree.chart.annotations.TextAnnotation
Returns the text anchor.
getTextAnchor() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the text anchor.
getTextAnchor() - Method in class org.jfree.chart.axis.Tick
Returns the text anchor.
getTextAnchor() - Method in class org.jfree.chart.block.LabelBlock
Returns the text anchor (never null).
getTextAnchor() - Method in class org.jfree.chart.labels.ItemLabelPosition
Returns the text anchor.
getTextAnchor() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the text anchor.
getTextAntiAlias() - Method in class org.jfree.chart.JFreeChart
Returns the current value stored in the rendering hints table for RenderingHints.KEY_TEXT_ANTIALIASING.
getTextBottom() - Method in class jhplot.gui.GHPanel
Get the text of bottom margin.
getTextBottomColor() - Method in class jhplot.gui.GHPanel
Get the color of bottom margin for the text.
getTextBottomColorBack() - Method in class jhplot.gui.GHPanel
Get the background color of bottom margin
getTextBottomFont() - Method in class jhplot.gui.GHPanel
Get the font of bottom margin.
getTextBounds(AttributedString, Graphics2D) - Static method in class org.jfree.chart.util.AttrStringUtils
Returns the bounds for the attributed string.
getTextBounds(String, FontMetrics) - Static method in class org.jfree.chart.util.TextUtils
Returns the bounds for the specified text.
getTextBounds(String, double, double, FontMetrics) - Static method in class org.jfree.chart.util.TextUtils
Returns the bounds for the specified text when it is drawn with the left-baseline aligned to the point (x, y).
getTextColor() - Method in class jplot3d.ColorModelSet
 
getTextColor() - Method in interface jplot3d.SurfaceColor
 
getTextDescent() - Method in class jplot.GraphLabel
Returns the text descent
getTextHeight() - Method in class jplot.GraphLabel
Returns the height of the text of the label
getTextLeft() - Method in class jhplot.gui.GHPanel
Get the text of left margin.
getTextLeftColor() - Method in class jhplot.gui.GHPanel
Get the color of bottom margin for the text.
getTextLeftColorBack() - Method in class jhplot.gui.GHPanel
Get the background color of left margin
getTextLeftFont() - Method in class jhplot.gui.GHPanel
Get the font of left margin.
getTextPosBottomX() - Method in class jhplot.gui.GHPanel
Get the text position in X relative to widths for bottom margin
getTextPosBottomY() - Method in class jhplot.gui.GHPanel
Get the text position in Y relative to widths for bottom margin
getTextPosLeftX() - Method in class jhplot.gui.GHPanel
Get the text position in X relative to widths for left margin
getTextPosLeftY() - Method in class jhplot.gui.GHPanel
Get the text position in Y relative to widths for left margin
getTextPosRightX() - Method in class jhplot.gui.GHPanel
Get the text position in X relative to widths for right margin
getTextPosRightY() - Method in class jhplot.gui.GHPanel
Get the text position in Y relative to widths for right margin
getTextPosTopX() - Method in class jhplot.gui.GHPanel
Get the text position in X relative to widths for top margin
getTextPosTopY() - Method in class jhplot.gui.GHPanel
Get the text position in Y relative to widths for top margin
getTextRight() - Method in class jhplot.gui.GHPanel
Get text of right margin.
getTextRightColor() - Method in class jhplot.gui.GHPanel
Get the color of right margin for the text.
getTextRightColorBack() - Method in class jhplot.gui.GHPanel
Get the background color of right margin
getTextRightFont() - Method in class jhplot.gui.GHPanel
Get the font of right margin.
getTextRotationBottom() - Method in class jhplot.gui.GHPanel
Get the text rotation for bottom margin
getTextRotationLeft() - Method in class jhplot.gui.GHPanel
Get the text rotation for left margin
getTextRotationRight() - Method in class jhplot.gui.GHPanel
Get the text rotation for right margin
getTextRotationTop() - Method in class jhplot.gui.GHPanel
Get the text rotation for top margin
getTextsHeight(Graphics2D) - Method in class org.jlab.groot.graphics.GraphicsAxis.GraphicsAxisTicks
 
getTextString() - Method in class org.jlab.groot.ui.LatexText
 
getTextsWidth(Graphics2D) - Method in class org.jlab.groot.graphics.GraphicsAxis.GraphicsAxisTicks
 
getTextTop() - Method in class jhplot.gui.GHPanel
Get text of top margin (title).
getTextTopColor() - Method in class jhplot.gui.GHPanel
Get the color of top margin for the text.
getTextTopColorBack() - Method in class jhplot.gui.GHPanel
Get the background color of top margin
getTextTopFont() - Method in class jhplot.gui.GHPanel
Get the font of top margin
getTextWidth() - Method in class jplot.GraphLabel
Returns the width of the text of the label
getThermometerPaint() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the paint used to draw the thermometer outline.
getThermometerPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the thermometer paint.
getThermometerStroke() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the stroke used to draw the thermometer outline.
getTheta() - Method in class org.apache.commons.math3.geometry.euclidean.threed.SphericalCoordinates
Get the azimuthal angle in x-y plane.
getTheta() - Method in class org.apache.commons.math3.geometry.spherical.twod.S2Point
Get the azimuthal angle \( \theta \) in the x-y plane.
getThMomPower() - Method in class hep.physics.jet.EventShape
 
getThreshold() - Method in class org.apache.commons.io.output.ThresholdingOutputStream
Returns the threshold, in bytes, at which an event will be triggered.
getThreshold() - Method in exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
 
getThreshold() - Method in exception org.apache.commons.math3.linear.NonSymmetricMatrixException
 
getThrowable() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Get a reference to the exception to which the context relates.
getTicColor(int) - Method in class jhplot.HPlot
Returns the color used by the labels drawn at each tick.
getTicColor(int) - Method in class jplot.GraphSettings
Returns the color used by the labels drawn at each tic.
getTicFont(int) - Method in class jhplot.HPlot
Returns the font used by the labels drawn at each tick.
getTicFont(int) - Method in class jplot.GraphSettings
Returns the font used by the labels drawn at each tic.
getTicFont() - Method in interface jplot3d.SurfaceModel
 
getTicFont() - Method in class jplot3d.SurfaceModelCanvas
 
getTickColor() - Method in class jhplot.HChart
Get color of ticks.
getTickFont() - Method in class jhplot.HChart
Get font of ticks.
getTickLabelFont() - Method in class org.jfree.chart.axis.Axis
Returns the font used for the tick labels (if showing).
getTickLabelFont(Comparable) - Method in class org.jfree.chart.axis.CategoryAxis
Returns the font for the tick label for the given category.
getTickLabelFont() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the font used to draw the tick labels.
getTickLabelFont() - Method in class org.jfree.chart.plot.JThermometer
Returns the tick label font.
getTickLabelFont() - Method in class org.jfree.chart.plot.MeterPlot
Returns the tick label font.
getTickLabelFormat() - Method in class org.jfree.chart.plot.MeterPlot
Returns the tick label format.
getTickLabelFormatter() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the number formatter used to convert the tick label values to strings.
getTickLabelInsets() - Method in class org.jfree.chart.axis.Axis
Returns the insets for the tick labels.
getTickLabelOffset() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the tick label offset.
getTickLabelPaint() - Method in class org.jfree.chart.axis.Axis
Returns the color/shade used for the tick labels.
getTickLabelPaint(Comparable) - Method in class org.jfree.chart.axis.CategoryAxis
Returns the paint for the tick label for the given category.
getTickLabelPaint() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the paint used to draw the tick labels.
getTickLabelPaint() - Method in class org.jfree.chart.plot.MeterPlot
Returns the tick label paint.
getTickLabelPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the tick label paint.
getTickLabelsVisible() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns true if the tick labels should be displayed, and false otherwise.
getTickLabelsVisible() - Method in class org.jfree.chart.plot.MeterPlot
Returns the flag that determines whether or not tick labels are visible.
getTickLength() - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Returns the tick length (in Java2D units).
getTickMarkInsideLength() - Method in class org.jfree.chart.axis.Axis
Returns the inside length of the tick marks.
getTickMarkOutsideLength() - Method in class org.jfree.chart.axis.Axis
Returns the outside length of the tick marks.
getTickMarkPaint() - Method in class org.jfree.chart.axis.Axis
Returns the paint used to draw tick marks (if they are showing).
getTickMarkPosition() - Method in class org.jfree.chart.axis.DateAxis
Returns the tick mark position (start, middle or end of the time period).
getTickMarkStroke() - Method in class org.jfree.chart.axis.Axis
Returns the stroke used to draw tick marks.
getTickPaint() - Method in class org.jfree.chart.plot.MeterPlot
Returns the paint used to draw the ticks around the dial.
getTickRadius() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the radius (as a percentage of the maximum space available) of the outer limit of the tick marks.
getTicks() - Method in class org.jfree.chart.axis.AxisState
Returns the list of ticks.
getTicks() - Method in class org.jlab.groot.ui.GraphicsAxisLabels
 
getTickSize() - Method in class org.jfree.chart.plot.MeterPlot
Returns the tick size (the interval between ticks on the dial).
getTickSize() - Method in class org.jlab.groot.base.AxisAttributes
 
getTickType() - Method in class org.jfree.chart.axis.ValueTick
Returns the tick type (major or minor).
getTickUnit() - Method in class org.jfree.chart.axis.DateAxis
Returns the tick unit for the axis.
getTickUnit() - Method in class org.jfree.chart.axis.LogAxis
Returns the current tick unit.
getTickUnit() - Method in class org.jfree.chart.axis.NumberAxis
Returns the tick unit for the axis.
getTickValues() - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns the tick values.
getTicLength(int) - Method in class jhplot.HPlot
Returns the length of the ticks.
getTicLength(int) - Method in class jplot.GraphSettings
Returns the length of the tics.
getTicOffset() - Method in interface jplot3d.SurfaceModel
 
getTicOffset() - Method in class jplot3d.SurfaceModelCanvas
 
getTicsMirror(int) - Method in class jhplot.HPlot
Returns whether or not we should draw ticks on the mirror axis.
getTicsRotate(int) - Method in class jhplot.HPlot
Returns whether or not we should rotate the ticks.
getTiesStrategy() - Method in class org.apache.commons.math3.stat.ranking.NaturalRanking
Return the TiesStrategy
getTime() - Method in interface hep.lcio.event.CalorimeterHit
Returns the time of the hit in [ns].
getTime() - Method in interface hep.lcio.event.MCParticle
The creation time of the particle in [ns] wrt.
getTime() - Method in interface hep.lcio.event.SimTrackerHit
Returns the time of the hit in [ns].
getTime() - Method in interface hep.lcio.event.TPCHit
Deprecated.
Returns the time of the hit.
getTime() - Method in interface hep.lcio.event.TrackerData
Returns a time measurement associated with the adc values, e.g.
getTime() - Method in interface hep.lcio.event.TrackerHit
The time of the hit in [ns].
getTime() - Method in interface hep.lcio.event.TrackerPulse
The time of the pulse - arbitrary units.
getTime() - Method in interface hep.lcio.event.TrackerRawData
Returns a time measurement associated with the adc values, e.g.
getTime() - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
getTime() - Method in class hep.lcio.implementation.event.IMCParticle
 
getTime() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
getTime() - Method in class hep.lcio.implementation.event.ITPCHit
 
getTime() - Method in class hep.lcio.implementation.event.ITrackerData
 
getTime() - Method in class hep.lcio.implementation.event.ITrackerHit
 
getTime() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getTime() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getTime() - Method in class hep.lcio.implementation.event.ITrackerPulse
 
getTime() - Method in class hep.lcio.implementation.event.ITrackerRawData
 
getTime() - Method in class jminhep.utils.StopWatch
Get the time recorded by this StopWatch object.
getTime() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get current time.
getTime() - Method in class org.apache.commons.math3.ode.FieldODEState
Get time.
getTime(Date) - Method in class org.jfree.chart.axis.SegmentedTimeline
Special method that handles conversion between the Default Time Zone and a UTC time zone with no DST.
getTime() - Method in class org.jfree.data.time.FixedMillisecond
Returns the date/time.
getTimeCont(int) - Method in interface hep.lcio.event.SimCalorimeterHit
Returns the time of the i-th in [ns] contribution to the hit.
getTimeCont(int) - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
getTimeCreation() - Method in class jhplot.io.HBook
Return time of file creation.
getTimeFromLong(long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Converts a date/time value to take account of daylight savings time.
getTimeline() - Method in class org.jfree.chart.axis.DateAxis
Returns the underlying timeline used by this axis.
getTimePeriod(int) - Method in class org.jfree.data.time.TimePeriodValues
Returns the time period at the specified index.
getTimePeriod(int) - Method in class org.jfree.data.time.TimeSeries
Returns the time period at the specified index.
getTimePeriod(int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the time period for the specified item.
getTimePeriodClass() - Method in class org.jfree.data.time.TimeSeries
Returns the time period class for this series.
getTimePeriods() - Method in class org.jfree.data.time.TimeSeries
Returns a collection of all the time periods in the time series.
getTimePeriodsUniqueToOtherSeries(TimeSeries) - Method in class org.jfree.data.time.TimeSeries
Returns a collection of time periods in the specified series, but not in this series, and therefore unique to the specified series.
getTimeSeriesInstance() - Static method in class org.jfree.chart.labels.StandardXYToolTipGenerator
Returns a tool tip generator that formats the x-values as dates and the y-values as numbers.
getTimeStamp() - Method in interface hep.lcio.event.LCEvent
Returns the time stamp of the event.
getTimeStamp() - Method in interface hep.lcio.event.RawCalorimeterHit
Returns a time stamp for the hit.
getTimeStamp() - Method in class hep.lcio.implementation.event.ILCEvent
 
getTimeStamp() - Method in class hep.lcio.implementation.event.IRawCalorimeterHit
 
getTimeStamp() - Method in class hep.physics.event.BaseEvent
 
getTimeStamp() - Method in interface hep.physics.event.HEPEvent
Get the current timestamp.
getTimestamp() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
getTimestamp() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
required uint64 timestamp = 4;
getTimestamp() - Method in interface proeic.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 timestamp = 4;
getTimestamp() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
getTimestamp() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
required uint64 timestamp = 4;
getTimestamp() - Method in interface promc.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 timestamp = 4;
getTimestamp() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
getTimestamp() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
required uint64 timestamp = 4;
getTimestamp() - Method in interface pronlo.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 timestamp = 4;
getTimestamp() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
getTimestamp() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
required uint64 timestamp = 4;
getTimestamp() - Method in interface proreco.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 timestamp = 4;
getTimeZone() - Method in class org.jfree.chart.axis.DateAxis
Returns the time zone for the axis.
getTimeZone() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the time zone used to convert the periods defining the axis range into absolute milliseconds.
getTip() - Method in class fitter.BFunc
 
getTipRadius() - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Returns the tip radius.
getTipRadius() - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Returns the tip radius.
getTitle() - Method in class jhplot.DrawOptions
Get the title of an object.
getTitle() - Method in class jhplot.F3D
Get the title
getTitle() - Method in class jhplot.FProxy
Get the title of the function.
getTitle() - Method in class jhplot.H3D
get Title of the histogram
getTitle() - Method in class jhplot.HPlotJas
Return title of this plotter.
getTitle() - Method in class jhplot.HProf1D
get Title of the histogram
getTitle() - Method in class jhplot.io.FileRoot
Get ROOT title
getTitle() - Method in class jhplot.P0D
Get a new title
getTitle() - Method in class jhplot.P0I
Get a new title
getTitle() - Method in class jhplot.P3D
Get a new title
getTitle() - Method in class jhplot.Plottable
Get a new title
getTitle() - Method in class jhplot.PND
Get a new title.
getTitle() - Method in class jhplot.PNI
Get a new title
getTitle() - Method in class jhplot.stat.DataKeeper
 
getTitle() - Method in class jhplot.VHolder
Get title of the container
getTitle() - Method in class jplot.DataArray
Get the title if any
getTitle() - Method in class jplot.DataArray2D
Get the title if any
getTitle() - Method in class jplot.DataArray3D
Get the title if any
getTitle() - Method in class jplot3d.JSurfacePanel
 
getTitle() - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Returns the title for the annotation.
getTitle() - Method in class org.jfree.chart.entity.TitleEntity
Returns the title that occupies the entity area.
getTitle() - Method in class org.jfree.chart.event.TitleChangeEvent
Returns the title that generated the event.
getTitle() - Method in class org.jfree.chart.JFreeChart
Returns the main chart title.
getTitle() - Method in class org.jlab.groot.base.AxisAttributes
 
getTitle() - Method in class org.jlab.groot.base.DatasetAttributes
 
getTitle() - Method in class org.jlab.groot.base.PadAttributes
 
getTitle() - Method in class org.jlab.groot.data.GraphErrors
 
getTitle() - Method in class org.jlab.groot.data.H1F
The getter for the histogram title.
getTitle() - Method in class org.jlab.groot.data.H2F
The getter for the histogram title.
getTitle() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getTitle(String) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getTitle() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getTitle() - Method in class org.jlab.groot.math.Axis
 
getTitle() - Method in class root.FakeTKey
 
getTitleAnchor() - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Returns the title anchor for the annotation.
getTitleFont() - Method in class org.jlab.groot.base.AxisAttributes
 
getTitleFont() - Method in class org.jlab.groot.base.PadAttributes
 
getTitleFont() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getTitleFont(String) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getTitleFont() - Method in class org.jlab.groot.graphics.GraphicsAxis
returns properties of the title font
getTitleFont() - Method in class org.jlab.groot.ui.GraphicsAxis
returns properties of the title font
getTitleFontName() - Method in class org.jlab.groot.base.AxisAttributes
 
getTitleFontName() - Method in class org.jlab.groot.base.PadAttributes
 
getTitleFontSize() - Method in class org.jlab.groot.base.AxisAttributes
 
getTitleFontSize() - Method in class org.jlab.groot.base.PadAttributes
 
getTitleFontSize() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getTitleFontSize() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
getTitleOffset() - Method in class org.jlab.groot.base.AxisAttributes
 
getTitleOffset() - Method in class org.jlab.groot.base.PadAttributes
 
getTitleOffset() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getTitlePaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the title paint.
getTitleX() - Method in class org.jlab.groot.base.DatasetAttributes
 
getTitleX() - Method in class org.jlab.groot.data.GraphErrors
 
getTitleX() - Method in class org.jlab.groot.data.H1F
The getter for the x-axis title.
getTitleX() - Method in class org.jlab.groot.data.H2F
The getter for the x-axis title.
getTitleY() - Method in class org.jlab.groot.base.DatasetAttributes
 
getTitleY() - Method in class org.jlab.groot.data.GraphErrors
 
getTitleY() - Method in class org.jlab.groot.data.H1F
The getter for the y-axis title.
getTitleY() - Method in class org.jlab.groot.data.H2F
The getter for the y-axis title.
getTList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float T = 16 [packed = true];
getTList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float T = 16 [packed = true];
getTList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float T = 16 [packed = true];
getTList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
getTList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint32 T = 16 [packed = true];
getTList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 T = 16 [packed = true];
getTList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
getTList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint32 T = 16 [packed = true];
getTList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint32 T = 16 [packed = true];
getTo() - Method in interface hep.lcio.event.LCRelation
The 'to' object of the given relation.
getTo() - Method in class hep.lcio.implementation.event.ILCRelation
 
getToken(int) - Method in class jplot3dp.MathParser.MathParser
 
getToken(int) - Method in class org.nfunk.jep.Parser
 
getTolerance() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get the tolerance below which points are considered identical.
getTolerance() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Get the tolerance below which points are considered to belong to hyperplanes.
getTolerance() - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - Method in class org.apache.commons.math3.geometry.spherical.oned.Arc
Get the tolerance below which angles are considered identical.
getTolerance() - Method in class org.apache.commons.math3.geometry.spherical.oned.LimitAngle
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - Method in class org.nfunk.jep.function.Comparative
Returns the tolerance used for comparing complex numbers
getToolBar() - Method in class org.jlab.groot.studio.StudioToolBar
 
getToolTipCount(int) - Method in class org.jfree.chart.labels.CustomXYToolTipGenerator
Returns the number of tool tips in a given list.
getToolTipGenerator() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the tool tip generator.
getToolTipGenerator() - Method in class org.jfree.chart.plot.PiePlot
Returns the tool tip generator, an object that is responsible for generating the text items used for tool tips by the plot.
getToolTipGenerator() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the tool tip generator for the plot.
getToolTipGenerator(int, int) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns the tool tip generator that should be used for the specified item.
getToolTipGenerator() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractCategoryItemRenderer.getSeriesToolTipGenerator(int) and AbstractCategoryItemRenderer.getBaseToolTipGenerator().
getToolTipGenerator(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns the tool tip generator that should be used for the specified item.
getToolTipGenerator() - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.getSeriesToolTipGenerator(int) and CategoryItemRenderer.getBaseToolTipGenerator().
getToolTipGenerator(int, int) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns the tooltip generator for the specified series and item.
getToolTipGenerator(int, int) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Returns the tool tip generator for a data item.
getToolTipGenerator(int, int) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the tool tip generator for a data item.
getToolTipGenerator() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Deprecated.
As of version 1.0.6, this override setting should not be used. You can use the base setting instead (AbstractXYItemRenderer.getBaseToolTipGenerator()).
getToolTipGenerator(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the tool tip generator for a data item.
getToolTipText() - Method in class org.jfree.chart.annotations.AbstractXYAnnotation
Returns the tool tip text for the annotation.
getToolTipText() - Method in class org.jfree.chart.block.LabelBlock
Returns the tool tip text.
getToolTipText(MouseEvent) - Method in class org.jfree.chart.ChartPanel
Returns a string for the tooltip.
getToolTipText() - Method in class org.jfree.chart.entity.ChartEntity
Returns the tool tip text for the entity.
getToolTipText(int, int) - Method in class org.jfree.chart.labels.CustomXYToolTipGenerator
Returns the tool tip text for an item.
getToolTipText() - Method in class org.jfree.chart.LegendItem
Returns the tool tip text.
getToolTipText() - Method in class org.jfree.chart.title.LegendItemBlockContainer
Returns the tool tip text.
getToolTipText() - Method in class org.jfree.chart.title.TextTitle
Returns the tool tip text.
getTop() - Method in class org.jfree.chart.axis.AxisSpace
Returns the space reserved for axes at the top of the plot area.
getTopEdge(VectorGraphics) - Method in class graph.RTextLine
Return the top edge of the rotated text.
getTopEdge(VectorGraphics, int) - Method in class graph.RTextLine
Return the top edge of the rotated text.
getTopMargin() - Method in class jplot.GraphSettings
Returns the distance between the top-border of the panel and the top X-axis.
getTopMargin() - Method in class org.jlab.groot.base.PadMargins
 
getTopNode() - Method in class org.lsmp.djep.xjep.MacroFunction
 
getTopNode() - Method in class org.nfunk.jep.JEP
Returns the top node of the expression tree.
getTotal() - Method in class org.jfree.chart.plot.PiePlotState
Returns the total of the values in the dataset.
getTotalDimension() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Return the dimension of the complete set of equations.
getTotalDimension() - Method in class org.apache.commons.math3.ode.FieldEquationsMapper
Return the dimension of the complete set of equations.
getTotals() - Method in class jhplot.utils.SHisto
Returns the total bin count over all bins for all bands.
getTotalSumSquares() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the sum of squared deviations of the y values about their mean.
getTotalSumSquares() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the sum of squared deviations of the y values about their mean.
getTPoly() - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
getTrace() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrackCount() - Static method in class org.apache.commons.io.FileCleaner
getTrackCount() - Method in class org.apache.commons.io.FileCleaningTracker
Retrieve the number of files currently being tracked, and therefore awaiting deletion.
getTrackerData() - Method in interface hep.lcio.event.TrackerPulse
Optionally the TrackerData that has been used to create the pulse can be stored with the pulse - NULL if none.
getTrackerData() - Method in class hep.lcio.implementation.event.ITrackerPulse
 
getTrackerData() - Method in class hep.lcio.implementation.sio.SIOTrackerPulse
 
getTrackerHits() - Method in interface hep.lcio.event.Track
Optionaly ( check/set flag(LCIO::TRBIT_HITS)==1) return the hits that have been used to create this track.
getTrackerHits() - Method in class hep.lcio.implementation.event.ITrack
 
getTracks() - Method in interface hep.lcio.event.ReconstructedParticle
The tracks that have been used for this particle.
getTracks() - Method in interface hep.lcio.event.Track
The tracks that have been combined to this track.
getTracks() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getTracks() - Method in class hep.lcio.implementation.event.ITrack
 
getTracks() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Tracks tracks = 8;
getTracks() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Tracks tracks = 8;
getTracks() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Tracks tracks = 8;
getTracksBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Tracks tracks = 8;
getTracksOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Tracks tracks = 8;
getTracksOrBuilder() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Tracks tracks = 8;
getTracksOrBuilder() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Tracks tracks = 8;
getTrackState(int) - Method in interface hep.lcio.event.Track
Returns track state for the given location - or NULL if not found.
getTrackState(int) - Method in class hep.lcio.implementation.event.ITrack
 
getTrackStates() - Method in interface hep.lcio.event.Track
Returns track states associtated to this track.
getTrackStates() - Method in class hep.lcio.implementation.event.ITrack
 
getTransferData(DataFlavor) - Method in class org.jfree.chart.ChartTransferable
Returns the content for the requested flavor, if it is supported.
getTransferData(DataFlavor) - Method in class org.jlab.groot.ui.TransferableImage
 
getTransferDataFlavors() - Method in class org.jfree.chart.ChartTransferable
Returns the data flavors supported.
getTransferDataFlavors() - Method in class org.jlab.groot.ui.TransferableImage
 
getTransform(AffineTransform) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Line
getTransform(double, double, double, double, double, double) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get a Transform embedding an affine transform.
getTransform(Rotation) - Static method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Get a Transform embedding a 3D rotation.
getTransform() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns a copy of the current transform.
getTransform() - Method in class org.jfree.chart.needle.MeterNeedle
Returns the transform.
getTransformer(Class<?>) - Method in class org.apache.commons.math3.util.TransformerMap
Returns the Transformer that is mapped to a class if mapping is not present, this returns null.
getTransientColor() - Method in class net.java.dev.colorchooser.ColorChooser
Returns the currently displayed color which may not be the same as the value of getColor() but is the color currently displayed as the user moves the mouse to select the color.
getTransition_matrix() - Method in class jhplot.math.kalman.JKalman
 
getTranslateX() - Method in class org.jfree.chart.block.BlockParams
Returns the translation required to convert local x-coordinates back to the coordinate space of the container.
getTranslateY() - Method in class org.jfree.chart.block.BlockParams
Returns the translation required to convert local y-coordinates back to the coordinate space of the container.
getTransparency() - Method in class jhplot.shapes.HShape
Get the transparency level
getTranspose() - Method in class org.jfree.data.jdbc.JDBCCategoryDataset
Returns a flag that controls whether or not the table values are transposed when added to the dataset.
getTraverse() - Method in class org.nfunk.jep.JEP
Returns the value of the traverse option.
getTree(boolean) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Get the underlying BSP tree.
getTree(boolean) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Get the underlying BSP tree.
getTree() - Method in class org.jlab.groot.tree.DynamicTree
 
getTree() - Method in class org.jlab.groot.tree.TreeAnalyzer
 
getTree() - Method in class org.jlab.groot.tree.TreeSelector
 
getTreeCuts() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getTreeExpressions() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
getTreeIcons() - Static method in class org.jlab.groot.tree.Tree
returns icons for the tree
getTreeModel() - Method in interface org.jlab.groot.tree.TreeProvider
 
getTreeModel() - Method in class org.jlab.groot.tree.TreeTextFile
 
getTreeNode() - Method in class org.jlab.groot.data.Directory
 
getTreeUtils() - Method in class org.lsmp.djep.xjep.XJep
Returns the TreeUtilitities, used for examining properties of nodes.
getTrigger() - Method in class org.jfree.chart.ChartMouseEvent
Returns the mouse event that triggered this event.
getTrigger() - Method in class org.jfree.chart.fx.interaction.ChartMouseEventFX
Returns the mouse event that triggered this event.
getTwo() - Method in class org.apache.commons.math3.dfp.Dfp
Get the constant 2.
getTwo() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant 2.
getTwo() - Method in class org.nfunk.jep.type.DoubleNumberFactory
 
getTwo() - Method in interface org.nfunk.jep.type.NumberFactory
Return an object representing ONE+ONE.
getTwoParticleRes() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
 
getType() - Method in interface hep.lcio.event.CalorimeterHit
Type of hit.
getType() - Method in interface hep.lcio.event.Cluster
Flagword that defines the type of cluster.
getType() - Method in interface hep.lcio.event.ParticleID
Type - userdefined.
getType() - Method in interface hep.lcio.event.ReconstructedParticle
Type of reconstructed particle.
getType() - Method in interface hep.lcio.event.Track
Flagword that defines the type of track.
getType() - Method in interface hep.lcio.event.TrackerHit
Type of hit.
getType() - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
getType() - Method in class hep.lcio.implementation.event.ICluster
 
getType() - Method in class hep.lcio.implementation.event.IParticleID
 
getType() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
getType() - Method in class hep.lcio.implementation.event.ITrack
 
getType() - Method in class hep.lcio.implementation.event.ITrackerHit
 
getType() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getType() - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
getType() - Method in class hep.physics.particle.BasicParticle
 
getType() - Method in interface hep.physics.particle.Particle
Particle Type
getType() - Method in class jhplot.DrawOptions
Get the type of the object.
getType() - Method in class jhplot.FProxy
Get type of this function.
getType() - Method in class jhplot.math.exp4j.tokenizer.Token
 
getType() - Method in class jhplot.shapes.Arrow
Get the type of arrow
getType() - Method in class jplot.LinePars
Get the type of the data
getType() - Method in class org.jfree.chart.event.ChartChangeEvent
Returns the event type.
getType() - Method in class org.jfree.chart.event.ChartProgressEvent
Returns the event type.
getType() - Method in class org.jfree.data.KeyedValueComparator
Returns the type.
getType() - Method in class org.jfree.data.statistics.HistogramDataset
Returns the histogram type.
getType() - Method in enum org.jlab.groot.base.AttributeType
 
getType(String) - Static method in enum org.jlab.groot.base.AttributeType
 
getType(Integer) - Static method in enum org.jlab.groot.base.AttributeType
 
getType() - Method in class org.lsmp.djep.rpe.RpCommand
Returns the type of an individual command.
getType() - Method in class org.nfunk.jep.evaluation.CommandElement
 
getTypeName() - Method in interface hep.lcio.event.LCCollection
Returns the type name of the collection - valid names are defined in LCIO.
getTypeName() - Method in interface hep.lcio.event.LCGenericObject
The type name of the user class (typically the class name) This type name is stored as a collection parameter "TypeName" with every collection of LCGenericObject subclasses.
getTypeName() - Method in class hep.lcio.example.CalibrationConstant
 
getTypeName() - Method in class hep.lcio.implementation.event.ILCCollection
 
getTypeName() - Method in class hep.lcio.implementation.event.ILCGenericObject
 
getTypeName(String) - Method in class hep.lcio.util.SIODump.Resolver
 
getU() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns the upper triangular factor, U.
getU() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns the upper triangular factor, U.
getU() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the left singular vectors U.
getU() - Method in interface hep.lcio.event.TrackerHitPlane
Direction of first measurement - given as (theta, phi).
getU() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getU() - Method in class Jama.LUDecomposition
Return upper triangular factor
getU() - Method in class Jama.SingularValueDecomposition
Return the left singular vectors
getU() - Method in class jhplot.math.kalman.jama.LUDecomposition
Return upper triangular factor
getU() - Method in class jhplot.math.LUDecomposition
Return upper triangular factor
getU() - Method in class jhplot.math.SingularValueDecomposition
Return the left singular vectors
getU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the plane first canonical vector.
getU() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Returns the matrix U of the decomposition.
getU() - Method in class org.apache.commons.math3.linear.LUDecomposition
Returns the matrix U of the decomposition.
getU() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the matrix U of the decomposition.
getUIClassId() - Method in class net.java.dev.colorchooser.ColorChooser
Overridden to return UI_CLASS_ID
getUMinus() - Method in class org.nfunk.jep.OperatorSet
 
getUnderflow() - Method in class jhplot.H1D
Number of underflow entries
getUnderflow() - Method in class jhplot.HProf1D
Number of underflow entries
getUnderflow() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double underflow = 13;
getUnderflow() - Method in class promc.io.PBufFile.Record.H1D
optional double underflow = 13;
getUnderflow() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional double underflow = 13;
getUnderflowEntriesX() - Method in class jhplot.H2D
Get underflow entries in X
getUnderflowEntriesX() - Method in class jhplot.HProf2D
Get underflow entries in X
getUnderflowEntriesY() - Method in class jhplot.H2D
Get underflow entries in Y
getUnderflowEntriesY() - Method in class jhplot.HProf2D
Get underflow entries in Y
getUnderflowHeight() - Method in class jhplot.H1D
Underflow height
getUnderflowHeight() - Method in class jhplot.HProf1D
Underflow height
getUnderflowHeightsX() - Method in class jhplot.HProf2D
Get underflow heights in X
getUnderflowHeightX() - Method in class jhplot.H2D
Get underflow height in X
getUnderflowHeightX() - Method in class jhplot.HProf2D
Get underflow height in X
getUnderflowHeightY() - Method in class jhplot.H2D
Get underflow height in Y
getUnderflowHeightY() - Method in class jhplot.HProf2D
Get underflow height in Y
getUnderlyingDataset() - Method in class org.jfree.data.category.CategoryToPieDataset
Returns the underlying dataset.
getUnderlyingDataset() - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the underlying dataset that was supplied to the constructor.
getUnderlyingDataset() - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the underlying dataset that was supplied to the constructor.
getUnderlyingDataset() - Method in class org.jfree.data.xy.XYBarDataset
Returns the underlying dataset that was specified via the constructor.
getUniqueCount() - Method in class org.apache.commons.math3.stat.Frequency
Returns the number of values in the frequency table.
getUniqueID() - Method in class root.FakeTKey
 
getUniqueValueCount() - Method in class org.jfree.data.general.WaferMapDataset
Returns the number of unique values.
getUniqueValues() - Method in class org.jfree.data.general.WaferMapDataset
Returns the set of unique values.
getUnit() - Method in class jplot.Utils.LabeledTextField
 
getUnit() - Method in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of 1.0.13, use the getUnitType() method.
getUnit() - Method in class org.jlab.groot.tree.Branch
 
getUnits() - Method in class org.jfree.chart.plot.MeterPlot
Returns a string describing the units for the dial.
getUnits() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns a code indicating the unit display type.
getUnitType() - Method in class org.jfree.chart.axis.DateTickUnit
Returns the unit type.
getUnknownFields() - Method in class proeic.io.ProMC.ProMCEvent.Event
 
getUnknownFields() - Method in class proeic.io.ProMC.ProMCEvent
 
getUnknownFields() - Method in class proeic.io.ProMC.ProMCEvent.Particles
 
getUnknownFields() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
getUnknownFields() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
getUnknownFields() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getUnknownFields() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getUnknownFields() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getUnknownFields() - Method in class proeic.io.ProMCStatFile.ProMCStat
 
getUnknownFields() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
getUnknownFields() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
getUnknownFields() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.F1D
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.F2D
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.FND
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.FPR
 
getUnknownFields() - Method in class promc.io.PBufFile.Record
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.H1D
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.H2D
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.P0D
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.P0I
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.P1D
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.PND
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.PNI
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.PXY
 
getUnknownFields() - Method in class promc.io.PBufFile.Record.PXYZ
 
getUnknownFields() - Method in class promc.io.PEventFile.HEvent.Entry
 
getUnknownFields() - Method in class promc.io.PEventFile.HEvent
 
getUnknownFields() - Method in class promc.io.PEventFile.HEvent.Group
 
getUnknownFields() - Method in class promc.io.ProMC.ProMCEvent.Event
 
getUnknownFields() - Method in class promc.io.ProMC.ProMCEvent
 
getUnknownFields() - Method in class promc.io.ProMC.ProMCEvent.Particles
 
getUnknownFields() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
getUnknownFields() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
 
getUnknownFields() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getUnknownFields() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getUnknownFields() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getUnknownFields() - Method in class promc.io.ProMCStatFile.ProMCStat
 
getUnknownFields() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
getUnknownFields() - Method in class pronlo.io.ProMC.ProMCEvent.Event
 
getUnknownFields() - Method in class pronlo.io.ProMC.ProMCEvent
 
getUnknownFields() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
 
getUnknownFields() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
getUnknownFields() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
getUnknownFields() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getUnknownFields() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getUnknownFields() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getUnknownFields() - Method in class pronlo.io.ProMCStatFile.ProMCStat
 
getUnknownFields() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
getUnknownFields() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
 
getUnknownFields() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
 
getUnknownFields() - Method in class proreco.io.ProMC.ProMCEvent.Event
 
getUnknownFields() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
 
getUnknownFields() - Method in class proreco.io.ProMC.ProMCEvent
 
getUnknownFields() - Method in class proreco.io.ProMC.ProMCEvent.Jets
 
getUnknownFields() - Method in class proreco.io.ProMC.ProMCEvent.MissingET
 
getUnknownFields() - Method in class proreco.io.ProMC.ProMCEvent.Muons
 
getUnknownFields() - Method in class proreco.io.ProMC.ProMCEvent.Particles
 
getUnknownFields() - Method in class proreco.io.ProMC.ProMCEvent.Photons
 
getUnknownFields() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
 
getUnknownFields() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
getUnknownFields() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
getUnknownFields() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
getUnknownFields() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
getUnknownFields() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
getUnknownFields() - Method in class proreco.io.ProMCStatFile.ProMCStat
 
getUnknownFields() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
getUpArrow() - Method in class org.jfree.chart.axis.ValueAxis
Returns a shape that can be displayed as an arrow pointing upwards at the end of an axis line.
getUpPaint() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns the paint used to fill candles when the price moves up from open to close.
getUpper() - Method in class jhplot.math.num.pdf.Uniform
Access the upper parameter.
getUpper() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Deprecated.
as of 3.1, replaced by Interval.getSup()
getUpper() - Method in class org.apache.commons.math3.optim.SimpleBounds
Gets the upper bounds.
getUpper() - Method in class org.apache.commons.math3.optimization.SimpleBounds
Deprecated.
Gets the lower bounds.
getUpperBound() - Method in class org.apache.commons.math3.optim.BaseMultivariateOptimizer
 
getUpperBound() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.
 
getUpperBound() - Method in class org.apache.commons.math3.stat.interval.ConfidenceInterval
 
getUpperBound() - Method in class org.jfree.chart.axis.ValueAxis
Returns the upper bound for the axis range.
getUpperBound() - Method in class org.jfree.chart.plot.dial.StandardDialRange
Returns the upper bound of the dial range.
getUpperBound() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns the upper bound for the scale.
getUpperBound() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns the upper bound for the thermometer.
getUpperBound() - Method in class org.jfree.chart.renderer.GrayPaintScale
Returns the upper bound.
getUpperBound() - Method in class org.jfree.chart.renderer.LookupPaintScale
Returns the upper bound.
getUpperBound() - Method in interface org.jfree.chart.renderer.PaintScale
Returns the upper bound for the scale.
getUpperBound() - Method in class org.jfree.data.Range
Returns the upper bound for the range.
getUpperBound() - Method in class org.jfree.data.statistics.SimpleHistogramBin
Return the upper bound.
getUpperBounds() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Returns a fresh copy of the array of upper bounds for the bins.
getUpperClip() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns the upper clip value.
getUpperDate() - Method in class org.jfree.data.time.DateRange
Returns the upper (later) date for the range.
getUpperEdgeX(int) - Method in class jhplot.H2D
Get upper edge of the bin in X
getUpperEdgeX(int) - Method in class jhplot.HProf2D
Get upper edge of the bin in X
getUpperEdgeY(int) - Method in class jhplot.H2D
Get upper edge of the bin in Y
getUpperEdgeY(int) - Method in class jhplot.HProf2D
Get upper edge of the bin in Y
getUpperMargin() - Method in class org.jfree.chart.axis.CategoryAxis
Returns the upper margin for the axis.
getUpperMargin() - Method in class org.jfree.chart.axis.ValueAxis
Returns the upper margin for the axis, expressed as a percentage of the axis range.
getUpperMillis() - Method in class org.jfree.data.time.DateRange
Returns the upper bound of the range in milliseconds.
getUpperValue() - Method in class org.jlab.groot.ui.RangeSlider
Returns the upper value in the range.
getUpperY() - Method in class org.jfree.chart.plot.PieLabelRecord
Returns the upper bound of the label.
getURL() - Method in class org.jfree.chart.annotations.AbstractXYAnnotation
Returns the URL for the annotation.
getURL(int, int) - Method in class org.jfree.chart.urls.CustomCategoryURLGenerator
Returns the URL for an item.
getURL(Comparable, int) - Method in class org.jfree.chart.urls.CustomPieURLGenerator
Returns the URL for a section in the specified map.
getURL(int, int) - Method in class org.jfree.chart.urls.CustomXYURLGenerator
Returns the URL for an item.
getURLCount(int) - Method in class org.jfree.chart.urls.CustomCategoryURLGenerator
Returns the number of URLs in a given list.
getURLCount(int) - Method in class org.jfree.chart.urls.CustomPieURLGenerator
Returns the number of URLs in a given map (specified by its position in the map list).
getURLCount(int) - Method in class org.jfree.chart.urls.CustomXYURLGenerator
Returns the number of URLs in a given list.
getURLGenerator() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the URL generator for HTML image maps.
getURLGenerator() - Method in class org.jfree.chart.plot.PiePlot
Returns the URL generator.
getURLGenerator() - Method in class org.jfree.chart.plot.SpiderWebPlot
Returns the URL generator for the plot.
getURLGenerator() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns the URL generator.
getURLGenerator() - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Returns the URL generator for HTML image maps.
getURLGenerator() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns the URL generator for HTML image maps.
getURLGenerator() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns the URL generator for HTML image maps.
getURLText() - Method in class org.jfree.chart.block.LabelBlock
Returns the URL text.
getURLText() - Method in class org.jfree.chart.entity.ChartEntity
Returns the URL text for the entity.
getURLText() - Method in class org.jfree.chart.LegendItem
Returns the URL text.
getURLText() - Method in class org.jfree.chart.title.LegendItemBlockContainer
Returns the URL text.
getURLText() - Method in class org.jfree.chart.title.TextTitle
Returns the URL text.
getUseFillPaint() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns true if the renderer should use the fill paint setting to fill shapes, and false if it should just use the regular paint.
getUseFillPaint() - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Returns true if the renderer should use the fill paint setting to fill shapes, and false if it should just use the regular paint.
getUseFillPaint() - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns true if the renderer should use the fill paint setting to fill shapes, and false if it should just use the regular paint.
getUseFillPaint() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Returns the flag that controls whether the series fill paint is used to fill the area under the line.
getUseFillPaint() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns true if the renderer should use the fill paint setting to fill shapes, and false if it should just use the regular paint.
getUseFillPaint() - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Returns true if the renderer should use the fill paint setting to fill shapes, and false if it should just use the regular paint.
getUseOutlinePaint() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the flag that controls whether the outline paint is used for shape outlines.
getUseOutlinePaint() - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Returns the flag that controls whether the outline paint is used for shape outlines.
getUseOutlinePaint() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns the flag that controls whether or not the renderer's outline paint is used to draw the candlestick outline.
getUseOutlinePaint() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Returns true if the renderer should use the outline paint setting to draw shape outlines, and false if it should just use the regular paint.
getUseOutlinePaint() - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Returns the flag that controls whether the outline paint is used for shape outlines.
getUseOutlinePaintForWhiskers() - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Returns the flag that, if true, causes the whiskers to be drawn using the series outline paint.
getUserDirectory() - Static method in class org.apache.commons.io.FileUtils
Returns a File representing the user's home directory.
getUserDirectoryPath() - Static method in class org.apache.commons.io.FileUtils
Returns the path to the user's home directory.
getUseSeriesOffset() - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Returns the flag that controls whether or not the x-position for each data item is offset within the category according to the series.
getUseSeriesOffset() - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Returns the flag that controls whether or not the x-position for each data item is offset within the category according to the series.
getUseSubrangePaint() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns a flag that controls whether or not the mercury color changes for each subrange.
getUseYInterval() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns a flag that determines whether the y-interval from the dataset is used to calculate the length of each bar.
getUT() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the transpose of the matrix U of the decomposition.
getV() - Method in class cern.colt.matrix.linalg.EigenvalueDecomposition
Returns the eigenvector matrix, V
getV() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the right singular vectors V.
getV() - Method in interface hep.lcio.event.TrackerHitPlane
Direction of second measurement - given as (theta, phi).
getV() - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
getV() - Method in class Jama.EigenvalueDecomposition
Return the eigenvector matrix
getV() - Method in class Jama.SingularValueDecomposition
Return the right singular vectors
getV() - Method in class jhplot.math.SingularValueDecomposition
Return the right singular vectors
getV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the plane second canonical vector.
getV() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets the matrix V of the decomposition.
getV() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the matrix V of the decomposition.
getV3() - Method in class hephysics.particle.LParticle
Get a 3-vector woth (Px,Py,Pz) or (X,Y,Z)
getV3() - Method in class hephysics.vec.HepLorentzVector
Get 3-vector
getVal() - Method in class jhplot.math.ValueErr
Get current value
getVals() - Method in class org.apache.commons.math3.special.BesselJ.BesselJResult
 
getValue() - Method in class jhplot.math.exp4j.tokenizer.NumberToken
Get the value of the number
getValue(int) - Method in class jhplot.stat.DataKeeper
Get value at index
getValue() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the value part of the derivative structure.
getValue() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Get the value of the function.
getValue(String) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets the value associated to the given context key.
getValue() - Method in class org.apache.commons.math3.optim.linear.LinearConstraint
Gets the value of the constraint (right hand side).
getValue() - Method in class org.apache.commons.math3.optim.PointVectorValuePair
Gets the value of the objective function.
getValue() - Method in class org.apache.commons.math3.optim.univariate.UnivariatePointValuePair
Get the value of the objective function.
getValue() - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated.
Get the value of the constraint (right hand side).
getValue(double[]) - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.
Compute the value of the linear equation at the current point
getValue(RealVector) - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.
Compute the value of the linear equation at the current point
getValue() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated.
Gets the value of the objective function.
getValue() - Method in class org.apache.commons.math3.optimization.univariate.UnivariatePointValuePair
Deprecated.
Get the value of the objective function.
getValue() - Method in class org.apache.commons.math3.util.Pair
Get the value.
getValue() - Method in class org.jfree.chart.annotations.CategoryTextAnnotation
Returns the value that the annotation attaches to.
getValue() - Method in class org.jfree.chart.axis.ValueTick
Returns the value.
getValue() - Method in class org.jfree.chart.plot.Crosshair
Returns the crosshair value.
getValue(int) - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the value from the specified dataset.
getValue() - Method in class org.jfree.chart.plot.JThermometer
Returns the value of the thermometer.
getValue() - Method in class org.jfree.chart.plot.ValueMarker
Returns the value.
getValue(int) - Method in class org.jfree.data.category.CategoryToPieDataset
Returns a value from the dataset.
getValue(Comparable) - Method in class org.jfree.data.category.CategoryToPieDataset
Returns the value for a given key.
getValue(int, int) - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns a value from the table.
getValue(Comparable, Comparable) - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns the value for a pair of keys.
getValue(Comparable, Comparable) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the data value for one category in a series.
getValue(int, int) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Returns the data value for one category in a series.
getValue(Comparable, Comparable) - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns the value for a pair of keys.
getValue(int, int) - Method in class org.jfree.data.category.SlidingCategoryDataset
Returns a value from the table.
getValue() - Method in class org.jfree.data.DefaultKeyedValue
Returns the value.
getValue(int) - Method in class org.jfree.data.DefaultKeyedValues
Returns a value.
getValue(Comparable) - Method in class org.jfree.data.DefaultKeyedValues
Returns the value for a given key.
getValue(int, int) - Method in class org.jfree.data.DefaultKeyedValues2D
Returns the value for a given row and column.
getValue(Comparable, Comparable) - Method in class org.jfree.data.DefaultKeyedValues2D
Returns the value for the given row and column keys.
getValue(double) - Method in interface org.jfree.data.function.Function2D
Returns the value of the function ('y') for a given input ('x').
getValue(double) - Method in class org.jfree.data.function.LineFunction2D
Returns the function value.
getValue(double) - Method in class org.jfree.data.function.NormalDistributionFunction2D
Returns the function value.
getValue(double) - Method in class org.jfree.data.function.PolynomialFunction2D
Returns the function value.
getValue(double) - Method in class org.jfree.data.function.PowerFunction2D
Returns the value of the function for a given input ('x').
getValue(Comparable, Comparable) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns the value for a pair of keys.
getValue(int, int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Returns a value from the table.
getValue(Comparable, Comparable) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the value for an item.
getValue(int, int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Returns the value for a task.
getValue() - Method in class org.jfree.data.general.DefaultKeyedValueDataset
Returns the value.
getValue(int) - Method in class org.jfree.data.general.DefaultPieDataset
Returns a value.
getValue(Comparable) - Method in class org.jfree.data.general.DefaultPieDataset
Returns the data value associated with a key.
getValue() - Method in class org.jfree.data.general.DefaultValueDataset
Returns the value.
getValue(Comparable) - Method in interface org.jfree.data.KeyedValues
Returns the value for a given key.
getValue(Comparable, Comparable) - Method in interface org.jfree.data.KeyedValues2D
Returns the value associated with the specified keys.
getValue(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the value for an item.
getValue(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Returns the value for an item.
getValue(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns the average value for the specified item.
getValue(int, int) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns the average value for the specified item.
getValue(int, int) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the value for an item (for this dataset, the mean value is returned).
getValue(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Returns the value for an item (for this dataset, the mean value is returned).
getValue() - Method in class org.jfree.data.time.TimePeriodValue
Returns the value.
getValue(int) - Method in class org.jfree.data.time.TimePeriodValues
Returns the value at the specified index.
getValue(int) - Method in class org.jfree.data.time.TimeSeries
Returns the value at the specified index.
getValue(RegularTimePeriod) - Method in class org.jfree.data.time.TimeSeries
Returns the value for a time period.
getValue() - Method in class org.jfree.data.time.TimeSeriesDataItem
Returns the value.
getValue() - Method in interface org.jfree.data.Value
Returns the value.
getValue(int) - Method in interface org.jfree.data.Values
Returns the value with the specified index.
getValue(int, int) - Method in interface org.jfree.data.Values2D
Returns a value from the table.
getValue() - Method in class org.jfree.data.xml.ItemHandler
Returns the key that has been read by the handler, or null.
getValue(int) - Method in class org.jlab.groot.data.DataVector
 
getValue() - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
getValue() - Method in class org.jlab.groot.tree.Branch
 
getValue(ITree) - Method in class org.jlab.groot.tree.TreeExpression
 
getValue() - Method in class org.jlab.groot.ui.RangeSlider
Returns the lower value in the range.
getValue() - Method in class org.lsmp.djep.matrixJep.MatrixVariable
returns the value, unpacks Scalers so they just return its elements.
getValue() - Method in class org.lsmp.djep.matrixJep.nodeTypes.ASTMConstant
 
getValue(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
Returns the value represented by node
getValue() - Method in class org.nfunk.jep.ASTConstant
 
getValue() - Method in class org.nfunk.jep.evaluation.CommandElement
 
getValue(Node, SymbolTable) - Method in class org.nfunk.jep.EvaluatorVisitor
Returns the value of the expression as an object.
getValue() - Method in class org.nfunk.jep.JEP
Evaluates and returns the value of the expression as a double number.
getValue(Object) - Method in class org.nfunk.jep.SymbolTable
Finds the value of the variable with the given name.
getValue() - Method in class org.nfunk.jep.Variable
 
getValue() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
getValue() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required double value = 2;
getValue() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required double value = 2;
getValue() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
getValue() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
required sint64 value = 2;
getValue() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required sint64 value = 2;
getValue() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
required double value = 2;
getValue() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
required double value = 2;
getValue() - Method in interface proeic.io.ProMCStatFile.ProMCStat.MetaFloatOrBuilder
required double value = 2;
getValue() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
required sint64 value = 2;
getValue() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
required sint64 value = 2;
getValue() - Method in interface proeic.io.ProMCStatFile.ProMCStat.MetaIntOrBuilder
required sint64 value = 2;
getValue(int) - Method in class promc.io.PBufFile.Record.P0D.Builder
repeated double value = 2 [packed = true];
getValue(int) - Method in class promc.io.PBufFile.Record.P0D
repeated double value = 2 [packed = true];
getValue(int) - Method in interface promc.io.PBufFile.Record.P0DOrBuilder
repeated double value = 2 [packed = true];
getValue(int) - Method in class promc.io.PBufFile.Record.P0I.Builder
repeated int64 value = 2 [packed = true];
getValue(int) - Method in class promc.io.PBufFile.Record.P0I
repeated int64 value = 2 [packed = true];
getValue(int) - Method in interface promc.io.PBufFile.Record.P0IOrBuilder
repeated int64 value = 2 [packed = true];
getValue(int) - Method in class promc.io.PBufFile.Record.PND.Builder
repeated double value = 2 [packed = true];
getValue(int) - Method in class promc.io.PBufFile.Record.PND
repeated double value = 2 [packed = true];
getValue(int) - Method in interface promc.io.PBufFile.Record.PNDOrBuilder
repeated double value = 2 [packed = true];
getValue(int) - Method in class promc.io.PBufFile.Record.PNI.Builder
repeated int32 value = 2 [packed = true];
getValue(int) - Method in class promc.io.PBufFile.Record.PNI
repeated int32 value = 2 [packed = true];
getValue(int) - Method in interface promc.io.PBufFile.Record.PNIOrBuilder
repeated int32 value = 2 [packed = true];
getValue() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
getValue() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required double value = 2;
getValue() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required double value = 2;
getValue() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
getValue() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
required sint64 value = 2;
getValue() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required sint64 value = 2;
getValue() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
getValue() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required double value = 2;
getValue() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required double value = 2;
getValue() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
getValue() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
required sint64 value = 2;
getValue() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required sint64 value = 2;
getValue() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
getValue() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required double value = 2;
getValue() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required double value = 2;
getValue() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
getValue() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
required sint64 value = 2;
getValue() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required sint64 value = 2;
getValue1() - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Returns the y-value for the start of the line.
getValue2() - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Returns the y-value for the end of the line.
getValueAnchor() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns the value anchor.
getValueAsObject() - Method in class org.lsmp.djep.matrixJep.MatrixJep
 
getValueAsObject() - Method in class org.nfunk.jep.JEP
Evaluates and returns the value of the expression as an object.
getValueAt(int, int) - Method in class org.jfree.data.time.TimeSeriesTableModel
Returns the data value for a cell in the table model.
getValueAt(int, int) - Method in class org.jfree.data.xy.XYDatasetTableModel
Returns a value of the specified cell.
getValueCount() - Method in class promc.io.PBufFile.Record.P0D.Builder
repeated double value = 2 [packed = true];
getValueCount() - Method in class promc.io.PBufFile.Record.P0D
repeated double value = 2 [packed = true];
getValueCount() - Method in interface promc.io.PBufFile.Record.P0DOrBuilder
repeated double value = 2 [packed = true];
getValueCount() - Method in class promc.io.PBufFile.Record.P0I.Builder
repeated int64 value = 2 [packed = true];
getValueCount() - Method in class promc.io.PBufFile.Record.P0I
repeated int64 value = 2 [packed = true];
getValueCount() - Method in interface promc.io.PBufFile.Record.P0IOrBuilder
repeated int64 value = 2 [packed = true];
getValueCount() - Method in class promc.io.PBufFile.Record.PND.Builder
repeated double value = 2 [packed = true];
getValueCount() - Method in class promc.io.PBufFile.Record.PND
repeated double value = 2 [packed = true];
getValueCount() - Method in interface promc.io.PBufFile.Record.PNDOrBuilder
repeated double value = 2 [packed = true];
getValueCount() - Method in class promc.io.PBufFile.Record.PNI.Builder
repeated int32 value = 2 [packed = true];
getValueCount() - Method in class promc.io.PBufFile.Record.PNI
repeated int32 value = 2 [packed = true];
getValueCount() - Method in interface promc.io.PBufFile.Record.PNIOrBuilder
repeated int32 value = 2 [packed = true];
getValueFont() - Method in class org.jfree.chart.plot.MeterPlot
Returns the font for the value label.
getValueFont() - Method in class org.jfree.chart.plot.ThermometerPlot
Gets the font used to display the current value.
getValueList() - Method in class promc.io.PBufFile.Record.P0D.Builder
repeated double value = 2 [packed = true];
getValueList() - Method in class promc.io.PBufFile.Record.P0D
repeated double value = 2 [packed = true];
getValueList() - Method in interface promc.io.PBufFile.Record.P0DOrBuilder
repeated double value = 2 [packed = true];
getValueList() - Method in class promc.io.PBufFile.Record.P0I.Builder
repeated int64 value = 2 [packed = true];
getValueList() - Method in class promc.io.PBufFile.Record.P0I
repeated int64 value = 2 [packed = true];
getValueList() - Method in interface promc.io.PBufFile.Record.P0IOrBuilder
repeated int64 value = 2 [packed = true];
getValueList() - Method in class promc.io.PBufFile.Record.PND.Builder
repeated double value = 2 [packed = true];
getValueList() - Method in class promc.io.PBufFile.Record.PND
repeated double value = 2 [packed = true];
getValueList() - Method in interface promc.io.PBufFile.Record.PNDOrBuilder
repeated double value = 2 [packed = true];
getValueList() - Method in class promc.io.PBufFile.Record.PNI.Builder
repeated int32 value = 2 [packed = true];
getValueList() - Method in class promc.io.PBufFile.Record.PNI
repeated int32 value = 2 [packed = true];
getValueList() - Method in interface promc.io.PBufFile.Record.PNIOrBuilder
repeated int32 value = 2 [packed = true];
getValueLocation() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns a code indicating the location at which the value label is displayed.
getValuePaint() - Method in class org.jfree.chart.plot.MeterPlot
Returns the paint for the value label.
getValuePaint() - Method in class org.jfree.chart.plot.ThermometerPlot
Gets the paint used to display the current value.
getValueRef() - Method in class org.apache.commons.math3.optim.PointVectorValuePair
Gets a reference to the value of the objective function.
getValueRef() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated.
Gets a reference to the value of the objective function.
getValues(int) - Method in class jhplot.H1D
Get positions in X,Y and Errors.
getValues(int) - Method in class jhplot.HProf1D
Get positions in X,Y and Errors.
getValues() - Method in class jhplot.stat.DataKeeper
Get values
getValues() - Method in class jhplot.stat.Moments
Get values of the moments
getValues() - Method in class jhplot.stat.MomentsFac
Get values of the factorial moments
getValues() - Method in class jhplot.stat.MomentsNorm
Get values of the normalised factorial moments (NFM).
getValues() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the current set of values in an array of double primitives.
getValues() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the current set of values in an array of double primitives.
getValues(int, int) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns a list (possibly empty) of the values for the specified item.
getValues(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultMultiValueCategoryDataset
Returns a list (possibly empty) of the values for the specified item.
getValues(int, int) - Method in interface org.jfree.data.statistics.MultiValueCategoryDataset
Returns a list (possibly empty) of the values for the specified item.
getValues(Comparable, Comparable) - Method in interface org.jfree.data.statistics.MultiValueCategoryDataset
Returns a list (possibly empty) of the values for the specified item.
getValuesArray() - Method in class jplot3d.JSurface
Gets the current vertices array.
getValuesFileURL() - Method in class org.apache.commons.math3.random.ValueServer
Returns the URL for the file used to build the empirical distribution when using ValueServer.DIGEST_MODE.
getVar() - Method in class org.nfunk.jep.ASTVarNode
 
getVar(String) - Method in class org.nfunk.jep.JEP
Gets the object representing the variable with a given name.
getVar(String) - Method in class org.nfunk.jep.SymbolTable
Finds the variable with given name.
getVariable(String) - Method in class jplot3dp.MathParser.MathParser
 
getVariable() - Method in class org.lsmp.djep.rpe.RpCommand
 
getVariable(int) - Method in class org.lsmp.djep.rpe.RpEval
 
getVariableFactory() - Method in class org.nfunk.jep.SymbolTable
Returns the variable factory of this instance.
getVariables() - Method in class graph.ParseFunction
Return a boolean array with index 0 true if the independent variable x was found in the function, index 1 true if y was found, and index 2 true if z was found.
getVariables() - Method in class jhplot.FProxy
Get variables
getVariance() - Method in class jhplot.math.num.pdf.NegativeBinomial
Get mean value.
getVariance() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the variance of the available values.
getVariance() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the (sample) variance of the available values.
getVariance() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the variance of the available values.
getVariance() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getVariance() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the (sample) variance of the available values.
getVariance() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the (sample) variance of the available values.
getVarianceDirection() - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns the varianceDirection property.
getVarianceImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured variance implementation.
getVarianceImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured variance implementation
getVarianceImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured variance implementation
getVarianceMax() - Method in class jhplot.stat.EEcentricity
Get variance alone the major axis (longest component)
getVarianceMin() - Method in class jhplot.stat.EEcentricity
Get variance alone the minor (shortest component)
getVarName() - Method in class org.nfunk.jep.evaluation.CommandElement
 
getVarRef(Variable) - Method in class org.lsmp.djep.mrpe.MRpEval
Finds the reference number used for this variable.
getVarRef(MatrixVariableI) - Method in class org.lsmp.djep.mrpe.MRpEval
Finds the reference number used for this variable.
getVars() - Method in class jhplot.FND
Return all variables
getVars(Node) - Static method in class org.lsmp.djep.vectorJep.function.VMap
 
getVars() - Method in class promc.io.PBufFile.Record.FND.Builder
required string vars = 3;
getVars() - Method in class promc.io.PBufFile.Record.FND
required string vars = 3;
getVars() - Method in interface promc.io.PBufFile.Record.FNDOrBuilder
required string vars = 3;
getVarsBytes() - Method in class promc.io.PBufFile.Record.FND.Builder
required string vars = 3;
getVarsBytes() - Method in class promc.io.PBufFile.Record.FND
required string vars = 3;
getVarsBytes() - Method in interface promc.io.PBufFile.Record.FNDOrBuilder
required string vars = 3;
getVarsInEquation(Node, Vector) - Method in class org.lsmp.djep.xjep.XJep
Finds all the variables in an equation.
getVarString() - Method in class jhplot.FND
Get arguments of the function (independent variables).
getVarValue(String) - Method in class org.nfunk.jep.JEP
Returns the value of the variable with given name.
getVector() - Method in class org.apache.commons.math3.geometry.spherical.oned.S1Point
Get the corresponding normalized vector in the 2D euclidean space.
getVector() - Method in class org.apache.commons.math3.geometry.spherical.twod.S2Point
Get the corresponding normalized vector in the 3D euclidean space.
getVector() - Method in class org.jfree.data.xy.VectorDataItem
Returns the vector.
getVector(int, int) - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns the vector for an item in a series.
getVector(int, int) - Method in interface org.jfree.data.xy.VectorXYDataset
Returns the vector for an item in a series.
getVectorDouble(String) - Static method in class org.jlab.groot.matrix.SparseGridIO
 
getVectorGraphics() - Method in class jplot3d.JSurface
Get current graphics
getVectorInt(String) - Static method in class org.jlab.groot.matrix.SparseGridIO
 
getVectorPart() - Method in class org.apache.commons.math3.complex.Quaternion
Gets the three components of the vector part of the quaternion.
getVectorSize() - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
getVectorX() - Method in class org.jfree.data.xy.VectorDataItem
Returns the x-component for the vector.
getVectorX() - Method in class org.jlab.groot.data.GraphErrors
 
getVectorXValue(int) - Method in class org.jfree.data.xy.VectorSeries
Returns the x-component of the vector for an item in the series.
getVectorXValue(int, int) - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns the x-component of the vector for an item in a series.
getVectorXValue(int, int) - Method in interface org.jfree.data.xy.VectorXYDataset
Returns the x-component of the vector for an item in a series.
getVectorY() - Method in class org.jfree.data.xy.VectorDataItem
Returns the y-component for the vector.
getVectorY() - Method in class org.jlab.groot.data.GraphErrors
 
getVectorYValue(int) - Method in class org.jfree.data.xy.VectorSeries
Returns the y-component of the vector for an item in the series.
getVectorYValue(int, int) - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns the y-component of the vector for an item in a series.
getVectorYValue(int, int) - Method in interface org.jfree.data.xy.VectorXYDataset
Returns the y-component of the vector for an item in a series.
getVersion() - Method in class jhplot.io.EFile
Get version of the input file.
getVersion() - Method in class jhplot.io.FileRoot
Get ROOT version
getVersion() - Method in class jhplot.io.HBook
Get version of the file.
getVersion() - Method in class jhplot.io.HFileMap
Get file version.
getVersion() - Method in class jhplot.io.PFile
Get version of the input file.
getVersion() - Static method in class jhplot.JHPlot
Get version information
getVersion() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
getVersion() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
required uint64 version = 1;
getVersion() - Method in interface proeic.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 version = 1;
getVersion() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
getVersion() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
required uint64 version = 1;
getVersion() - Method in interface promc.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 version = 1;
getVersion() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
getVersion() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
required uint64 version = 1;
getVersion() - Method in interface pronlo.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 version = 1;
getVersion() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
getVersion() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
required uint64 version = 1;
getVersion() - Method in interface proreco.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 version = 1;
getVertex() - Method in interface hep.lcio.event.MCParticle
Returns the production vertex of the particle in [mm].
getVertex() - Method in class hep.lcio.implementation.event.IMCParticle
 
getVerticalAlignment() - Method in class org.jfree.chart.title.Title
Returns the vertical alignment of the title.
getVerticalAxisTrace() - Method in class org.jfree.chart.ChartPanel
Returns the flag that controls whether or not a vertical axis trace line is drawn over the plot area at the current mouse location.
getVertices() - Method in class org.apache.commons.math3.geometry.euclidean.twod.hull.ConvexHull2D
Get the vertices of the convex hull.
getVertices() - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Get the vertices of the polygon.
getVertices() - Method in interface org.apache.commons.math3.geometry.hull.ConvexHull
Get the vertices of the convex hull.
getViewHeight() - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the height of the viewing rectangle.
getViewWidth() - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the width of the viewing rectangle.
getViewX() - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the x-coordinate of the viewing rectangle.
getViewY() - Method in class org.jfree.chart.plot.dial.DialPlot
Returns the y-coordinate of the viewing rectangle.
getVisibleSeriesArray() - Method in class org.jfree.chart.renderer.category.CategoryItemRendererState
Returns a copy of the visible series array.
getVisibleSeriesCount() - Method in class org.jfree.chart.renderer.category.CategoryItemRendererState
Returns the number of visible series or -1 if no visible series have been specified.
getVisibleSeriesIndex(int) - Method in class org.jfree.chart.renderer.category.CategoryItemRendererState
Returns the index of the row relative to the visible rows.
getVolume(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the volume value for the specified series and item.
getVolume(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the volume.
getVolume(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns null always, because this dataset doesn't record any volume data.
getVolume(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the volume-value for one item in a series.
getVolume(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the trading volume.
getVolume() - Method in class org.jfree.data.xy.OHLCDataItem
Returns the volume.
getVolume(int, int) - Method in interface org.jfree.data.xy.OHLCDataset
Returns the volume for the specified series and item.
getVolumePaint() - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Returns the paint that is used to fill the volume bars if they are visible.
getVolumeValue(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the volume-value (as a double primitive) for an item within a series.
getVolumeValue(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the volume-value (as a double primitive) for an item within a series.
getVolumeValue(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns Double.NaN always, because this dataset doesn't record any volume data.
getVolumeValue(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the volume-value (as a double primitive) for an item within a series.
getVolumeValue(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the volume-value (as a double primitive) for an item within a series.
getVolumeValue(int, int) - Method in interface org.jfree.data.xy.OHLCDataset
Returns the volume-value (as a double primitive) for an item within a series.
getVT() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets the transpose of the matrix V of the decomposition.
getVT() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the transpose of the matrix V of the decomposition.
getWallPaint() - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Returns the paint used to highlight the left and bottom wall in the plot background.
getWallPaint() - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Returns the paint used to highlight the left and bottom wall in the plot background.
getWallPaint() - Method in class org.jfree.chart.renderer.xy.XYLine3DRenderer
Returns the paint used to highlight the left and bottom wall in the plot background.
getWallPaint() - Method in class org.jfree.chart.StandardChartTheme
Returns the wall paint for charts with a 3D effect.
getWeek() - Method in class org.jfree.data.time.Week
Returns the week.
getWeight() - Method in class cern.jet.random.sampling.WeightedRandomSampler
Not yet commented.
getWeight() - Method in interface hep.lcio.event.LCEvent
Returns the event weight.
getWeight() - Method in interface hep.lcio.event.LCRelation
The weight of the given relation - only if collection flag bit LCIO::LCREL_WEIGHTED is set.
getWeight() - Method in class hep.lcio.implementation.event.ILCEvent
 
getWeight() - Method in class hep.lcio.implementation.event.ILCRelation
 
getWeight(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegrator
Gets the weight of the integration point at the given index.
getWeight() - Method in class org.apache.commons.math3.fitting.WeightedObservedPoint
Gets the weight of the measurement in the fitting process.
getWeight() - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultivariateVectorOptimizer
Deprecated.
Gets the weight matrix of the observations.
getWeight() - Method in class org.apache.commons.math3.optim.nonlinear.vector.Weight
Deprecated.
Gets the initial guess.
getWeight() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated.
Gets the weight matrix of the observations.
getWeight() - Method in class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint
Deprecated.
Get the weight of the measurement in the fitting process.
getWeight() - Method in class org.apache.commons.math3.optimization.Weight
Deprecated.
Gets the initial guess.
getWeight() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the weight for this plot when it is used as a subplot within a combined plot.
getWeight() - Method in class org.jfree.chart.plot.XYPlot
Returns the weight for this plot when it is used as a subplot within a combined plot.
getWeight() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional double Weight = 14;
getWeight() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional double Weight = 14;
getWeight() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional double Weight = 14;
getWeight(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float weight = 17 [packed = true];
getWeight(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float weight = 17 [packed = true];
getWeight(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float weight = 17 [packed = true];
getWeight() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
getWeight() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double weight = 20;
getWeight() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double weight = 20;
getWeight() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional double Weight = 14;
getWeight() - Method in class promc.io.ProMC.ProMCEvent.Event
optional double Weight = 14;
getWeight() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional double Weight = 14;
getWeight(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
getWeight(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint64 weight = 17 [packed = true];
getWeight(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 weight = 17 [packed = true];
getWeight() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
getWeight() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double weight = 20;
getWeight() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double weight = 20;
getWeight() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
getWeight() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double weight = 20;
getWeight() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double weight = 20;
getWeight(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
getWeight(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint64 weight = 17 [packed = true];
getWeight(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 weight = 17 [packed = true];
getWeight() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
getWeight() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double weight = 20;
getWeight() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double weight = 20;
getWeightCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float weight = 17 [packed = true];
getWeightCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float weight = 17 [packed = true];
getWeightCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float weight = 17 [packed = true];
getWeightCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
getWeightCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint64 weight = 17 [packed = true];
getWeightCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 weight = 17 [packed = true];
getWeightCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
getWeightCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint64 weight = 17 [packed = true];
getWeightCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 weight = 17 [packed = true];
getWeightList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float weight = 17 [packed = true];
getWeightList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float weight = 17 [packed = true];
getWeightList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float weight = 17 [packed = true];
getWeightList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
getWeightList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated uint64 weight = 17 [packed = true];
getWeightList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 weight = 17 [packed = true];
getWeightList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
getWeightList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated uint64 weight = 17 [packed = true];
getWeightList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated uint64 weight = 17 [packed = true];
getWeightSquareRoot() - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Deprecated.
Gets the square-root of the weight matrix.
getWeightSquareRoot() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated.
Gets the square-root of the weight matrix.
getWhiskerWidth() - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Returns the width of the whiskers as fraction of the bar width.
getWhoAm() - Method in class jhplot.shapes.HShape
Primitive type
getWholeFormat() - Method in class org.apache.commons.math3.fraction.ProperBigFractionFormat
Access the whole format.
getWholeFormat() - Method in class org.apache.commons.math3.fraction.ProperFractionFormat
Access the whole format.
getWidth(Graphics) - Method in class graph.TextLine
 
getWidth() - Method in interface hep.physics.particle.properties.ParticleType
Width
getWidth() - Method in class jplot.GraphLabel
Returns the width of the bounding box of the label
getWidth() - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
getWidth() - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
getWidth() - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Returns the width (in data space) of the data rectangle into which the image will be drawn.
getWidth() - Method in class org.jfree.chart.block.AbstractBlock
Returns the natural width of the block, if this is known in advance.
getWidth() - Method in class org.jfree.chart.block.RectangleConstraint
Returns the fixed width.
getWidth() - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Get the width of this item.
getWidth() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
getWidth() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
getWidth() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float width = 4;
getWidth() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float width = 4;
getWidth() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
getWidth() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float width = 4;
getWidth() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float width = 4;
getWidth() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
getWidth() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float width = 4;
getWidth() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float width = 4;
getWidth() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
getWidth() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float width = 4;
getWidth() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float width = 4;
getWidthBin() - Method in class jplot.LinePars
Returns the histogram bin width, in case of histogram
getWidthConstraintType() - Method in class org.jfree.chart.block.RectangleConstraint
Returns the constraint type.
getWidthRadius() - Method in class org.jfree.chart.plot.dial.DialPointer.Pointer
Returns the width radius.
getWidthRange() - Method in class org.jfree.chart.block.RectangleConstraint
Returns the width range.
getWidthRatio() - Method in class org.jfree.chart.axis.CategoryLabelPosition
Returns the ratio used to calculate the maximum category label width.
getWidthType() - Method in class org.jfree.chart.axis.CategoryLabelPosition
Returns the width calculation type.
getWilsonScoreInterval(int, int, double) - Static method in class org.apache.commons.math3.stat.interval.IntervalUtils
Create a Wilson score binomial confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, successes and confidence level.
getWindDirection(int, int) - Method in class org.jfree.data.xy.DefaultWindDataset
Returns the wind direction for one item within a series.
getWindDirection(int, int) - Method in interface org.jfree.data.xy.WindDataset
Returns the wind direction (should be in the range 0 to 12, corresponding to the positions on an upside-down clock face).
getWindForce(int, int) - Method in class org.jfree.data.xy.DefaultWindDataset
Returns the wind force for one item within a series.
getWindForce(int, int) - Method in interface org.jfree.data.xy.WindDataset
Returns the wind force on the Beaufort scale (0 to 12).
getWindow(Rectangle2D) - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Returns the shape for the window for this dial.
getWindow(Rectangle2D) - Method in interface org.jfree.chart.plot.dial.DialFrame
Returns the shape of the viewing window for the dial, or null if the dial is completely open.
getWindow(Rectangle2D) - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Returns the shape for the window for this dial.
getWindowSize() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the maximum number of values that can be stored in the dataset, or INFINITE_WINDOW (-1) if there is no limit.
getWindowSize() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the maximum number of values that can be stored in the dataset, or INFINITE_WINDOW (-1) if there is no limit.
getWrapper() - Method in class org.jfree.chart.title.LegendTitle
Returns the wrapper container, if any.
getWrongColumnDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
 
getWrongDimension(int) - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
 
getWrongDimensions() - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
 
getWrongRowDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
 
getX(int) - Method in class jhplot.F1D
Get value in X-axis
getX(int) - Method in class jhplot.FND
Get value in X-axis
getX() - Method in class jhplot.HKey
Returns the X position of the text.
getX() - Method in class jhplot.HLabel
Returns the X position of the text.
getX() - Method in class jhplot.HLabelEq
Returns the X position of the text.
getX() - Method in class jhplot.HMLabel
Returns the X position of the text.
getX(int) - Method in class jhplot.P1D
Return a specific X-value.
getX(int) - Method in class jhplot.P2D
Return a specific X-value.
getX(int) - Method in class jhplot.P3D
Return a specific X-value.
getX(int) - Method in class jplot.DataArray
Return a specific X-value.
getX(int) - Method in class jplot.DataArray2D
Return a specific X-value.
getX(int) - Method in class jplot.DataArray3D
Return a specific X-value.
getX() - Method in class jplot.GraphLabel
Returns the X position of the bounding box.
getX() - Method in class jplot.PlotPoint
Return the current X-value.
getX() - Method in class jplot.PlotPoint2D
Return the current X-value.
getX() - Method in class jplot.PlotPoint3D
Return the current X-value.
getX() - Method in class jplot3d.JPoint
Return the current X-value.
getX() - Method in class org.apache.commons.math3.fitting.WeightedObservedPoint
Gets the abscissa of the point.
getX() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the abscissa of the vector.
getX() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the abscissa of the vector.
getX() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the abscissa of the vector.
getX() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the abscissa of the vector.
getX() - Method in class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint
Deprecated.
Get the abscissa of the point.
getX() - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Returns the x-coordinate (in data space) for the annotation.
getX() - Method in class org.jfree.chart.annotations.XYImageAnnotation
Returns the x-coordinate (in data space) for the annotation.
getX() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the x coordinate for the text anchor point (measured against the domain axis).
getX() - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Returns the x-coordinate for the annotation.
getX() - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Get the x-coordinate for the item's location.
getX() - Method in class org.jfree.chart.renderer.Outlier
Returns the x coordinate of the bounding box containing the outlier ellipse.
getX(int, int) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the x value for the specified series and index (zero-based indices).
getX(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the x-value for the specified series.
getX(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the X-value for the specified series and item.
getX(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the X-value for the specified series and item.
getX(int, int) - Method in class org.jfree.data.jdbc.JDBCXYDataset
Returns the x-value for the specified series and item.
getX(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the x-value for one item in a series.
getX(int, int) - Method in class org.jfree.data.statistics.HistogramDataset
Returns the X value for a bin.
getX(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the x-value for an item within a series.
getX(int, int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the x-value.
getX(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the x-value for an item within a series.
getX(int, int) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the x-value for the specified series and item.
getX(int, int) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the x-value for the specified series and item.
getX(int, int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the x-value for an item within a series.
getX(int, int) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the x-value for the specified series and item.
getX(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the x-value for one item in a series.
getX(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the x-value for an item within a series.
getX(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the x-value for a data item.
getX(int, int) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the x-value for the specified series and item.
getX(int, int) - Method in class org.jfree.data.xy.DefaultWindDataset
Returns the x-value for one item within a series.
getX(int, int) - Method in class org.jfree.data.xy.DefaultXYDataset
Returns the x-value for an item within a series.
getX(int, int) - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns the x-value for an item within a series.
getX(int, int) - Method in class org.jfree.data.xy.MatrixSeriesCollection
Returns the j index value of the specified Mij matrix item in the specified matrix series.
getX() - Method in class org.jfree.data.xy.Vector
Returns the x-value.
getX(int, int) - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns the x-value for an item within a series.
getX() - Method in class org.jfree.data.xy.XIntervalDataItem
Returns the x-value.
getX(int) - Method in class org.jfree.data.xy.XIntervalSeries
Returns the x-value for the specified item.
getX(int, int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the x-value for an item within a series.
getX(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the x-value for an item within a series.
getX() - Method in class org.jfree.data.xy.XYCoordinate
Returns the x-coordinate.
getX() - Method in class org.jfree.data.xy.XYDataItem
Returns the x-value.
getX(int, int) - Method in interface org.jfree.data.xy.XYDataset
Returns the x-value for an item within a series.
getX() - Method in class org.jfree.data.xy.XYIntervalDataItem
Returns the x-value.
getX(int) - Method in class org.jfree.data.xy.XYIntervalSeries
Returns the x-value for the specified item.
getX(int, int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the x-value for an item within a series.
getX(int) - Method in class org.jfree.data.xy.XYSeries
Returns the x-value at the specified index.
getX(int, int) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the x-value for the specified series and item.
getX() - Method in class org.jfree.data.xy.YIntervalDataItem
Returns the x-value.
getX(int) - Method in class org.jfree.data.xy.YIntervalSeries
Returns the x-value for the specified item.
getX(int, int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the x-value for an item within a series.
getX() - Method in class org.jlab.groot.ui.LatexText
 
getX() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X = 15;
getX() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float X = 15;
getX() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float X = 15;
getX(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float X = 13 [packed = true];
getX(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float X = 13 [packed = true];
getX(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float X = 13 [packed = true];
getX(int) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double x = 2 [packed = true];
getX(int) - Method in class promc.io.PBufFile.Record.P1D
repeated double x = 2 [packed = true];
getX(int) - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double x = 2 [packed = true];
getX(int) - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double x = 2 [packed = true];
getX(int) - Method in class promc.io.PBufFile.Record.PXY
repeated double x = 2 [packed = true];
getX(int) - Method in interface promc.io.PBufFile.Record.PXYOrBuilder
repeated double x = 2 [packed = true];
getX(int) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double x = 2 [packed = true];
getX(int) - Method in class promc.io.PBufFile.Record.PXYZ
repeated double x = 2 [packed = true];
getX(int) - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
repeated double x = 2 [packed = true];
getX(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
getX(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 X = 13 [packed = true];
getX(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 X = 13 [packed = true];
getX(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
getX(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 X = 13 [packed = true];
getX(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 X = 13 [packed = true];
getX(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 X = 5 [packed = true];
getX(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 X = 5 [packed = true];
getX(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 X = 5 [packed = true];
getX1() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X1 = 8;
getX1() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float X1 = 8;
getX1() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float X1 = 8;
getX1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
getX1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double x1 = 5;
getX1() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x1 = 5;
getX1() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float X1 = 8;
getX1() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float X1 = 8;
getX1() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float X1 = 8;
getX1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
getX1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double x1 = 5;
getX1() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x1 = 5;
getX1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
getX1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double x1 = 5;
getX1() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x1 = 5;
getX1(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X1 = 8;
getX1(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float X1 = 8;
getX1(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float X1 = 8;
getX1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
getX1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double x1 = 5;
getX1() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x1 = 5;
getX1Count() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X1 = 8;
getX1Count() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float X1 = 8;
getX1Count() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float X1 = 8;
getX1List() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X1 = 8;
getX1List() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float X1 = 8;
getX1List() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float X1 = 8;
getX2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X2 = 9;
getX2() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float X2 = 9;
getX2() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float X2 = 9;
getX2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
getX2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double x2 = 6;
getX2() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x2 = 6;
getX2() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float X2 = 9;
getX2() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float X2 = 9;
getX2() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float X2 = 9;
getX2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
getX2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double x2 = 6;
getX2() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x2 = 6;
getX2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
getX2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double x2 = 6;
getX2() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x2 = 6;
getX2(int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X2 = 9;
getX2(int) - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float X2 = 9;
getX2(int) - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float X2 = 9;
getX2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
getX2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double x2 = 6;
getX2() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x2 = 6;
getX2Count() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X2 = 9;
getX2Count() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float X2 = 9;
getX2Count() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float X2 = 9;
getX2List() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X2 = 9;
getX2List() - Method in class proreco.io.ProMC.ProMCEvent.Event
repeated float X2 = 9;
getX2List() - Method in interface proreco.io.ProMC.ProMCEvent.EventOrBuilder
repeated float X2 = 9;
getXAxis() - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Get the X axis of the circle.
getXaxis() - Method in class org.jlab.groot.data.H1F
 
getxAxis() - Method in class org.jlab.groot.data.H1F
Retrieves the x-axis as an Axis object
getXAxis() - Method in class org.jlab.groot.data.H2F
 
getXBar() - Method in class jhplot.stat.LinReg
Get average x
getXBar() - Method in class jhplot.stat.LinRegWeighted
Get average x
getXColumn() - Method in class jplot.DataFile
Returns the index of the column used for the X-axis
getXCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float X = 13 [packed = true];
getXCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float X = 13 [packed = true];
getXCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float X = 13 [packed = true];
getXCount() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double x = 2 [packed = true];
getXCount() - Method in class promc.io.PBufFile.Record.P1D
repeated double x = 2 [packed = true];
getXCount() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double x = 2 [packed = true];
getXCount() - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double x = 2 [packed = true];
getXCount() - Method in class promc.io.PBufFile.Record.PXY
repeated double x = 2 [packed = true];
getXCount() - Method in interface promc.io.PBufFile.Record.PXYOrBuilder
repeated double x = 2 [packed = true];
getXCount() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double x = 2 [packed = true];
getXCount() - Method in class promc.io.PBufFile.Record.PXYZ
repeated double x = 2 [packed = true];
getXCount() - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
repeated double x = 2 [packed = true];
getXCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
getXCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 X = 13 [packed = true];
getXCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 X = 13 [packed = true];
getXCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
getXCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 X = 13 [packed = true];
getXCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 X = 13 [packed = true];
getXCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 X = 5 [packed = true];
getXCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 X = 5 [packed = true];
getXCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 X = 5 [packed = true];
getXDate(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the x-value for one item in a series, as a Date.
getXDate(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the x-value for one item in a series, as a Date.
getXDate(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the x-value for a data item as a date.
getXDateFormat() - Method in class org.jfree.chart.labels.AbstractXYItemLabelGenerator
Returns the date formatter for the x-values.
getXE1left() - Method in class jhplot.P1D
Left error on X (1st level)
getXE1right() - Method in class jhplot.P1D
Right eroor on X
getXE2left() - Method in class jhplot.P1D
Left error on X (2nd level)
getXE2right() - Method in class jhplot.P1D
Right error (2nd level) on X
getXFormat() - Method in class org.jfree.chart.labels.AbstractXYItemLabelGenerator
Returns the number formatter for the x-values.
getXHigh() - Method in class org.jfree.data.xy.XYInterval
Returns the upper bound of the x-interval.
getXHigh() - Method in class org.jfree.data.xy.YWithXInterval
Returns the upper bound of the x-interval.
getXHighValue() - Method in class org.jfree.data.xy.XIntervalDataItem
Returns the upper bound of the x-interval.
getXHighValue(int) - Method in class org.jfree.data.xy.XIntervalSeries
Returns the upper bound of the x-interval for the specified item.
getXHighValue() - Method in class org.jfree.data.xy.XYIntervalDataItem
Returns the upper bound of the x-interval.
getXHighValue(int) - Method in class org.jfree.data.xy.XYIntervalSeries
Returns the upper bound of the x-interval for the specified item in the series.
getXIndices() - Method in interface org.jfree.data.contour.ContourDataset
Deprecated.
Returns the index of the xvalues.
getXIndices() - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the index of the xvalues.
getXlabel() - Method in class jplot3d.JSurfacePanel
 
getXlabel() - Method in interface jplot3d.SurfaceModel
 
getXlabel() - Method in class jplot3d.SurfaceModelCanvas
 
getXleft(int) - Method in class jhplot.P1D
Return a specific left error on X-value.
getXleft(int) - Method in class jplot.DataArray
Return a specific left error on X-value.
getXleft() - Method in class jplot.PlotPoint
Return the current left error on X-value.
getXleft(int) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xleft = 4 [packed = true];
getXleft(int) - Method in class promc.io.PBufFile.Record.P1D
repeated double xleft = 4 [packed = true];
getXleft(int) - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xleft = 4 [packed = true];
getXleftCount() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xleft = 4 [packed = true];
getXleftCount() - Method in class promc.io.PBufFile.Record.P1D
repeated double xleft = 4 [packed = true];
getXleftCount() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xleft = 4 [packed = true];
getXleftList() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xleft = 4 [packed = true];
getXleftList() - Method in class promc.io.PBufFile.Record.P1D
repeated double xleft = 4 [packed = true];
getXleftList() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xleft = 4 [packed = true];
getXleftSys(int) - Method in class jhplot.P1D
Return a specific left error on X-value (systematic error).
getXleftSys(int) - Method in class jplot.DataArray
Return a specific left error on X-value (systematical error).
getXleftSys() - Method in class jplot.PlotPoint
Return the current left systematical error on X-value.
getXList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float X = 13 [packed = true];
getXList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float X = 13 [packed = true];
getXList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float X = 13 [packed = true];
getXList() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double x = 2 [packed = true];
getXList() - Method in class promc.io.PBufFile.Record.P1D
repeated double x = 2 [packed = true];
getXList() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double x = 2 [packed = true];
getXList() - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double x = 2 [packed = true];
getXList() - Method in class promc.io.PBufFile.Record.PXY
repeated double x = 2 [packed = true];
getXList() - Method in interface promc.io.PBufFile.Record.PXYOrBuilder
repeated double x = 2 [packed = true];
getXList() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double x = 2 [packed = true];
getXList() - Method in class promc.io.PBufFile.Record.PXYZ
repeated double x = 2 [packed = true];
getXList() - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
repeated double x = 2 [packed = true];
getXList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
getXList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 X = 13 [packed = true];
getXList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 X = 13 [packed = true];
getXList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
getXList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 X = 13 [packed = true];
getXList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 X = 13 [packed = true];
getXList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 X = 5 [packed = true];
getXList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 X = 5 [packed = true];
getXList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 X = 5 [packed = true];
getXLow() - Method in class org.jfree.data.xy.XYInterval
Returns the lower bound of the x-interval.
getXLow() - Method in class org.jfree.data.xy.YWithXInterval
Returns the lower bound of the x-interval.
getXLowValue() - Method in class org.jfree.data.xy.XIntervalDataItem
Returns the lower bound of the x-interval.
getXLowValue(int) - Method in class org.jfree.data.xy.XIntervalSeries
Returns the lower bound of the x-interval for the specified item.
getXLowValue() - Method in class org.jfree.data.xy.XYIntervalDataItem
Returns the lower bound of the x-interval.
getXLowValue(int) - Method in class org.jfree.data.xy.XYIntervalSeries
Returns the lower bound of the x-interval for the specified item in the series.
getXmax() - Method in class graph.DataSet
return the data X maximum.
getXmax() - Method in class graph.Graph2D
Get the Maximum X value of all attached DataSets.
getXMax() - Method in interface jplot3d.SurfaceModel
 
getXMax() - Method in class jplot3d.SurfaceModelCanvas
 
getXmin() - Method in class graph.DataSet
return the data X minimum.
getXmin() - Method in class graph.Graph2D
Get the Minimum X value of all attached DataSets.
getXMin() - Method in interface jplot3d.SurfaceModel
 
getXMin() - Method in class jplot3d.SurfaceModelCanvas
 
getXmlEncoding() - Method in exception org.apache.commons.io.input.XmlStreamReaderException
Returns the encoding found in the XML prolog of the InputStream.
getXmlGuessEncoding() - Method in exception org.apache.commons.io.input.XmlStreamReaderException
Returns the encoding guess based on the first bytes of the InputStream.
getXOffset() - Method in interface org.jfree.chart.Effect3D
Returns the x-offset (in Java2D units) for the 3D effect.
getXOffset() - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Returns the x-offset for the 3D effect.
getXOffset() - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Returns the x-offset for the 3D effect.
getXOffset() - Method in class org.jfree.chart.renderer.xy.XYLine3DRenderer
Returns the x-offset for the 3D effect.
getXOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 XOuter = 8 [packed = true];
getXOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 XOuter = 8 [packed = true];
getXOuter(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 XOuter = 8 [packed = true];
getXOuterCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 XOuter = 8 [packed = true];
getXOuterCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 XOuter = 8 [packed = true];
getXOuterCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 XOuter = 8 [packed = true];
getXOuterList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 XOuter = 8 [packed = true];
getXOuterList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 XOuter = 8 [packed = true];
getXOuterList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 XOuter = 8 [packed = true];
getXPos() - Method in class jplot.GraphLabel
Returns the X position of the text.
getXPosition() - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the position within each time period that is used for the X value when the collection is used as an XYDataset.
getXPosition() - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the position of the X value within each time period.
getXPosition() - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the position within each time period that is used for the X value when the collection is used as an XYDataset.
getXPosition() - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the position within each time period that is used for the X value.
getXRange() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
 
getXRange() - Method in interface org.jfree.chart.annotations.XYAnnotationBoundsInfo
Returns the range of x-values (in data space) that the annotation uses.
getXRange() - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Returns the x-range for the annotation.
getXright(int) - Method in class jhplot.P1D
Return a specific right error on X-value.
getXright(int) - Method in class jplot.DataArray
Return a specific right error on X-value.
getXright() - Method in class jplot.PlotPoint
Return the current right error on X-value.
getXright(int) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xright = 5 [packed = true];
getXright(int) - Method in class promc.io.PBufFile.Record.P1D
repeated double xright = 5 [packed = true];
getXright(int) - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xright = 5 [packed = true];
getXrightCount() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xright = 5 [packed = true];
getXrightCount() - Method in class promc.io.PBufFile.Record.P1D
repeated double xright = 5 [packed = true];
getXrightCount() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xright = 5 [packed = true];
getXrightList() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xright = 5 [packed = true];
getXrightList() - Method in class promc.io.PBufFile.Record.P1D
repeated double xright = 5 [packed = true];
getXrightList() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xright = 5 [packed = true];
getXrightSys(int) - Method in class jhplot.P1D
Return a specific right error on X-value (systematic error).
getXrightSys(int) - Method in class jplot.DataArray
Return a specific right error on X-value (systematical error).
getXrightSys() - Method in class jplot.PlotPoint
Return the current right systematical error on X-value.
getXSampleCount() - Method in class org.jfree.data.general.DefaultHeatMapDataset
Returns the number of x values across the width of the dataset.
getXSampleCount() - Method in interface org.jfree.data.general.HeatMapDataset
Returns the number of x values across the width of the dataset.
getXScaling() - Method in class jplot3d.Projector
Gets the scaling factor in x direction.
getXSumSquares() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the sum of squared deviations of the x values about their mean.
getXSymbolicValue(int, int) - Method in interface org.jfree.data.xy.XisSymbolic
Returns the symbolic value of the data set specified by series and item parameters.
getXSymbolicValue(Integer) - Method in interface org.jfree.data.xy.XisSymbolic
Returns the symbolic value linked with the specified Integer.
getXSymbolicValues() - Method in interface org.jfree.data.xy.XisSymbolic
Returns the list of symbolic values.
getXsysleft(int) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysleft = 8 [packed = true];
getXsysleft(int) - Method in class promc.io.PBufFile.Record.P1D
repeated double xsysleft = 8 [packed = true];
getXsysleft(int) - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xsysleft = 8 [packed = true];
getXsysleftCount() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysleft = 8 [packed = true];
getXsysleftCount() - Method in class promc.io.PBufFile.Record.P1D
repeated double xsysleft = 8 [packed = true];
getXsysleftCount() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xsysleft = 8 [packed = true];
getXsysleftList() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysleft = 8 [packed = true];
getXsysleftList() - Method in class promc.io.PBufFile.Record.P1D
repeated double xsysleft = 8 [packed = true];
getXsysleftList() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xsysleft = 8 [packed = true];
getXsysright(int) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysright = 9 [packed = true];
getXsysright(int) - Method in class promc.io.PBufFile.Record.P1D
repeated double xsysright = 9 [packed = true];
getXsysright(int) - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xsysright = 9 [packed = true];
getXsysrightCount() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysright = 9 [packed = true];
getXsysrightCount() - Method in class promc.io.PBufFile.Record.P1D
repeated double xsysright = 9 [packed = true];
getXsysrightCount() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xsysright = 9 [packed = true];
getXsysrightList() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysright = 9 [packed = true];
getXsysrightList() - Method in class promc.io.PBufFile.Record.P1D
repeated double xsysright = 9 [packed = true];
getXsysrightList() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double xsysright = 9 [packed = true];
getXval() - Method in class jhplot.P1D
Get array of X values;
getXValue() - Method in class org.jfree.chart.ClipPath
Deprecated.
Returns the xValue.
getXValue(int) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns an x value.
getXValue(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the x-value (as a double primitive) for an item within a series.
getXValue(int) - Method in class org.jfree.data.general.DefaultHeatMapDataset
A convenience method that returns the x-value for the given index.
getXValue(int) - Method in interface org.jfree.data.general.HeatMapDataset
A convenience method that returns the x-value for the given index.
getXValue(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the x-value (as a double primitive) for an item within a series.
getXValue(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the x-value for an item within a series.
getXValue(int, int) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the x-value (as a double primitive) for an item within a series.
getXValue(int, int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the x-value (as a double primitive) for an item within a series.
getXValue(int, int) - Method in class org.jfree.data.xy.AbstractXYDataset
Returns the x-value (as a double primitive) for an item within a series.
getXValue(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the x-value for an item within a series.
getXValue(int, int) - Method in class org.jfree.data.xy.DefaultXYDataset
Returns the x-value for an item within a series.
getXValue(int, int) - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns the x-value for an item within a series.
getXValue() - Method in class org.jfree.data.xy.VectorDataItem
Returns the x-value.
getXValue(int) - Method in class org.jfree.data.xy.VectorSeries
Returns the x-value for the specified item.
getXValue(int, int) - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns the x-value for an item within a series.
getXValue(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the x-value (as a double primitive) for an item within a series.
getXValue() - Method in class org.jfree.data.xy.XYDataItem
Returns the x-value as a double primitive.
getXValue(int, int) - Method in interface org.jfree.data.xy.XYDataset
Returns the x-value for an item within a series.
getXValues() - Method in interface org.jfree.data.contour.ContourDataset
Deprecated.
Returns the array of Numbers representing the x data values.
getXValues() - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the x values.
getXYBarPainter() - Method in class org.jfree.chart.StandardChartTheme
Returns the XY bar painter.
getXYPlot() - Method in class org.jfree.chart.JFreeChart
Returns the plot cast as an XYPlot.
getXYZString() - Method in class j4np.physics.Vector3
 
getY(int) - Method in class jhplot.F1D
Get value in Y-axis
getY(int) - Method in class jhplot.FND
Get value in Y-axis
getY() - Method in class jhplot.HKey
Returns the Y position of the text.
getY() - Method in class jhplot.HLabel
Returns the Y position of the text.
getY() - Method in class jhplot.HLabelEq
Returns the Y position of the text.
getY() - Method in class jhplot.HMLabel
Returns the Y position of the text.
getY(int) - Method in class jhplot.P1D
Return a specific Y-value.
getY(int) - Method in class jhplot.P2D
Return a specific Y-value.
getY(int) - Method in class jhplot.P3D
Return a specific Y-value.
getY(int) - Method in class jplot.DataArray
Return a specific Y-value.
getY(int) - Method in class jplot.DataArray2D
Return a specific Y-value.
getY(int) - Method in class jplot.DataArray3D
Return a specific Y-value.
getY() - Method in class jplot.GraphLabel
Returns the Y position of the bounding box.
getY() - Method in class jplot.PlotPoint
Return the current Y-value.
getY() - Method in class jplot.PlotPoint2D
Return the current Y-value.
getY() - Method in class jplot.PlotPoint3D
Return the current Y-value.
getY() - Method in class jplot3d.JPoint
Return the current Y-value.
getY() - Method in class org.apache.commons.math3.fitting.WeightedObservedPoint
Gets the observed value of the function at x.
getY() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the ordinate of the vector.
getY() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the ordinate of the vector.
getY() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the ordinate of the vector.
getY() - Method in class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint
Deprecated.
Get the observed value of the function at x.
getY() - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Returns the y-coordinate (in data space) for the annotation.
getY() - Method in class org.jfree.chart.annotations.XYImageAnnotation
Returns the y-coordinate (in data space) for the annotation.
getY() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the y coordinate for the text anchor point (measured against the range axis).
getY() - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Returns the y-coordinate for the annotation.
getY() - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Get the y-coordinate for the item's location.
getY() - Method in class org.jfree.chart.renderer.Outlier
Returns the y coordinate of the bounding box containing the outlier ellipse.
getY(int, int) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the y value for the specified series and index (zero-based indices).
getY(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the y-value for the specified series/item.
getY(int, int) - Method in class org.jfree.data.general.CombinedDataset
Deprecated.
Returns the Y-value for the specified series and item.
getY(int, int) - Method in class org.jfree.data.general.SubSeriesDataset
Deprecated.
Returns the Y-value for the specified series and item.
getY(int, int) - Method in class org.jfree.data.jdbc.JDBCXYDataset
Returns the y-value for the specified series and item.
getY(int, int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Returns the y-value for one item in a series.
getY(int, int) - Method in class org.jfree.data.statistics.HistogramDataset
Returns the y-value for a bin (calculated to take into account the histogram type).
getY(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the y-value for an item within a series.
getY(int, int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the y-value.
getY(int, int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns the y-value for an item within a series.
getY(int, int) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Returns the y-value for the specified series and item.
getY(int, int) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the y-value for the specified series and item.
getY(int, int) - Method in class org.jfree.data.time.TimeTableXYDataset
Returns the y-value for an item within a series.
getY(int, int) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns the y-value for the specified series and item.
getY(int, int) - Method in class org.jfree.data.xy.DefaultHighLowDataset
Returns the y-value for one item in a series.
getY(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the y-value for an item within a series.
getY(int, int) - Method in class org.jfree.data.xy.DefaultOHLCDataset
Returns the y-value.
getY(int, int) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the y-value for the specified series and item.
getY(int, int) - Method in class org.jfree.data.xy.DefaultWindDataset
Returns the y-value for one item within a series.
getY(int, int) - Method in class org.jfree.data.xy.DefaultXYDataset
Returns the y-value for an item within a series.
getY(int, int) - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns the y-value for an item within a series.
getY(int, int) - Method in class org.jfree.data.xy.MatrixSeriesCollection
Returns the i index value of the specified Mij matrix item in the specified matrix series.
getY() - Method in class org.jfree.data.xy.Vector
Returns the y-value.
getY(int, int) - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns the y-value for an item within a series.
getY(int, int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the y-value for an item within a series.
getY(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the y-value for an item within a series.
getY() - Method in class org.jfree.data.xy.XYCoordinate
Returns the y-coordinate.
getY() - Method in class org.jfree.data.xy.XYDataItem
Returns the y-value.
getY(int, int) - Method in interface org.jfree.data.xy.XYDataset
Returns the y-value for an item within a series.
getY() - Method in class org.jfree.data.xy.XYInterval
Returns the y-value.
getY(int, int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the y-value for an item within a series.
getY(int) - Method in class org.jfree.data.xy.XYSeries
Returns the y-value at the specified index.
getY(int, int) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the y-value for the specified series and item.
getY() - Method in class org.jfree.data.xy.YInterval
Returns the y-value.
getY(int, int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the y-value for an item within a series.
getY() - Method in class org.jfree.data.xy.YWithXInterval
Returns the y-value.
getY() - Method in class org.jlab.groot.ui.LatexText
 
getY(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Y = 14 [packed = true];
getY(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Y = 14 [packed = true];
getY(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Y = 14 [packed = true];
getY(int) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double y = 3 [packed = true];
getY(int) - Method in class promc.io.PBufFile.Record.P1D
repeated double y = 3 [packed = true];
getY(int) - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double y = 3 [packed = true];
getY(int) - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double y = 3 [packed = true];
getY(int) - Method in class promc.io.PBufFile.Record.PXY
repeated double y = 3 [packed = true];
getY(int) - Method in interface promc.io.PBufFile.Record.PXYOrBuilder
repeated double y = 3 [packed = true];
getY(int) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double y = 3 [packed = true];
getY(int) - Method in class promc.io.PBufFile.Record.PXYZ
repeated double y = 3 [packed = true];
getY(int) - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
repeated double y = 3 [packed = true];
getY(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
getY(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 Y = 14 [packed = true];
getY(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Y = 14 [packed = true];
getY(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
getY(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 Y = 14 [packed = true];
getY(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Y = 14 [packed = true];
getY(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Y = 6 [packed = true];
getY(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 Y = 6 [packed = true];
getY(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 Y = 6 [packed = true];
getYAxis() - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Get the Y axis of the circle.
getYaxis() - Method in class org.jlab.groot.data.H1F
 
getyAxis() - Method in class org.jlab.groot.data.H1F
Retrieves the y-axis as an Axis object
getYAxis() - Method in class org.jlab.groot.data.H2F
 
getYBar() - Method in class jhplot.stat.LinReg
Get average Y
getYBar() - Method in class jhplot.stat.LinRegWeighted
Get average Y
getYColumn(int) - Method in class jplot.DataFile
Returns the index of the column used for the Y-axis.
getYCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Y = 14 [packed = true];
getYCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Y = 14 [packed = true];
getYCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Y = 14 [packed = true];
getYCount() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double y = 3 [packed = true];
getYCount() - Method in class promc.io.PBufFile.Record.P1D
repeated double y = 3 [packed = true];
getYCount() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double y = 3 [packed = true];
getYCount() - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double y = 3 [packed = true];
getYCount() - Method in class promc.io.PBufFile.Record.PXY
repeated double y = 3 [packed = true];
getYCount() - Method in interface promc.io.PBufFile.Record.PXYOrBuilder
repeated double y = 3 [packed = true];
getYCount() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double y = 3 [packed = true];
getYCount() - Method in class promc.io.PBufFile.Record.PXYZ
repeated double y = 3 [packed = true];
getYCount() - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
repeated double y = 3 [packed = true];
getYCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
getYCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 Y = 14 [packed = true];
getYCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Y = 14 [packed = true];
getYCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
getYCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 Y = 14 [packed = true];
getYCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Y = 14 [packed = true];
getYCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Y = 6 [packed = true];
getYCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 Y = 6 [packed = true];
getYCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 Y = 6 [packed = true];
getYCut() - Method in class hep.physics.jet.AbstractJetFinder
Obtain the current ycut
getYCut() - Method in class hep.physics.jet.FixNumberOfJetsFinder
Resulting ycut value.
getYDateFormat() - Method in class org.jfree.chart.labels.AbstractXYItemLabelGenerator
Returns the date formatter for the y-values.
getYE1down() - Method in class jhplot.P1D
Down error on Y (1st level)
getYE1upper() - Method in class jhplot.P1D
Upper error on Y (1st level)
getYE2down() - Method in class jhplot.P1D
Down error on Y (2nd level)
getYE2upper() - Method in class jhplot.P1D
Upper error on Y (2nd level)
getYear() - Method in class org.jfree.data.time.Day
Returns the year.
getYear() - Method in class org.jfree.data.time.Hour
Returns the year in which this hour falls.
getYear() - Method in class org.jfree.data.time.Month
Returns the year in which the month falls.
getYear() - Method in class org.jfree.data.time.Quarter
Returns the year.
getYear() - Method in class org.jfree.data.time.Week
Returns the year in which the week falls.
getYear() - Method in class org.jfree.data.time.Year
Returns the year.
getYearValue() - Method in class org.jfree.data.time.Month
Returns the year in which the month falls.
getYearValue() - Method in class org.jfree.data.time.Quarter
Returns the year.
getYearValue() - Method in class org.jfree.data.time.Week
Returns the year in which the week falls, as an integer value.
getYFormat() - Method in class org.jfree.chart.labels.AbstractXYItemLabelGenerator
Returns the number formatter for the y-values.
getYHigh() - Method in class org.jfree.data.xy.XYInterval
Returns the upper bound of the y-interval.
getYHigh() - Method in class org.jfree.data.xy.YInterval
Returns the upper bound of the y-interval.
getYHighValue() - Method in class org.jfree.data.xy.XYIntervalDataItem
Returns the upper bound of the y-interval.
getYHighValue(int) - Method in class org.jfree.data.xy.XYIntervalSeries
Returns the upper bound of the y-interval for the specified item in the series.
getYHighValue() - Method in class org.jfree.data.xy.YIntervalDataItem
Returns the upper bound of the y-interval.
getYHighValue(int) - Method in class org.jfree.data.xy.YIntervalSeries
Returns the upper bound of the y-interval for the specified item in the series.
getYlabel() - Method in class jplot3d.JSurfacePanel
 
getYlabel() - Method in interface jplot3d.SurfaceModel
 
getYlabel() - Method in class jplot3d.SurfaceModelCanvas
 
getYList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Y = 14 [packed = true];
getYList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Y = 14 [packed = true];
getYList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Y = 14 [packed = true];
getYList() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double y = 3 [packed = true];
getYList() - Method in class promc.io.PBufFile.Record.P1D
repeated double y = 3 [packed = true];
getYList() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double y = 3 [packed = true];
getYList() - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double y = 3 [packed = true];
getYList() - Method in class promc.io.PBufFile.Record.PXY
repeated double y = 3 [packed = true];
getYList() - Method in interface promc.io.PBufFile.Record.PXYOrBuilder
repeated double y = 3 [packed = true];
getYList() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double y = 3 [packed = true];
getYList() - Method in class promc.io.PBufFile.Record.PXYZ
repeated double y = 3 [packed = true];
getYList() - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
repeated double y = 3 [packed = true];
getYList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
getYList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 Y = 14 [packed = true];
getYList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Y = 14 [packed = true];
getYList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
getYList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 Y = 14 [packed = true];
getYList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Y = 14 [packed = true];
getYList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Y = 6 [packed = true];
getYList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 Y = 6 [packed = true];
getYList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 Y = 6 [packed = true];
getYLow() - Method in class org.jfree.data.xy.XYInterval
Returns the lower bound of the y-interval.
getYLow() - Method in class org.jfree.data.xy.YInterval
Returns the lower bound of the y-interval.
getYlower(int) - Method in class jhplot.P1D
Return a specific lower error on Y-value.
getYlower(int) - Method in class jplot.DataArray
Return a specific lower error on Y-value.
getYlower() - Method in class jplot.PlotPoint
Return the lower error on current Y-value.
getYlower(int) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ylower = 7 [packed = true];
getYlower(int) - Method in class promc.io.PBufFile.Record.P1D
repeated double ylower = 7 [packed = true];
getYlower(int) - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double ylower = 7 [packed = true];
getYlowerCount() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ylower = 7 [packed = true];
getYlowerCount() - Method in class promc.io.PBufFile.Record.P1D
repeated double ylower = 7 [packed = true];
getYlowerCount() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double ylower = 7 [packed = true];
getYlowerList() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ylower = 7 [packed = true];
getYlowerList() - Method in class promc.io.PBufFile.Record.P1D
repeated double ylower = 7 [packed = true];
getYlowerList() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double ylower = 7 [packed = true];
getYlowerSys(int) - Method in class jhplot.P1D
Return a specific total lower error on Y-value.
getYlowerSys(int) - Method in class jplot.DataArray
Return a specific total lower error on Y-value.
getYlowerSys() - Method in class jplot.PlotPoint
Return the lower systematical error on current Y-value.
getYLowValue() - Method in class org.jfree.data.xy.XYIntervalDataItem
Returns the lower bound of the y-interval.
getYLowValue(int) - Method in class org.jfree.data.xy.XYIntervalSeries
Returns the lower bound of the Y-interval for the specified item in the series.
getYLowValue() - Method in class org.jfree.data.xy.YIntervalDataItem
Returns the lower bound of the y-interval.
getYLowValue(int) - Method in class org.jfree.data.xy.YIntervalSeries
Returns the lower bound of the Y-interval for the specified item in the series.
getYmax() - Method in class graph.DataSet
return the data Y maximum.
getYmax() - Method in class graph.Graph2D
Get the Maximum Y value of all attached DataSets.
getYMax() - Method in interface jplot3d.SurfaceModel
 
getYMax() - Method in class jplot3d.SurfaceModelCanvas
 
getYmin() - Method in class graph.DataSet
return the data Y minimum.
getYmin() - Method in class graph.Graph2D
Get the Minimum Y value of all attached DataSets.
getYMin() - Method in interface jplot3d.SurfaceModel
 
getYMin() - Method in class jplot3d.SurfaceModelCanvas
 
getYOffset() - Method in interface org.jfree.chart.Effect3D
Returns the y-offset (in Java2D units) for the 3D effect.
getYOffset() - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Returns the y-offset for the 3D effect.
getYOffset() - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Returns the y-offset for the 3D effect.
getYOffset() - Method in class org.jfree.chart.renderer.xy.XYLine3DRenderer
Returns the y-offset for the 3D effect.
getYOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 YOuter = 9 [packed = true];
getYOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 YOuter = 9 [packed = true];
getYOuter(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 YOuter = 9 [packed = true];
getYOuterCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 YOuter = 9 [packed = true];
getYOuterCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 YOuter = 9 [packed = true];
getYOuterCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 YOuter = 9 [packed = true];
getYOuterList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 YOuter = 9 [packed = true];
getYOuterList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 YOuter = 9 [packed = true];
getYOuterList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 YOuter = 9 [packed = true];
getYPos() - Method in class jplot.GraphLabel
Returns the Y position of the text.
getYRange() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
 
getYRange() - Method in interface org.jfree.chart.annotations.XYAnnotationBoundsInfo
Returns the range of y-values (in data space) that the annotation uses.
getYRange() - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Returns the y-range for the annotation.
getYSampleCount() - Method in class org.jfree.data.general.DefaultHeatMapDataset
Returns the number of y values (or samples) for the dataset.
getYSampleCount() - Method in interface org.jfree.data.general.HeatMapDataset
Returns the number of y values (or samples) for the dataset.
getYScaling() - Method in class jplot3d.Projector
Gets the scaling factor in y direction.
getYSymbolicValue(int, int) - Method in interface org.jfree.data.xy.YisSymbolic
Returns the symbolic value of the data set specified by series and item parameters.
getYSymbolicValue(Integer) - Method in interface org.jfree.data.xy.YisSymbolic
Returns the symbolic value linked with the specified Integer.
getYSymbolicValues() - Method in interface org.jfree.data.xy.YisSymbolic
Returns the list of symbolic values.
getYsyslower(int) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysyslower = 11 [packed = true];
getYsyslower(int) - Method in class promc.io.PBufFile.Record.P1D
repeated double ysyslower = 11 [packed = true];
getYsyslower(int) - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double ysyslower = 11 [packed = true];
getYsyslowerCount() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysyslower = 11 [packed = true];
getYsyslowerCount() - Method in class promc.io.PBufFile.Record.P1D
repeated double ysyslower = 11 [packed = true];
getYsyslowerCount() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double ysyslower = 11 [packed = true];
getYsyslowerList() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysyslower = 11 [packed = true];
getYsyslowerList() - Method in class promc.io.PBufFile.Record.P1D
repeated double ysyslower = 11 [packed = true];
getYsyslowerList() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double ysyslower = 11 [packed = true];
getYsysupper(int) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysysupper = 10 [packed = true];
getYsysupper(int) - Method in class promc.io.PBufFile.Record.P1D
repeated double ysysupper = 10 [packed = true];
getYsysupper(int) - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double ysysupper = 10 [packed = true];
getYsysupperCount() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysysupper = 10 [packed = true];
getYsysupperCount() - Method in class promc.io.PBufFile.Record.P1D
repeated double ysysupper = 10 [packed = true];
getYsysupperCount() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double ysysupper = 10 [packed = true];
getYsysupperList() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysysupper = 10 [packed = true];
getYsysupperList() - Method in class promc.io.PBufFile.Record.P1D
repeated double ysysupper = 10 [packed = true];
getYsysupperList() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double ysysupper = 10 [packed = true];
getYupper(int) - Method in class jhplot.P1D
Return a specific upper error on Y-value.
getYupper(int) - Method in class jplot.DataArray
Return a specific upper error on Y-value.
getYupper() - Method in class jplot.PlotPoint
Return the upper error on current Y-value.
getYupper(int) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double yupper = 6 [packed = true];
getYupper(int) - Method in class promc.io.PBufFile.Record.P1D
repeated double yupper = 6 [packed = true];
getYupper(int) - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double yupper = 6 [packed = true];
getYupperCount() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double yupper = 6 [packed = true];
getYupperCount() - Method in class promc.io.PBufFile.Record.P1D
repeated double yupper = 6 [packed = true];
getYupperCount() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double yupper = 6 [packed = true];
getYupperList() - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double yupper = 6 [packed = true];
getYupperList() - Method in class promc.io.PBufFile.Record.P1D
repeated double yupper = 6 [packed = true];
getYupperList() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
repeated double yupper = 6 [packed = true];
getYupperSys(int) - Method in class jhplot.P1D
Return a specific systematical upper error on Y-value.
getYupperSys(int) - Method in class jplot.DataArray
Return a specific systematical upper error on Y-value.
getYupperSys() - Method in class jplot.PlotPoint
Return the upper systematical error on current Y-value.
getYval() - Method in class jhplot.P1D
Get array of Y values;
getYValue() - Method in class org.jfree.chart.ClipPath
Deprecated.
Returns the yValue.
getYValue(int, int) - Method in class org.jfree.data.gantt.XYTaskDataset
Returns the y-value (as a double primitive) for an item within a series.
getYValue(int) - Method in class org.jfree.data.general.DefaultHeatMapDataset
A convenience method that returns the y-value for the given index.
getYValue(int) - Method in interface org.jfree.data.general.HeatMapDataset
A convenience method that returns the y-value for the given index.
getYValue(int, int) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Returns the y-value (as a double primitive) for an item within a series.
getYValue(int, int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the y-value.
getYValue() - Method in class org.jfree.data.time.ohlc.OHLCItem
Returns the y-value.
getYValue(int, int) - Method in class org.jfree.data.xy.AbstractXYDataset
Returns the y-value (as a double primitive) for an item within a series.
getYValue(int, int) - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns the y-value for an item within a series.
getYValue(int, int) - Method in class org.jfree.data.xy.DefaultXYDataset
Returns the y-value for an item within a series.
getYValue(int, int) - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns the y-value for an item within a series.
getYValue() - Method in class org.jfree.data.xy.VectorDataItem
Returns the y-value.
getYValue(int) - Method in class org.jfree.data.xy.VectorSeries
Returns the y-value for the specified item.
getYValue(int, int) - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns the y-value for an item within a series.
getYValue() - Method in class org.jfree.data.xy.XIntervalDataItem
Returns the y-value.
getYValue(int) - Method in class org.jfree.data.xy.XIntervalSeries
Returns the y-value for the specified item.
getYValue(int, int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Returns the y-value (as a double primitive) for an item within a series.
getYValue(int, int) - Method in class org.jfree.data.xy.XYBarDataset
Returns the y-value (as a double primitive) for an item within a series.
getYValue() - Method in class org.jfree.data.xy.XYDataItem
Returns the y-value as a double primitive.
getYValue(int, int) - Method in interface org.jfree.data.xy.XYDataset
Returns the y-value (as a double primitive) for an item within a series.
getYValue() - Method in class org.jfree.data.xy.XYIntervalDataItem
Returns the y-value.
getYValue(int) - Method in class org.jfree.data.xy.XYIntervalSeries
Returns the y-value for the specified item.
getYValue(int, int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Returns the y-value (as a double primitive) for an item within a series.
getYValue() - Method in class org.jfree.data.xy.YIntervalDataItem
Returns the y-value.
getYValue(int) - Method in class org.jfree.data.xy.YIntervalSeries
Returns the y-value for the specified item.
getYValue(int, int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Returns the y-value (as a double primitive) for an item within a series.
getYValues() - Method in interface org.jfree.data.contour.ContourDataset
Deprecated.
Returns the array of Numbers representing the y data values.
getYValues() - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns a Number array containing all y values.
getZ() - Method in class Jampack.Zmat
Returns a copy of the real and imaginary parts as a complex array.
getZ(int) - Method in class jhplot.P2D
Return a specific Z-value.
getZ(int) - Method in class jhplot.P3D
Return a specific Z-value.
getZ(int) - Method in class jplot.DataArray2D
Return a specific Z-value.
getZ(int) - Method in class jplot.DataArray3D
Return a specific Z-value.
getZ() - Method in class jplot.PlotPoint2D
Return the current Z-value.
getZ() - Method in class jplot.PlotPoint3D
Return the current Z-value.
getZ() - Method in class jplot3d.JPoint
Return the current Z-value.
getZ() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the height of the vector.
getZ() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the height of the vector.
getZ(int, int) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the z value for the specified series and index (zero-based indices).
getZ(int, int) - Method in class org.jfree.data.general.DefaultHeatMapDataset
Returns the z-value at the specified sample position in the dataset.
getZ(int, int) - Method in interface org.jfree.data.general.HeatMapDataset
Returns the z-value at the specified sample position in the dataset.
getZ(int, int) - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns the z-value for an item within a series.
getZ(int, int) - Method in class org.jfree.data.xy.MatrixSeriesCollection
Returns the Mij item value of the specified Mij matrix item in the specified matrix series.
getZ(int, int) - Method in interface org.jfree.data.xy.XYZDataset
Returns the z-value for the specified series and item.
getZ(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Z = 15 [packed = true];
getZ(int) - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Z = 15 [packed = true];
getZ(int) - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Z = 15 [packed = true];
getZ(int) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double z = 4 [packed = true];
getZ(int) - Method in class promc.io.PBufFile.Record.PXYZ
repeated double z = 4 [packed = true];
getZ(int) - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
repeated double z = 4 [packed = true];
getZ(int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
getZ(int) - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 Z = 15 [packed = true];
getZ(int) - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Z = 15 [packed = true];
getZ(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
getZ(int) - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 Z = 15 [packed = true];
getZ(int) - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Z = 15 [packed = true];
getZ(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Z = 7 [packed = true];
getZ(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 Z = 7 [packed = true];
getZ(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 Z = 7 [packed = true];
getZ0() - Method in interface hep.lcio.event.Track
Impact paramter of the track in (r-z).
getZ0() - Method in interface hep.lcio.event.TrackState
Impact paramter of the track in (r-z).
getZ0() - Method in class hep.lcio.implementation.event.ITrack
 
getZ0() - Method in class hep.lcio.implementation.event.ITrackState
 
getZCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Z = 15 [packed = true];
getZCount() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Z = 15 [packed = true];
getZCount() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Z = 15 [packed = true];
getZCount() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double z = 4 [packed = true];
getZCount() - Method in class promc.io.PBufFile.Record.PXYZ
repeated double z = 4 [packed = true];
getZCount() - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
repeated double z = 4 [packed = true];
getZCount() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
getZCount() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 Z = 15 [packed = true];
getZCount() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Z = 15 [packed = true];
getZCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
getZCount() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 Z = 15 [packed = true];
getZCount() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Z = 15 [packed = true];
getZCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Z = 7 [packed = true];
getZCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 Z = 7 [packed = true];
getZCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 Z = 7 [packed = true];
getZDateFormat() - Method in class org.jfree.chart.labels.BubbleXYItemLabelGenerator
Returns the date formatter for the z-values.
getZDateFormat() - Method in class org.jfree.chart.labels.StandardXYZToolTipGenerator
Returns the date formatter for the z-values.
getZero() - Method in class org.apache.commons.math3.complex.ComplexField
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math3.dfp.Dfp
Get the constant 0.
getZero() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant 0.
getZero() - Method in interface org.apache.commons.math3.Field
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math3.fraction.BigFractionField
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math3.fraction.FractionField
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - Method in interface org.apache.commons.math3.geometry.Vector
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - Method in class org.apache.commons.math3.util.BigRealField
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math3.util.Decimal64Field
Get the additive identity of the field.
getZERO() - Method in interface org.lsmp.djep.groupJep.GroupI
Returns the identity element under +
getZERO() - Method in class org.lsmp.djep.groupJep.groups.BigReals
 
getZERO() - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
getZERO() - Method in class org.lsmp.djep.groupJep.groups.Integers
 
getZERO() - Method in class org.lsmp.djep.groupJep.groups.PermutationGroup
 
getZERO() - Method in class org.lsmp.djep.groupJep.groups.Quaternions
 
getZERO() - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
getZERO() - Method in class org.lsmp.djep.groupJep.groups.Reals
 
getZERO() - Method in class org.lsmp.djep.groupJep.groups.Zn
 
getZERO() - Method in class org.lsmp.djep.xjep.TreeUtils
 
getZero() - Method in class org.nfunk.jep.type.DoubleNumberFactory
 
getZero() - Method in interface org.nfunk.jep.type.NumberFactory
Return an object representing ZERO the additive identity.
getZeroStrokeWidth() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the width to use for the stroke when the AWT stroke specified has a zero width (the default value is 0.5).
getZFormat() - Method in class org.jfree.chart.labels.BubbleXYItemLabelGenerator
Returns the number formatter for the z-values.
getZFormat() - Method in class org.jfree.chart.labels.StandardXYZToolTipGenerator
Returns the number formatter for the z-values.
getZlabel() - Method in class jplot3d.JSurfacePanel
 
getZlabel() - Method in interface jplot3d.SurfaceModel
 
getZlabel() - Method in class jplot3d.SurfaceModelCanvas
 
getZList() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Z = 15 [packed = true];
getZList() - Method in class proeic.io.ProMC.ProMCEvent.Particles
repeated float Z = 15 [packed = true];
getZList() - Method in interface proeic.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated float Z = 15 [packed = true];
getZList() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double z = 4 [packed = true];
getZList() - Method in class promc.io.PBufFile.Record.PXYZ
repeated double z = 4 [packed = true];
getZList() - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
repeated double z = 4 [packed = true];
getZList() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
getZList() - Method in class promc.io.ProMC.ProMCEvent.Particles
repeated sint32 Z = 15 [packed = true];
getZList() - Method in interface promc.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Z = 15 [packed = true];
getZList() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
getZList() - Method in class proreco.io.ProMC.ProMCEvent.Particles
repeated sint32 Z = 15 [packed = true];
getZList() - Method in interface proreco.io.ProMC.ProMCEvent.ParticlesOrBuilder
repeated sint32 Z = 15 [packed = true];
getZList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Z = 7 [packed = true];
getZList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 Z = 7 [packed = true];
getZList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 Z = 7 [packed = true];
getZMax() - Method in interface jplot3d.SurfaceModel
 
getZMax() - Method in class jplot3d.SurfaceModelCanvas
 
getZMin() - Method in interface jplot3d.SurfaceModel
 
getZMin() - Method in class jplot3d.SurfaceModelCanvas
 
getZoomAroundAnchor() - Method in class org.jfree.chart.ChartPanel
Returns the flag that controls whether or not zoom operations are centered around the current anchor point.
getZoomFactor() - Method in class org.jfree.chart.fx.interaction.ScrollHandlerFX
Returns the zoom factor.
getZoomFillPaint() - Method in class org.jfree.chart.ChartPanel
Returns the zoom rectangle fill paint.
getZoomFillPaint() - Method in class org.jfree.chart.fx.ChartViewerSkin
Returns the current fill paint for the zoom rectangle.
getZoomInFactor() - Method in class org.jfree.chart.ChartPanel
Returns the zoom in factor.
getZoomOutFactor() - Method in class org.jfree.chart.ChartPanel
Returns the zoom out factor.
getZoomOutlinePaint() - Method in class org.jfree.chart.ChartPanel
Returns the zoom rectangle outline paint.
getZoomTriggerDistance() - Method in class org.jfree.chart.ChartPanel
Returns the zoom trigger distance.
getZOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 ZOuter = 10 [packed = true];
getZOuter(int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 ZOuter = 10 [packed = true];
getZOuter(int) - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 ZOuter = 10 [packed = true];
getZOuterCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 ZOuter = 10 [packed = true];
getZOuterCount() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 ZOuter = 10 [packed = true];
getZOuterCount() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 ZOuter = 10 [packed = true];
getZOuterList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 ZOuter = 10 [packed = true];
getZOuterList() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
repeated sint32 ZOuter = 10 [packed = true];
getZOuterList() - Method in interface proreco.io.ProMC.ProMCEvent.TracksOrBuilder
repeated sint32 ZOuter = 10 [packed = true];
getZRange() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
 
getZScaling() - Method in class jplot3d.Projector
Gets the scaling factor in z direction.
getZValue(int, int) - Method in class org.jfree.data.general.DefaultHeatMapDataset
Returns the z-value at the specified sample position in the dataset.
getZValue(int, int) - Method in interface org.jfree.data.general.HeatMapDataset
Returns the z-value at the specified sample position in the dataset.
getZValue(int, int) - Method in class org.jfree.data.xy.AbstractXYZDataset
Returns the z-value (as a double primitive) for an item within a series.
getZValue(int, int) - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns the z-value for an item within a series.
getZValue(int, int) - Method in interface org.jfree.data.xy.XYZDataset
Returns the z-value (as a double primitive) for an item within a series.
getZValueRange(Range, Range) - Method in interface org.jfree.data.contour.ContourDataset
Deprecated.
Returns the maximum z-value within visible region of plot.
getZValueRange(Range, Range) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns the maximum z-value within visible region of plot.
getZValues() - Method in interface org.jfree.data.contour.ContourDataset
Deprecated.
Returns the array of Numbers representing the z data values.
getZValues() - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns a Number array containing all z values.
GeV - Static variable in class cern.clhep.Units
 
GHFontChooser - Class in jhplot.utils
Font selection dialog
GHFontChooser(Container, String) - Constructor for class jhplot.utils.GHFontChooser
 
GHFontChooser(JComponent) - Constructor for class jhplot.utils.GHFontChooser
 
GHFrame - Class in jhplot.gui
Create main Frame with several plots.
GHFrame(String, int, int, int, int, boolean) - Constructor for class jhplot.gui.GHFrame
Create main frame window with all HPlot menus.
GHFrame(String, int, int, int, int, boolean, int) - Constructor for class jhplot.gui.GHFrame
Create main frame window for all Dmelt canvases.
GHFrame(String, int, int) - Constructor for class jhplot.gui.GHFrame
Construct a GHFrame with a single plot/graph.
GHFrame(String, int, int, boolean) - Constructor for class jhplot.gui.GHFrame
Construct a GHFrame canvas with a single plot/graph.
GHFrame(String, int, int, int, int) - Constructor for class jhplot.gui.GHFrame
Construct a GHFrame canvas with plots/graphs.
GHFrame(String) - Constructor for class jhplot.gui.GHFrame
Construct a GHFrame canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
GHFrame() - Constructor for class jhplot.gui.GHFrame
Construct a GHFrame canvas with a plot with the default parameters 600 by 400, and 10% space for the global title "Default".
GHMargin - Class in jhplot.gui
Panels with global margin.
GHMargin(GHPanel, String) - Constructor for class jhplot.gui.GHMargin
Main class to create global margin
GHPanel - Class in jhplot.gui
Class to build the global panel with graphics.
GHPanel(int, int) - Constructor for class jhplot.gui.GHPanel
Create a panel with graphics.
gid() - Method in class j4np.physics.PDGParticle
 
GIF - Static variable in interface org.jfree.chart.encoders.ImageFormat
Graphics Interchange Format - lossless, but 256 colour restriction
gigaelectronvolt - Static variable in class cern.clhep.Units
 
GillFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements the Gill fourth order Runge-Kutta integrator for Ordinary Differential Equations .
GillFieldIntegrator(Field<T>, T) - Constructor for class org.apache.commons.math3.ode.nonstiff.GillFieldIntegrator
Simple constructor.
GillIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the Gill fourth order Runge-Kutta integrator for Ordinary Differential Equations .
GillIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.GillIntegrator
Simple constructor.
GList - Class in org.lsmp.djep.groupJep.function
List function for use with arbitary groups.
GList(GroupI) - Constructor for class org.lsmp.djep.groupJep.function.GList
 
Global - Class in jminhep.clcontrol
Main global parameters for clustering
Global() - Constructor for class jminhep.clcontrol.Global
 
globalCC() - Method in class org.freehep.math.minuit.MnGlobalCorrelationCoeff
 
globalFont - Static variable in class jhepsim.SetEnv
 
GLogical - Class in org.lsmp.djep.groupJep.function
Implements logical operators for a group.
GLogical(int) - Constructor for class org.lsmp.djep.groupJep.function.GLogical
Constructs
GLSMultipleLinearRegression - Class in org.apache.commons.math3.stat.regression
The GLS implementation of multiple linear regression.
GLSMultipleLinearRegression() - Constructor for class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
 
GMod - Class in org.lsmp.djep.groupJep.function
Modulus operator for group.
GMod(GroupI) - Constructor for class org.lsmp.djep.groupJep.function.GMod
 
GMultiply - Class in org.lsmp.djep.groupJep.function
Multiplication operator for a group.
GMultiply(GroupI) - Constructor for class org.lsmp.djep.groupJep.function.GMultiply
 
GNot - Class in org.lsmp.djep.groupJep.function
Not function for use with arbitary groups.
GNot() - Constructor for class org.lsmp.djep.groupJep.function.GNot
 
Go() - Method in class jplot3dp.MathParser.MathParser
 
GoalType - Enum in org.apache.commons.math3.optim.nonlinear.scalar
Goal type for an optimization problem (minimization or maximization of a scalar function.
GoalType - Enum in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
GOBIT_FIXED - Static variable in interface hep.lcio.event.LCIO
 
GOLD_B - Static variable in class jplot3d.ColorModelSet
 
GOLD_H - Static variable in class jplot3d.ColorModelSet
 
GOLD_S - Static variable in class jplot3d.ColorModelSet
 
GOperatorSet - Class in org.lsmp.djep.groupJep
The set of operators used in the parser.
GOperatorSet(GroupI) - Constructor for class org.lsmp.djep.groupJep.GOperatorSet
TODO Should really change the properties of operators, might muck up simplification.
GPoints - Class in jplot
Draws a point-type corresponding to a symbolic constant, yielding values.
GPoints() - Constructor for class jplot.GPoints
 
GPower - Class in org.lsmp.djep.groupJep.function
Power operator for a group.
GPower(GroupI) - Constructor for class org.lsmp.djep.groupJep.function.GPower
 
gradient() - Method in interface org.apache.commons.math3.analysis.DifferentiableMultivariateFunction
Deprecated.
Returns the gradient function.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Gaussian.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logistic.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logit.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Sigmoid.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - Method in interface org.apache.commons.math3.analysis.ParametricUnivariateFunction
Compute the gradient of the function with respect to its parameters.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction.Parametric
Compute the gradient of the function with respect to its parameters.
gradient(double[]) - Method in interface org.freehep.math.minuit.FCNGradientBase
Calculate the function gradient with respect to each parameter at the given point in parameter space.
GradientBarPainter - Class in org.jfree.chart.renderer.category
An implementation of the BarPainter interface that uses several gradient fills to enrich the appearance of the bars.
GradientBarPainter() - Constructor for class org.jfree.chart.renderer.category.GradientBarPainter
Creates a new instance.
GradientBarPainter(double, double, double) - Constructor for class org.jfree.chart.renderer.category.GradientBarPainter
Creates a new instance.
GradientFunction - Class in org.apache.commons.math3.analysis.differentiation
Class representing the gradient of a multivariate function.
GradientFunction(MultivariateDifferentiableFunction) - Constructor for class org.apache.commons.math3.analysis.differentiation.GradientFunction
Simple constructor.
GradientMultivariateOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar
Base class for implementing optimizers for multivariate scalar differentiable functions.
gradientNCycles() - Method in class org.freehep.math.minuit.MnStrategy
 
gradientStepTolerance() - Method in class org.freehep.math.minuit.MnStrategy
 
gradientTolerance() - Method in class org.freehep.math.minuit.MnStrategy
 
GradientXYBarPainter - Class in org.jfree.chart.renderer.xy
An implementation of the XYBarPainter interface that uses several gradient fills to enrich the appearance of the bars.
GradientXYBarPainter() - Constructor for class org.jfree.chart.renderer.xy.GradientXYBarPainter
Creates a new instance.
GradientXYBarPainter(double, double, double) - Constructor for class org.jfree.chart.renderer.xy.GradientXYBarPainter
Creates a new instance.
GraggBulirschStoerIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements a Gragg-Bulirsch-Stoer integrator for Ordinary Differential Equations.
GraggBulirschStoerIntegrator(double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Simple constructor.
GraggBulirschStoerIntegrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Simple constructor.
gram - Static variable in class cern.clhep.Units
 
graph - package graph
 
Graph2D - Class in graph
This is the main plotting class.
Graph2D() - Constructor for class graph.Graph2D
 
GraphCanvas - Class in org.nfunk.jepexamples
This class plots a graph using the JEP API.
GraphCanvas(String, TextField) - Constructor for class org.nfunk.jepexamples.GraphCanvas
Constructor
GRAPHERRORS - Static variable in class org.jlab.groot.base.DatasetAttributes
 
GraphErrors - Class in org.jlab.groot.data
 
GraphErrors() - Constructor for class org.jlab.groot.data.GraphErrors
 
GraphErrors(String, double[], double[], double[], double[]) - Constructor for class org.jlab.groot.data.GraphErrors
 
GraphErrors(String, double[], double[]) - Constructor for class org.jlab.groot.data.GraphErrors
 
GraphErrors(String) - Constructor for class org.jlab.groot.data.GraphErrors
 
GraphErrorsPlotter - Class in org.jlab.groot.graphics
 
GraphErrorsPlotter(IDataSet) - Constructor for class org.jlab.groot.graphics.GraphErrorsPlotter
 
GraphGeneral - Class in jplot
The Graph class builds a panel which displays a graph according to the data stored in the DataArray.
GraphGeneral(JPlot, GraphSettings) - Constructor for class jplot.GraphGeneral
Main constructor.
GraphGeneral(GraphSettings) - Constructor for class jplot.GraphGeneral
Main constructor.
GraphGeneral.DragListener - Class in jplot
Drag listener, does the actual painting during dragging.
GraphGeneral.GraphMouseListener - Class in jplot
GraphMouseListener, allows to drag'n drop with the mouse.
graphics - Variable in class jplot3d.JSurface
 
GraphicsAxis - Class in org.jlab.groot.graphics
 
GraphicsAxis(int) - Constructor for class org.jlab.groot.graphics.GraphicsAxis
default
GraphicsAxis - Class in org.jlab.groot.ui
 
GraphicsAxis() - Constructor for class org.jlab.groot.ui.GraphicsAxis
default
GraphicsAxis.GraphicsAxisTicks - Class in org.jlab.groot.graphics
 
GraphicsAxisFrame - Class in org.jlab.groot.graphics
 
GraphicsAxisFrame() - Constructor for class org.jlab.groot.graphics.GraphicsAxisFrame
 
GraphicsAxisFrame - Class in org.jlab.groot.ui
 
GraphicsAxisFrame() - Constructor for class org.jlab.groot.ui.GraphicsAxisFrame
 
GraphicsAxisFrame(int) - Constructor for class org.jlab.groot.ui.GraphicsAxisFrame
 
GraphicsAxisLabels - Class in org.jlab.groot.ui
 
GraphicsAxisLabels() - Constructor for class org.jlab.groot.ui.GraphicsAxisLabels
 
GraphicsAxisTests - Class in org.jlab.groot.graphics
 
GraphicsAxisTests() - Constructor for class org.jlab.groot.graphics.GraphicsAxisTests
 
GraphicsAxisTicks() - Constructor for class org.jlab.groot.graphics.GraphicsAxis.GraphicsAxisTicks
 
graphicsFrameLineWidth - Static variable in class org.jlab.groot.base.GStyle
 
GraphicsTests - Class in org.jlab.groot.base
 
GraphicsTests() - Constructor for class org.jlab.groot.base.GraphicsTests
 
GraphLabel - Class in jplot
This class defines a label in terms of the actual text, font, color and position but also stuff like rotation, whether to hide or show etc.
GraphLabel(int, String, Font, Color) - Constructor for class jplot.GraphLabel
Constructor, sets the text of the label.
GraphLabel(int, Font, Color) - Constructor for class jplot.GraphLabel
Constructor, sets the text of the label.
GraphLabel(int, String) - Constructor for class jplot.GraphLabel
Constructor, sets the text of the label.
GraphLabel(String) - Constructor for class jplot.GraphLabel
Constructor, sets the text of the label.
GraphLabel(int) - Constructor for class jplot.GraphLabel
Constructor, sets the ID of the label but no text.
GraphLabel() - Constructor for class jplot.GraphLabel
Constructor, does nothing but initializing.
GraphLabel(GraphLabel) - Constructor for class jplot.GraphLabel
Constructor, builds the class with another graph label.
GraphMouseListener() - Constructor for class jplot.GraphGeneral.GraphMouseListener
 
GraphSettings - Class in jplot
GraphSettings contains the parameters which are used to draw the graph such as number of ticks, scaling values, offset parameters, axis lengths, colors, fonts, labels and their positions and much more.
GraphSettings(JFrame) - Constructor for class jplot.GraphSettings
Principal constructor.
GraphSettings() - Constructor for class jplot.GraphSettings
Principal constructor.
GRAPHTYPE_2D - Static variable in class jplot.GraphSettings
Graphtype, normal (classical) 2D graph.
GRAPHTYPE_MULTI - Static variable in class jplot.GraphSettings
Graphtype, the not-very-common multi-plot graph.
GRAPHTYPE_PIPER - Static variable in class jplot.GraphSettings
Graphtype, piper diagram (ask geochemists what that is).
GraphXY - Class in jplot
The GraphXY class builds a panel which displays a 2Dgraph according to the data stored in the DataArray.
GraphXY(JPlot, GraphSettings) - Constructor for class jplot.GraphXY
Main constructor.
GraphXY(GraphSettings) - Constructor for class jplot.GraphXY
Constructor, sets the settings to their default values.
GRAV - Static variable in class graph.SpecialFunction
Gravitational Constant.
GRAVACC - Static variable in class graph.SpecialFunction
Gravitational Acceleration at the Earths surface.
gray - Static variable in class cern.clhep.Units
 
GrayPaintScale - Class in org.jfree.chart.renderer
A paint scale that returns shades of gray.
GrayPaintScale() - Constructor for class org.jfree.chart.renderer.GrayPaintScale
Creates a new GrayPaintScale instance with default values.
GrayPaintScale(double, double) - Constructor for class org.jfree.chart.renderer.GrayPaintScale
Creates a new paint scale for values in the specified range.
GrayPaintScale(double, double, int) - Constructor for class org.jfree.chart.renderer.GrayPaintScale
Creates a new paint scale for values in the specified range.
greater(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A[row,col] = A[row,col] > s ? 1 : 0.
greater(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A[row,col] = A[row,col] > B[row,col] ? 1 : 0.
greater - Static variable in class cern.jet.math.Functions
Function that returns a > b ? 1 : 0.
greater(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a > b ? 1 : 0.
GREATER - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
GREATEREQ - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
greaterThan(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is greater than x.
GREEK_QUARTERS - Static variable in class org.jfree.chart.axis.QuarterDateFormat
Symbols for greek numbered quarters.
green3D - Static variable in class org.jlab.groot.base.ColorPalette
 
GreyPalette - Class in org.jfree.chart.plot
Deprecated.
This class is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
GreyPalette() - Constructor for class org.jfree.chart.plot.GreyPalette
Deprecated.
Creates a new palette.
GridArrangement - Class in org.jfree.chart.block
Arranges blocks in a grid within their container.
GridArrangement(int, int) - Constructor for class org.jfree.chart.block.GridArrangement
Creates a new grid arrangement.
gridcolor - Variable in class graph.Axis
Color of the grid
gridcolor - Variable in class graph.Graph2D
The color of the grid to be drawn
gridDivsU - Variable in class jplot3dp.ModelView.ModelFunction
 
gridDivsV - Variable in class jplot3dp.ModelView.ModelFunction
 
GridOperations - Class in org.jlab.groot.matrix
 
GridOperations() - Constructor for class org.jlab.groot.matrix.GridOperations
 
GridOptions() - Constructor for class jplot.panels.PanelAxes.GridOptions
Principal constructor.
GridStudio - Class in org.jlab.groot.matrix
 
GridStudio(String) - Constructor for class org.jlab.groot.matrix.GridStudio
 
GridStudio() - Constructor for class org.jlab.groot.matrix.GridStudio
 
gridToFront() - Method in class jplot.GraphSettings
Flag, saying whether the grid should be drawn at the foreground or not.
GROOTDemo - Class in org.jlab.groot.demo
 
GROOTDemo() - Constructor for class org.jlab.groot.demo.GROOTDemo
 
GROOTStudio - Class in org.jlab.groot.studio
 
GROOTStudio() - Constructor for class org.jlab.groot.studio.GROOTStudio
 
grootStyle - Static variable in class org.jlab.groot.base.TStyle
 
Group - Class in org.lsmp.djep.groupJep.groups
Base abstract class for all groups.
Group() - Constructor for class org.lsmp.djep.groupJep.groups.Group
 
GROUP_FIELD_NUMBER - Static variable in class promc.io.PEventFile.HEvent
 
GroupConsole - Class in org.lsmp.djepExamples
Console application with handling for abstract groups
GroupConsole() - Constructor for class org.lsmp.djepExamples.GroupConsole
 
GroupedStackedBarRenderer - Class in org.jfree.chart.renderer.category
A renderer that draws stacked bars within groups.
GroupedStackedBarRenderer() - Constructor for class org.jfree.chart.renderer.category.GroupedStackedBarRenderer
Creates a new renderer.
GroupI - Interface in org.lsmp.djep.groupJep
Represents a group with an identity, and addition operator.
GroupJep - Class in org.lsmp.djep.groupJep
An extension of JEP which allows calculations over arbitary groups, such as the integers(exact answers) and rationals.
GroupJep(GroupI) - Constructor for class org.lsmp.djep.groupJep.GroupJep
Create a new GroupJep instance with calculations over the given group.
GroupJep(JEP) - Constructor for class org.lsmp.djep.groupJep.GroupJep
 
GroupJepTest - Class in org.lsmp.djepJUnit
Tests some strange properties of special groups.
GroupJepTest(String) - Constructor for class org.lsmp.djepJUnit.GroupJepTest
 
grow(double) - Method in class org.jlab.groot.math.Dimension1D
 
grow(double, double) - Method in class org.jlab.groot.math.Dimension2D
 
grow(Dimension2D) - Method in class org.jlab.groot.math.Dimension2D
 
grow(double, double, double) - Method in class org.jlab.groot.math.Dimension3D
 
grow(Dimension3D) - Method in class org.jlab.groot.math.Dimension3D
 
GStyle - Class in org.jlab.groot.base
 
GStyle() - Constructor for class org.jlab.groot.base.GStyle
 
GSubtract - Class in org.lsmp.djep.groupJep.function
Subtract operator for a group.
GSubtract(GroupI) - Constructor for class org.lsmp.djep.groupJep.function.GSubtract
 
GT - Static variable in class org.lsmp.djep.rpe.RpEval
 
GT - Static variable in class org.nfunk.jep.function.Comparative
 
gt(Object, Object) - Method in class org.nfunk.jep.function.Comparative
 
GT - Static variable in interface org.nfunk.jep.ParserConstants
 
GTest - Class in org.apache.commons.math3.stat.inference
Implements G Test statistics.
GTest() - Constructor for class org.apache.commons.math3.stat.inference.GTest
 
gTest(double[], long[]) - Method in class org.apache.commons.math3.stat.inference.GTest
Returns the observed significance level, or p-value, associated with a G-Test for goodness of fit comparing the observed frequency counts to those in the expected array.
gTest(double[], long[], double) - Method in class org.apache.commons.math3.stat.inference.GTest
Performs a G-Test (Log-Likelihood Ratio Test) for goodness of fit evaluating the null hypothesis that the observed counts conform to the frequency distribution described by the expected counts, with significance level alpha.
gTest(double[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
gTest(double[], long[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
gTestDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math3.stat.inference.GTest
Returns the observed significance level, or p-value, associated with a G-Value (Log-Likelihood Ratio) for two sample test comparing bin frequency counts in observed1 and observed2.
gTestDataSetsComparison(long[], long[], double) - Method in class org.apache.commons.math3.stat.inference.GTest
Performs a G-Test (Log-Likelihood Ratio Test) comparing two binned data sets.
gTestDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
gTestDataSetsComparison(long[], long[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
gTestIntrinsic(double[], long[]) - Method in class org.apache.commons.math3.stat.inference.GTest
Returns the intrinsic (Hardy-Weinberg proportions) p-Value, as described in p64-69 of McDonald, J.H.
gTestIntrinsic(double[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
guess() - Method in class org.apache.commons.math3.fitting.GaussianCurveFitter.ParameterGuesser
Gets an estimation of the parameters.
guess() - Method in class org.apache.commons.math3.fitting.GaussianFitter.ParameterGuesser
Deprecated.
Gets an estimation of the parameters.
guess() - Method in class org.apache.commons.math3.fitting.HarmonicCurveFitter.ParameterGuesser
Gets an estimation of the parameters.
guess() - Method in class org.apache.commons.math3.fitting.HarmonicFitter.ParameterGuesser
Deprecated.
Gets an estimation of the parameters.
guess() - Method in class org.apache.commons.math3.optimization.fitting.GaussianFitter.ParameterGuesser
Deprecated.
Gets an estimation of the parameters.
guess() - Method in class org.apache.commons.math3.optimization.fitting.HarmonicFitter.ParameterGuesser
Deprecated.
Gets an estimation of the parameters.
guessParametersErrors() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated.
as of version 3.1, AbstractLeastSquaresOptimizer.computeSigma(double[],double) should be used instead. It should be emphasized that guessParametersErrors and computeSigma are not strictly equivalent.
GumbelDistribution - Class in org.apache.commons.math3.distribution
This class implements the Gumbel distribution.
GumbelDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.GumbelDistribution
Build a new instance.
GumbelDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.GumbelDistribution
Build a new instance.
GUMinus - Class in org.lsmp.djep.groupJep.function
Unitary division for a group.
GUMinus(GroupI) - Constructor for class org.lsmp.djep.groupJep.function.GUMinus
 

H

H - Class in Jampack
H computes the conjugate transpose of a matrix and the transpose of a complex matrix.
H() - Constructor for class Jampack.H
 
H - Variable in class Jampack.Zhess
The upper Hessenberg matrix
H1D - Class in jhplot
Histogram in one dimension (1D).
H1D() - Constructor for class jhplot.H1D
Build 1D histogram.
H1D(String, int, double, double) - Constructor for class jhplot.H1D
Build 1D histogram
H1D(String, double[]) - Constructor for class jhplot.H1D
Create 1D histogram with variable bin size.
H1D(String, IAxis) - Constructor for class jhplot.H1D
Create 1D histogram with variable bin size.
H1D(Histogram1D) - Constructor for class jhplot.H1D
Create H1D histogram from JAIDA Histogram1D class.
H1D(Cloud1D, int) - Constructor for class jhplot.H1D
Create H1D histogram from JAIDA Cloud1D class.
H1D(IHistogram1D) - Constructor for class jhplot.H1D
Create H1D histogram from JAIDA IHistogram1D class
H1D(String, H1D) - Constructor for class jhplot.H1D
Create H1D from another instance.
H1D(TH1) - Constructor for class jhplot.H1D
Create H1D histogram from JAIDA TH1 histogram class
H1D - Static variable in class jplot.LinePars
 
H1D_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
H1DA - Class in jhplot
Adaptive histogram in one dimension (1D).
H1DA() - Constructor for class jhplot.H1DA
Create addaptive histogram.
H1F - Class in org.jlab.groot.data
Defines the class to create a basic 1D Histogram
H1F() - Constructor for class org.jlab.groot.data.H1F
The default constructor, which creates a Histogram1D object with the Name "default", the Title "default", no Axis titles, and sets the minimum xAxis value to 0, the maximum x value to 1, and creates 1 bin.
H1F(String, String, String, int, double, double) - Constructor for class org.jlab.groot.data.H1F
Creates a Histogram1D object using the specified name, axis titles, number of bins, and minimum and maximum x axis values.
H1F(String, double, double, float[]) - Constructor for class org.jlab.groot.data.H1F
Creates a 1-D Histogram with the specified name, minimum and maximum x-axis values, and the bin heights
H1F(String, int, double, double) - Constructor for class org.jlab.groot.data.H1F
Creates a 1-D Histogram with the specified name, number of bins, and minimum and maximum x-axis values
H1F(String, String, int, double, double) - Constructor for class org.jlab.groot.data.H1F
Creates a 1-D Histogram with the specified name, title, number of bins, and minimum and maximum x-axis values
H1F(String, String, double, double) - Constructor for class org.jlab.groot.data.H1F
Creates a new histogram using the name, title, minimum, and maximum.
H2D - Class in jhplot
Histogram in two dimensions (2D).
H2D(String, int, double, double, int, double, double) - Constructor for class jhplot.H2D
Create 2D histogram
H2D(IHistogram2D) - Constructor for class jhplot.H2D
Create H2D histogram from JAIDA IHistogram2D class
H2D(Cloud2D, int, int) - Constructor for class jhplot.H2D
Create H2D histogram from Cloud2D.
H2D(String, double[], double[]) - Constructor for class jhplot.H2D
Create a 2D histogram using variable size bins in X and Y
H2D(String, IAxis, IAxis) - Constructor for class jhplot.H2D
Define H2D in terms of axis
H2D(Histogram2D) - Constructor for class jhplot.H2D
Create a H2D histogram from JAIDA histogram
H2D(TH2) - Constructor for class jhplot.H2D
Create H2D histogram from JAIDA TH1 histogram class
H2D - Static variable in class jplot.LinePars
 
H2D_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
H2F - Class in org.jlab.groot.data
Specifies the methods to create a 2D Histogram and operations to fill it and set values to its bins
H2F() - Constructor for class org.jlab.groot.data.H2F
 
H2F(String) - Constructor for class org.jlab.groot.data.H2F
Creates an empty 2D Histogram with 1 bin x and y axes
H2F(String, int, double, double, int, double, double) - Constructor for class org.jlab.groot.data.H2F
Creates a 2D Histogram with the specified parameters.
H2F(String, String, int, double, double, int, double, double) - Constructor for class org.jlab.groot.data.H2F
 
H3D - Class in jhplot
Create histogram in 3D
H3D(String, IAxis, IAxis, IAxis) - Constructor for class jhplot.H3D
Create 3D histogram
H3D - Static variable in class jplot.LinePars
 
h_Planck - Static variable in class cern.clhep.PhysicalConstants
 
HADOVEREEM_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.BLJets
 
HADOVEREEM_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.GenJets
 
HADOVEREEM_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Jets
 
HALF_LOG_2_PI - Static variable in interface jhplot.math.num.Constants
1/2 * log(2 π).
halfpi - Static variable in class cern.clhep.PhysicalConstants
 
HaltonSequenceGenerator - Class in org.apache.commons.math3.random
Implementation of a Halton sequence.
HaltonSequenceGenerator(int) - Constructor for class org.apache.commons.math3.random.HaltonSequenceGenerator
Construct a new Halton sequence generator for the given space dimension.
HaltonSequenceGenerator(int, int[], int[]) - Constructor for class org.apache.commons.math3.random.HaltonSequenceGenerator
Construct a new Halton sequence generator with the given base numbers and weights for each dimension.
handle(String) - Method in interface org.apache.commons.io.input.TailerListener
Handles a line from a Tailer.
handle(Exception) - Method in interface org.apache.commons.io.input.TailerListener
Handles an Exception .
handle(String) - Method in class org.apache.commons.io.input.TailerListenerAdapter
Handles a line from a Tailer.
handle(Exception) - Method in class org.apache.commons.io.input.TailerListenerAdapter
Handles an Exception .
handleClick(int, int, ChartRenderingInfo) - Method in class org.jfree.chart.JFreeChart
Handles a 'click' on the chart.
handleClick(int, int, PlotRenderingInfo) - Method in class org.jfree.chart.plot.CategoryPlot
Handles a 'click' on the plot by updating the anchor value.
handleClick(int, int, PlotRenderingInfo) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Handles a 'click' on the plot.
handleClick(int, int, PlotRenderingInfo) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Handles a 'click' on the plot by updating the anchor values.
handleClick(int, int, PlotRenderingInfo) - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Handles a 'click' on the plot by updating the anchor value.
handleClick(int, int, PlotRenderingInfo) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Handles a 'click' on the plot by updating the anchor values...
handleClick(int, int, PlotRenderingInfo) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Handles a 'click' on the plot by updating the anchor values...
handleClick(int, int, PlotRenderingInfo) - Method in class org.jfree.chart.plot.Plot
Handles a 'click' on the plot.
handleClick(int, int, PlotRenderingInfo) - Method in class org.jfree.chart.plot.XYPlot
Handles a 'click' on the plot by updating the anchor values.
handleCommand(String) - Method in class jplot3dp.MainComponent
 
handleError(Exception) - Method in class org.lsmp.djepExamples.Console
Handle an error in the parse and evaluate routines.
handleMouseClicked(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.AbstractMouseHandlerFX
Handles a mouse clicked event.
handleMouseClicked(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.AnchorHandlerFX
Handles a mouse clicked event by setting the anchor point for the canvas and redrawing the chart (the anchor point is a reference point used by the chart to determine crosshair lines).
handleMouseClicked(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.DispatchHandlerFX
Handles a mouse clicked event by setting the anchor point for the canvas and redrawing the chart (the anchor point is a reference point used by the chart to determine crosshair lines).
handleMouseClicked(ChartCanvas, MouseEvent) - Method in interface org.jfree.chart.fx.interaction.MouseHandlerFX
Handles a mouse clicked event.
handleMouseDragged(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.AbstractMouseHandlerFX
Handles a mouse dragged event.
handleMouseDragged(ChartCanvas, MouseEvent) - Method in interface org.jfree.chart.fx.interaction.MouseHandlerFX
Handles a mouse dragged event.
handleMouseDragged(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.PanHandlerFX
Handles a mouse dragged event by calculating the distance panned and updating the axes accordingly.
handleMouseDragged(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.ZoomHandlerFX
Handles a mouse dragged event by updating the zoom rectangle displayed in the ChartViewer.
handleMouseMoved(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.AbstractMouseHandlerFX
Handles a mouse moved event.
handleMouseMoved(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.DispatchHandlerFX
 
handleMouseMoved(ChartCanvas, MouseEvent) - Method in interface org.jfree.chart.fx.interaction.MouseHandlerFX
Handles a mouse moved event.
handleMouseMoved(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.TooltipHandlerFX
Handles a mouse moved event by updating the tooltip.
handleMousePressed(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.AbstractMouseHandlerFX
Handles a mouse pressed event.
handleMousePressed(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.AnchorHandlerFX
Handles a mouse pressed event by recording the location of the mouse pointer (so that later we can check that the click isn't part of a drag).
handleMousePressed(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.DispatchHandlerFX
Handles a mouse pressed event by recording the location of the mouse pointer (so that later we can check that the click isn't part of a drag).
handleMousePressed(ChartCanvas, MouseEvent) - Method in interface org.jfree.chart.fx.interaction.MouseHandlerFX
Handles a mouse pressed event.
handleMousePressed(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.PanHandlerFX
Handles a mouse pressed event by recording the initial mouse pointer location.
handleMousePressed(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.ZoomHandlerFX
Handles a mouse pressed event by recording the initial mouse pointer location.
handleMouseReleased(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.AbstractMouseHandlerFX
Handles a mouse released event.
handleMouseReleased(ChartCanvas, MouseEvent) - Method in interface org.jfree.chart.fx.interaction.MouseHandlerFX
Handles a mouse released event.
handleMouseReleased(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.PanHandlerFX
 
handleMouseReleased(ChartCanvas, MouseEvent) - Method in class org.jfree.chart.fx.interaction.ZoomHandlerFX
 
handleMouseWheelRotation(int) - Method in class org.jfree.chart.plot.PiePlot
Handles a mouse wheel rotation (this method is intended for use by the MouseWheelHandler class).
handleScroll(ChartCanvas, ScrollEvent) - Method in class org.jfree.chart.fx.interaction.AbstractMouseHandlerFX
Handles a scroll event.
handleScroll(ChartCanvas, ScrollEvent) - Method in interface org.jfree.chart.fx.interaction.MouseHandlerFX
Handles a scroll event.
handleScroll(ChartCanvas, ScrollEvent) - Method in class org.jfree.chart.fx.interaction.ScrollHandlerFX
 
handleStep(FieldStepInterpolator<T>, boolean) - Method in class org.apache.commons.math3.ode.ContinuousOutputFieldModel
Handle the last accepted step.
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Handle the last accepted step.
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math3.ode.sampling.DummyStepHandler
Handle the last accepted step.
handleStep(FieldODEStateAndDerivative<T>, boolean) - Method in interface org.apache.commons.math3.ode.sampling.FieldFixedStepHandler
Handle the last accepted step
handleStep(FieldStepInterpolator<T>, boolean) - Method in interface org.apache.commons.math3.ode.sampling.FieldStepHandler
Handle the last accepted step
handleStep(FieldStepInterpolator<T>, boolean) - Method in class org.apache.commons.math3.ode.sampling.FieldStepNormalizer
Handle the last accepted step
handleStep(double, double[], double[], boolean) - Method in interface org.apache.commons.math3.ode.sampling.FixedStepHandler
Handle the last accepted step
handleStep(StepInterpolator, boolean) - Method in interface org.apache.commons.math3.ode.sampling.StepHandler
Handle the last accepted step
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math3.ode.sampling.StepNormalizer
Handle the last accepted step
HarmonicCurveFitter - Class in org.apache.commons.math3.fitting
Fits points to a harmonic oscillator function.
HarmonicCurveFitter.ParameterGuesser - Class in org.apache.commons.math3.fitting
This class guesses harmonic coefficients from a sample.
HarmonicFitter - Class in org.apache.commons.math3.fitting
Deprecated.
As of 3.3. Please use HarmonicCurveFitter and WeightedObservedPoints instead.
HarmonicFitter(MultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.fitting.HarmonicFitter
Deprecated.
Simple constructor.
HarmonicFitter - Class in org.apache.commons.math3.optimization.fitting
Deprecated.
As of 3.1 (to be removed in 4.0).
HarmonicFitter(DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.HarmonicFitter
Deprecated.
Simple constructor.
HarmonicFitter.ParameterGuesser - Class in org.apache.commons.math3.fitting
Deprecated.
This class guesses harmonic coefficients from a sample.
HarmonicFitter.ParameterGuesser - Class in org.apache.commons.math3.optimization.fitting
Deprecated.
This class guesses harmonic coefficients from a sample.
harmonicMean() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the harmonic mean, which is size() / Sum( 1/x[i] ).
harmonicMean(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the harmonic mean of a data sequence.
HarmonicOscillator - Class in org.apache.commons.math3.analysis.function
HarmonicOscillator(double, double, double) - Constructor for class org.apache.commons.math3.analysis.function.HarmonicOscillator
Harmonic oscillator function.
HarmonicOscillator.Parametric - Class in org.apache.commons.math3.analysis.function
Parametric function where the input array contains the parameters of the harmonic oscillator function, ordered as follows: Amplitude Angular frequency Phase
hasAllentries() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional int32 allentries = 11;
hasAllentries() - Method in class promc.io.PBufFile.Record.H1D
optional int32 allentries = 11;
hasAllentries() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional int32 allentries = 11;
hasAllentries() - Method in class promc.io.PBufFile.Record.H2D.Builder
optional int32 allentries = 11;
hasAllentries() - Method in class promc.io.PBufFile.Record.H2D
optional int32 allentries = 11;
hasAllentries() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
optional int32 allentries = 11;
hasAlphaQCD() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QCD = 13;
hasAlphaQCD() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float Alpha_QCD = 13;
hasAlphaQCD() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float Alpha_QCD = 13;
hasAlphaQCD() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QCD = 13;
hasAlphaQCD() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float Alpha_QCD = 13;
hasAlphaQCD() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float Alpha_QCD = 13;
hasAlphaQED() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QED = 11;
hasAlphaQED() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float Alpha_QED = 11;
hasAlphaQED() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float Alpha_QED = 11;
hasAlphaQED() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QED = 11;
hasAlphaQED() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float Alpha_QED = 11;
hasAlphaQED() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float Alpha_QED = 11;
hasAttribute(AttributeType) - Method in class org.jlab.groot.base.Attributes
 
hasBins() - Method in class promc.io.PBufFile.Record.H1D.Builder
required int32 bins = 8;
hasBins() - Method in class promc.io.PBufFile.Record.H1D
required int32 bins = 8;
hasBins() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
required int32 bins = 8;
hasBjets() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.BLJets bjets = 5;
hasBjets() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.BLJets bjets = 5;
hasBjets() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.BLJets bjets = 5;
hasBOM() - Method in class org.apache.commons.io.input.BOMInputStream
Indicates whether the stream contains one of the specified BOMs.
hasBOM(ByteOrderMark) - Method in class org.apache.commons.io.input.BOMInputStream
Indicates whether the stream contains the specified BOM.
hasBranch(String) - Method in class org.jlab.groot.tree.Tree
check for branch name.
hasBytes() - Method in class org.apache.commons.io.input.buffer.CircularByteBuffer
Returns, whether the buffer is currently holding, at least, a single byte.
hasChanged() - Method in class org.nfunk.jep.SymbolTable
 
hasCharge() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
hasCharge() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional sint32 charge = 6;
hasCharge() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional sint32 charge = 6;
hasCharge() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
hasCharge() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional sint32 charge = 6;
hasCharge() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional sint32 charge = 6;
hasCharge() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
hasCharge() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional sint32 charge = 6;
hasCharge() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional sint32 charge = 6;
hasCharge() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
hasCharge() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional sint32 charge = 6;
hasCharge() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional sint32 charge = 6;
hasCode() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
hasCode() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 code = 13;
hasCode() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 code = 13;
hasCode() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
hasCode() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 code = 13;
hasCode() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 code = 13;
hasCode() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
hasCode() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 code = 13;
hasCode() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 code = 13;
hasCode() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
hasCode() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 code = 13;
hasCode() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 code = 13;
hasComplexEigenvalues() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Returns whether the calculated eigen values are complex or real.
HasComplexValueI - Interface in org.lsmp.djep.groupJep.values
Group elements which have a natural conversion to complex numbers.
hasCovariance() - Method in class org.freehep.math.minuit.MnUserParameterState
Returns true if the the state has a valid covariance, false otherwise.
hasCrossSection() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
hasCrossSection() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double cross_section = 14;
hasCrossSection() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section = 14;
hasCrossSection() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
hasCrossSection() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section = 2;
hasCrossSection() - Method in interface proeic.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section = 2;
hasCrossSection() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
hasCrossSection() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double cross_section = 14;
hasCrossSection() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section = 14;
hasCrossSection() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
hasCrossSection() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section = 2;
hasCrossSection() - Method in interface promc.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section = 2;
hasCrossSection() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
hasCrossSection() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double cross_section = 14;
hasCrossSection() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section = 14;
hasCrossSection() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
hasCrossSection() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section = 2;
hasCrossSection() - Method in interface pronlo.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section = 2;
hasCrossSection() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
hasCrossSection() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double cross_section = 14;
hasCrossSection() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section = 14;
hasCrossSection() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
hasCrossSection() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section = 2;
hasCrossSection() - Method in interface proreco.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section = 2;
hasCrossSectionAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
hasCrossSectionAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional double cross_section_accumulated = 3;
hasCrossSectionAccumulated() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_accumulated = 3;
hasCrossSectionAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
hasCrossSectionAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat
optional double cross_section_accumulated = 3;
hasCrossSectionAccumulated() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_accumulated = 3;
hasCrossSectionAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
hasCrossSectionAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional double cross_section_accumulated = 3;
hasCrossSectionAccumulated() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_accumulated = 3;
hasCrossSectionAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
hasCrossSectionAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional double cross_section_accumulated = 3;
hasCrossSectionAccumulated() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_accumulated = 3;
hasCrossSectionError() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
hasCrossSectionError() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double cross_section_error = 15;
hasCrossSectionError() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section_error = 15;
hasCrossSectionError() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
hasCrossSectionError() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section_error = 3;
hasCrossSectionError() - Method in interface proeic.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section_error = 3;
hasCrossSectionError() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
hasCrossSectionError() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double cross_section_error = 15;
hasCrossSectionError() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section_error = 15;
hasCrossSectionError() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
hasCrossSectionError() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section_error = 3;
hasCrossSectionError() - Method in interface promc.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section_error = 3;
hasCrossSectionError() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
hasCrossSectionError() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double cross_section_error = 15;
hasCrossSectionError() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section_error = 15;
hasCrossSectionError() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
hasCrossSectionError() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section_error = 3;
hasCrossSectionError() - Method in interface pronlo.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section_error = 3;
hasCrossSectionError() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
hasCrossSectionError() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double cross_section_error = 15;
hasCrossSectionError() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double cross_section_error = 15;
hasCrossSectionError() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
hasCrossSectionError() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
required double cross_section_error = 3;
hasCrossSectionError() - Method in interface proreco.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required double cross_section_error = 3;
hasCrossSectionErrorAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
hasCrossSectionErrorAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional double cross_section_error_accumulated = 4;
hasCrossSectionErrorAccumulated() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_error_accumulated = 4;
hasCrossSectionErrorAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
hasCrossSectionErrorAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat
optional double cross_section_error_accumulated = 4;
hasCrossSectionErrorAccumulated() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_error_accumulated = 4;
hasCrossSectionErrorAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
hasCrossSectionErrorAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional double cross_section_error_accumulated = 4;
hasCrossSectionErrorAccumulated() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_error_accumulated = 4;
hasCrossSectionErrorAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
hasCrossSectionErrorAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional double cross_section_error_accumulated = 4;
hasCrossSectionErrorAccumulated() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional double cross_section_error_accumulated = 4;
hasDefinition() - Method in class promc.io.PBufFile.Record.F1D.Builder
required string definition = 2;
hasDefinition() - Method in class promc.io.PBufFile.Record.F1D
required string definition = 2;
hasDefinition() - Method in interface promc.io.PBufFile.Record.F1DOrBuilder
required string definition = 2;
hasDefinition() - Method in class promc.io.PBufFile.Record.F2D.Builder
required string definition = 2;
hasDefinition() - Method in class promc.io.PBufFile.Record.F2D
required string definition = 2;
hasDefinition() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
required string definition = 2;
hasDefinition() - Method in class promc.io.PBufFile.Record.FND.Builder
required string definition = 2;
hasDefinition() - Method in class promc.io.PBufFile.Record.FND
required string definition = 2;
hasDefinition() - Method in interface promc.io.PBufFile.Record.FNDOrBuilder
required string definition = 2;
hasDefinition() - Method in class promc.io.PBufFile.Record.FPR.Builder
required string definition = 2;
hasDefinition() - Method in class promc.io.PBufFile.Record.FPR
required string definition = 2;
hasDefinition() - Method in interface promc.io.PBufFile.Record.FPROrBuilder
required string definition = 2;
hasDescription() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
hasDescription() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
hasDescription() - Method in interface proeic.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
hasDescription() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
hasDescription() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
hasDescription() - Method in interface promc.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
hasDescription() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
hasDescription() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
hasDescription() - Method in interface pronlo.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
hasDescription() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
hasDescription() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
required string description = 3;
hasDescription() - Method in interface proreco.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required string description = 3;
hasDimension() - Method in class promc.io.PBufFile.Record.PND.Builder
required int32 dimension = 3;
hasDimension() - Method in class promc.io.PBufFile.Record.PND
required int32 dimension = 3;
hasDimension() - Method in interface promc.io.PBufFile.Record.PNDOrBuilder
required int32 dimension = 3;
hasDimension() - Method in class promc.io.PBufFile.Record.PNI.Builder
required int32 dimension = 3;
hasDimension() - Method in class promc.io.PBufFile.Record.PNI
required int32 dimension = 3;
hasDimension() - Method in interface promc.io.PBufFile.Record.PNIOrBuilder
required int32 dimension = 3;
HasDivI - Interface in org.lsmp.djep.groupJep.interfaces
An IntergralDomainI which also has a notion of division, which is not necessarily closed i.e.
hasDivU() - Method in class promc.io.PBufFile.Record.FPR.Builder
required int32 divU = 3;
hasDivU() - Method in class promc.io.PBufFile.Record.FPR
required int32 divU = 3;
hasDivU() - Method in interface promc.io.PBufFile.Record.FPROrBuilder
required int32 divU = 3;
hasDivV() - Method in class promc.io.PBufFile.Record.FPR.Builder
required int32 divV = 4;
hasDivV() - Method in class promc.io.PBufFile.Record.FPR
required int32 divV = 4;
hasDivV() - Method in interface promc.io.PBufFile.Record.FPROrBuilder
required int32 divV = 4;
hasECM() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
hasECM() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double eCM = 10;
hasECM() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double eCM = 10;
hasECM() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
hasECM() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double eCM = 10;
hasECM() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double eCM = 10;
hasECM() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
hasECM() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double eCM = 10;
hasECM() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double eCM = 10;
hasECM() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
hasECM() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double eCM = 10;
hasECM() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double eCM = 10;
hasElectrons() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Electrons electrons = 6;
hasElectrons() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Electrons electrons = 6;
hasElectrons() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Electrons electrons = 6;
hasEquation() - Method in interface org.lsmp.djep.matrixJep.MatrixVariableI
Whether this variable has an equation.
hasEquation() - Method in class org.lsmp.djep.xjep.XVariable
Does this variable has an associated equation?
hasError() - Method in class org.nfunk.jep.JEP
Returns true if an error occurred during the most recent action (parsing or evaluation).
hasErrors() - Method in class org.lsmp.djep.xjep.ErrorCatchingVisitor
Are their any errors?
hasEvent() - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
hasEvent() - Method in class proeic.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
hasEvent() - Method in interface proeic.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
hasEvent() - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
hasEvent() - Method in class promc.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
hasEvent() - Method in interface promc.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
hasEvent() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
hasEvent() - Method in class pronlo.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
hasEvent() - Method in interface pronlo.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
hasEvent() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
hasEvent() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Event event = 1;
hasEvent() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Event event = 1;
hasEvents() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
hasEvents() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
required uint64 events = 2;
hasEvents() - Method in interface proeic.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 events = 2;
hasEvents() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
hasEvents() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
required uint64 events = 2;
hasEvents() - Method in interface promc.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 events = 2;
hasEvents() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
hasEvents() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
required uint64 events = 2;
hasEvents() - Method in interface pronlo.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 events = 2;
hasEvents() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
hasEvents() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
required uint64 events = 2;
hasEvents() - Method in interface proreco.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 events = 2;
hasF1D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F1D f1D = 9;
hasF1D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.F1D f1D = 9;
hasF1D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.F1D f1D = 9;
hasF2D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F2D f2D = 10;
hasF2D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.F2D f2D = 10;
hasF2D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.F2D f2D = 10;
hasFND() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FND fND = 11;
hasFND() - Method in class promc.io.PBufFile.Record
optional .promc.Record.FND fND = 11;
hasFND() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.FND fND = 11;
hasFPR() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FPR fPR = 12;
hasFPR() - Method in class promc.io.PBufFile.Record
optional .promc.Record.FPR fPR = 12;
hasFPR() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.FPR fPR = 12;
hasFullRank() - Method in class cern.colt.matrix.linalg.QRDecomposition
Returns whether the matrix A has full rank.
hasGenerator() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
optional int32 generator = 5;
hasGenerator() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
optional int32 generator = 5;
hasGenerator() - Method in interface proeic.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
optional int32 generator = 5;
hasGenjets() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.GenJets genjets = 4;
hasGenjets() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.GenJets genjets = 4;
hasGenjets() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.GenJets genjets = 4;
hasGlobalCC() - Method in class org.freehep.math.minuit.MnUserParameterState
 
hash(char) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(double) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(float) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(int) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(long) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(Object) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified object.
hash(short) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(boolean) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(double) - Static method in class org.apache.commons.math3.util.MathUtils
Returns an integer hash code representing the given double value.
hash(double[]) - Static method in class org.apache.commons.math3.util.MathUtils
Returns an integer hash code representing the given double array.
hasH1D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H1D h1D = 7;
hasH1D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.H1D h1D = 7;
hasH1D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.H1D h1D = 7;
hasH2D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H2D h2D = 8;
hasH2D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.H2D h2D = 8;
hasH2D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.H2D h2D = 8;
hashCode() - Method in class cern.colt.bitvector.BitMatrix
Returns a hash code value for the receiver.
hashCode() - Method in class cern.colt.bitvector.BitVector
Returns a hash code value for the receiver.
hashCode() - Method in class fitter.BFunc
 
hashCode() - Method in class hep.physics.vec.BasicHep3Vector
 
hashCode() - Method in class hep.physics.vec.BasicHepLorentzVector
 
hashCode() - Method in class hephysics.jet.ParticleD
Get a hash code
hashCode() - Method in class hephysics.jet.ParticleF
Get a hash code
hashCode() - Method in class hephysics.particle.LParticle
Get a hash code
hashCode() - Method in class hephysics.vec.Hep3Vector
 
hashCode() - Method in class hephysics.vec.HepLorentzVector
Hash code
hashCode() - Method in class jhplot.math.ValueErr
 
hashCode() - Method in class jhplot.P0D
Returns the hash code value for this collection.
hashCode() - Method in class jhplot.P0I
Returns the hash code value for this collection.
hashCode() - Method in class jhplot.P1D
Returns the hash code value for this collection (onoy X,Y values)
hashCode() - Method in class org.apache.commons.io.ByteOrderMark
Return the hashcode for this BOM.
hashCode() - Method in class org.apache.commons.io.file.AccumulatorPathVisitor
 
hashCode() - Method in class org.apache.commons.io.file.CleaningPathVisitor
 
hashCode() - Method in class org.apache.commons.io.file.CopyDirectoryVisitor
 
hashCode() - Method in class org.apache.commons.io.file.CountingPathVisitor
 
hashCode() - Method in class org.apache.commons.io.file.DeletingPathVisitor
 
hashCode() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get a hashCode for the derivative structure.
hashCode() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Get a hashCode for the derivative structure.
hashCode() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
hashCode() - Method in class org.apache.commons.math3.complex.Complex
Get a hashCode for the complex number.
hashCode() - Method in class org.apache.commons.math3.complex.Quaternion
hashCode() - Method in class org.apache.commons.math3.dfp.Dfp
Gets a hashCode for the instance.
hashCode() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets a hashCode for the fraction.
hashCode() - Method in class org.apache.commons.math3.fraction.Fraction
Gets a hashCode for the fraction.
hashCode() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get a hashCode for the 1D vector.
hashCode() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get a hashCode for the 3D vector.
hashCode() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get a hashCode for the 3D vector.
hashCode() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get a hashCode for the 2D vector.
hashCode() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
Deprecated.
hashCode() - Method in class org.apache.commons.math3.geometry.spherical.oned.S1Point
Get a hashCode for the 2D vector.
hashCode() - Method in class org.apache.commons.math3.geometry.spherical.twod.S2Point
Get a hashCode for the 2D vector.
hashCode() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Computes a hashcode for the matrix.
hashCode() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Computes a hashcode for the matrix.
hashCode() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Get a hashCode for the real vector.
hashCode() - Method in class org.apache.commons.math3.linear.ArrayRealVector
.
hashCode() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
.
hashCode() - Method in class org.apache.commons.math3.linear.RealVector
.
hashCode() - Method in class org.apache.commons.math3.linear.SparseFieldVector
hashCode() - Method in class org.apache.commons.math3.ml.clustering.DoublePoint
hashCode() - Method in class org.apache.commons.math3.optim.linear.LinearConstraint
hashCode() - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
hashCode() - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated.
hashCode() - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.
hashCode() - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
Deprecated.
hashCode() - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
Deprecated.
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns hash code based on getResult() and getN()
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile
Returns hash code based on getResult() and getN()
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math3.stat.Frequency
hashCode() - Method in class org.apache.commons.math3.util.BigReal
hashCode() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation returns the same value as new Double(this.doubleValue()).hashCode()
hashCode() - Method in class org.apache.commons.math3.util.DefaultTransformer
hashCode() - Method in class org.apache.commons.math3.util.Pair
Compute a hash code.
hashCode() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns a hash code consistent with equals.
hashCode() - Method in class org.apache.commons.math3.util.TransformerMap
hashCode() - Method in class org.jfree.chart.annotations.AbstractXYAnnotation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.annotations.CategoryTextAnnotation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.annotations.TextAnnotation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.annotations.XYBoxAnnotation
Returns a hash code.
hashCode() - Method in class org.jfree.chart.annotations.XYDataImageAnnotation
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.annotations.XYDrawableAnnotation
Returns a hash code.
hashCode() - Method in class org.jfree.chart.annotations.XYImageAnnotation
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.annotations.XYLineAnnotation
Returns a hash code.
hashCode() - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.annotations.XYPolygonAnnotation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.annotations.XYShapeAnnotation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns a hash code for the object.
hashCode() - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.Axis
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.axis.AxisLabelLocation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.axis.AxisLocation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.axis.AxisSpace
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.CategoryAxis
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.CategoryLabelPosition
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.CategoryLabelPositions
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.CategoryTick
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.DateAxis
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.DateTick
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.DateTickUnit
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.LogAxis
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.axis.MarkerAxisBand
Returns a hash code for the object.
hashCode() - Method in class org.jfree.chart.axis.NumberAxis
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.NumberTickUnit
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.axis.PeriodAxis
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.PeriodAxisLabelInfo
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.SegmentedTimeline
Returns a hash code for this object.
hashCode() - Method in class org.jfree.chart.axis.StandardTickUnitSource
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.axis.SubCategoryAxis
Returns a hashcode for this instance.
hashCode() - Method in class org.jfree.chart.axis.TickUnit
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.block.LengthConstraintType
Returns a hash code value for the object.
hashCode() - Method in class org.jfree.chart.entity.AxisEntity
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.entity.CategoryLabelEntity
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.entity.ChartEntity
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.entity.JFreeChartEntity
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.entity.PieSectionEntity
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.entity.PlotEntity
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.entity.TitleEntity
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.event.ChartChangeEventType
Returns a hash code value for the object.
hashCode(int, boolean) - Static method in class org.jfree.chart.HashUtilities
Returns a hash value based on a seed value and the value of a boolean primitive.
hashCode(int, int) - Static method in class org.jfree.chart.HashUtilities
Returns a hash value based on a seed value and the value of an int primitive.
hashCode(int, double) - Static method in class org.jfree.chart.HashUtilities
Returns a hash value based on a seed value and the value of a double primitive.
hashCode(int, Paint) - Static method in class org.jfree.chart.HashUtilities
Returns a hash value based on a seed value and a paint instance.
hashCode(int, Stroke) - Static method in class org.jfree.chart.HashUtilities
Returns a hash value based on a seed value and a stroke instance.
hashCode(int, String) - Static method in class org.jfree.chart.HashUtilities
Returns a hash value based on a seed value and a string instance.
hashCode(int, Comparable) - Static method in class org.jfree.chart.HashUtilities
Returns a hash value based on a seed value and a Comparable instance.
hashCode(int, Object) - Static method in class org.jfree.chart.HashUtilities
Returns a hash value based on a seed value and an Object instance.
hashCode(int, BooleanList) - Static method in class org.jfree.chart.HashUtilities
Computes a hash code for a BooleanList.
hashCode(int, PaintList) - Static method in class org.jfree.chart.HashUtilities
Computes a hash code for a PaintList.
hashCode(int, StrokeList) - Static method in class org.jfree.chart.HashUtilities
Computes a hash code for a StrokeList.
hashCode() - Method in class org.jfree.chart.labels.AbstractCategoryItemLabelGenerator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.labels.AbstractPieItemLabelGenerator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.labels.AbstractXYItemLabelGenerator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.labels.BubbleXYItemLabelGenerator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.labels.HighLowItemLabelGenerator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.labels.MultipleXYSeriesLabelGenerator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.labels.StandardCategorySeriesLabelGenerator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.labels.StandardCrosshairLabelGenerator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.labels.StandardXYSeriesLabelGenerator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.labels.SymbolicXYItemLabelGenerator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.needle.ArrowNeedle
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.needle.LineNeedle
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.needle.LongNeedle
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.needle.MeterNeedle
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.needle.MiddlePinNeedle
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.needle.PinNeedle
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.needle.PlumNeedle
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.needle.PointerNeedle
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.needle.ShipNeedle
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.needle.WindNeedle
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns a hash code.
hashCode() - Method in class org.jfree.chart.plot.Crosshair
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.DatasetRenderingOrder
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.AbstractDialLayer
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.DialBackground
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.DialCap
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.DialPlot
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.DialPointer
Returns a hash code.
hashCode() - Method in class org.jfree.chart.plot.dial.DialPointer.Pin
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.DialPointer.Pointer
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.StandardDialRange
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.DialShape
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.PieLabelLinkStyle
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.PlotOrientation
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.plot.SeriesRenderingOrder
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns a hashcode for the renderer.
hashCode() - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Returns a hash code for the renderer.
hashCode() - Method in class org.jfree.chart.renderer.category.GradientBarPainter
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.renderer.category.LevelRenderer
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.renderer.category.StackedBarRenderer3D
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.renderer.category.StandardBarPainter
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.renderer.category.StatisticalLineAndShapeRenderer
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.renderer.GrayPaintScale
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.renderer.xy.GradientXYBarPainter
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.renderer.xy.StackedXYBarRenderer
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.renderer.xy.StandardXYBarPainter
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.renderer.xy.XYStepRenderer
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.title.LegendGraphic
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.title.TextTitle
Returns a hash code.
hashCode() - Method in class org.jfree.chart.title.Title
Returns a hashcode for the title.
hashCode() - Method in class org.jfree.chart.urls.StandardCategoryURLGenerator
Returns a hash code.
hashCode() - Method in class org.jfree.chart.util.DefaultShadowGenerator
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.chart.util.RelativeDateFormat
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.category.DefaultCategoryDataset
Returns a hash code for the dataset.
hashCode() - Method in class org.jfree.data.ComparableObjectItem
Returns a hash code.
hashCode() - Method in class org.jfree.data.ComparableObjectSeries
Returns a hash code.
hashCode() - Method in class org.jfree.data.DefaultKeyedValue
Returns a hash code.
hashCode() - Method in class org.jfree.data.DefaultKeyedValues
Returns a hash code.
hashCode() - Method in class org.jfree.data.DefaultKeyedValues2D
Returns a hash code.
hashCode() - Method in class org.jfree.data.DomainOrder
Returns a hash code value for the object.
hashCode() - Method in class org.jfree.data.function.LineFunction2D
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.function.NormalDistributionFunction2D
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.function.PolynomialFunction2D
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.function.PowerFunction2D
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.general.DefaultKeyedValueDataset
Returns a hash code.
hashCode() - Method in class org.jfree.data.general.DefaultPieDataset
Returns a hash code.
hashCode() - Method in class org.jfree.data.general.DefaultValueDataset
Returns a hash code.
hashCode() - Method in class org.jfree.data.general.Series
Returns a hash code.
hashCode() - Method in class org.jfree.data.KeyedObjects
Returns a hash code.
hashCode() - Method in class org.jfree.data.KeyedObjects2D
Returns a hashcode for this object.
hashCode() - Method in class org.jfree.data.KeyedValueComparatorType
Returns a hash code.
hashCode() - Method in class org.jfree.data.Range
Returns a hash code.
hashCode() - Method in class org.jfree.data.RangeType
Returns a hash code value for the object.
hashCode() - Method in class org.jfree.data.statistics.HistogramType
Returns a hash code value for the object.
hashCode() - Method in class org.jfree.data.time.Day
Returns a hash code for this object instance.
hashCode() - Method in class org.jfree.data.time.FixedMillisecond
Returns a hash code for this object instance.
hashCode() - Method in class org.jfree.data.time.Hour
Returns a hash code for this object instance.
hashCode() - Method in class org.jfree.data.time.Millisecond
Returns a hash code for this object instance.
hashCode() - Method in class org.jfree.data.time.Minute
Returns a hash code for this object instance.
hashCode() - Method in class org.jfree.data.time.Month
Returns a hash code for this object instance.
hashCode() - Method in class org.jfree.data.time.ohlc.OHLC
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.time.Quarter
Returns a hash code for this object instance.
hashCode() - Method in class org.jfree.data.time.Second
Returns a hash code for this object instance.
hashCode() - Method in class org.jfree.data.time.SimpleTimePeriod
Returns a hash code for this object instance.
hashCode() - Method in class org.jfree.data.time.TimePeriodAnchor
Returns a hash code value for the object.
hashCode() - Method in class org.jfree.data.time.TimePeriodValue
Returns a hash code value for the object.
hashCode() - Method in class org.jfree.data.time.TimePeriodValues
Returns a hash code value for the object.
hashCode() - Method in class org.jfree.data.time.TimeSeries
Returns a hash code value for the object.
hashCode() - Method in class org.jfree.data.time.TimeSeriesCollection
Returns a hash code value for the object.
hashCode() - Method in class org.jfree.data.time.TimeSeriesDataItem
Returns a hash code.
hashCode() - Method in class org.jfree.data.time.Week
Returns a hash code for this object instance.
hashCode() - Method in class org.jfree.data.time.Year
Returns a hash code for this object instance.
hashCode() - Method in class org.jfree.data.xy.DefaultIntervalXYDataset
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns a hash code.
hashCode() - Method in class org.jfree.data.xy.DefaultXYDataset
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.xy.MatrixSeriesCollection
Returns a hash code.
hashCode() - Method in class org.jfree.data.xy.Vector
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.xy.XYCoordinate
Returns a hash code for this instance.
hashCode() - Method in class org.jfree.data.xy.XYDataItem
Returns a hash code.
hashCode() - Method in class org.jfree.data.xy.XYSeries
Returns a hash code.
hashCode() - Method in class org.jfree.data.xy.XYSeriesCollection
Returns a hash code.
hashcode() - Method in class org.lsmp.djep.vectorJep.Dimensions
apparently your should always override hashcode when you override equals (Effective Java, Bloch).
hashCode() - Method in class org.lsmp.djep.vectorJep.values.Matrix
Always override hashCode when you override equals.
hashCode() - Method in class org.lsmp.djep.vectorJep.values.MVector
Always override hashCode when you override equals.
hashCode() - Method in class org.lsmp.djep.vectorJep.values.Scaler
Always override hashCode when you override equals.
hashCode() - Method in class org.lsmp.djep.vectorJep.values.Tensor
Always override hashCode when you override equals.
hashCode() - Method in class org.nfunk.jep.type.Complex
Always override hashCode when you override equals.
hashCode() - Method in class root.FakeTKey
 
hashCodeForDoubleArray(double[]) - Static method in class org.jfree.chart.HashUtilities
Returns a hash code for a double[] instance.
hashCodeForPaint(Paint) - Static method in class org.jfree.chart.HashUtilities
Returns a hash code for a Paint instance.
HashFunctions - Class in cern.colt.map
Provides various hash functions.
HashUtilities - Class in org.jfree.chart
Some utility methods for calculating hash codes.
HashUtilities() - Constructor for class org.jfree.chart.HashUtilities
 
hasId() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
hasId() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
required sint32 id = 1;
hasId() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required sint32 id = 1;
hasId() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
hasId() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
required sint32 id = 1;
hasId() - Method in interface proeic.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required sint32 id = 1;
hasId() - Method in class promc.io.PEventFile.HEvent.Builder
optional int64 id = 1;
hasId() - Method in class promc.io.PEventFile.HEvent
optional int64 id = 1;
hasId() - Method in interface promc.io.PEventFile.HEventOrBuilder
optional int64 id = 1;
hasId() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
hasId() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
required sint32 id = 1;
hasId() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required sint32 id = 1;
hasId() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
hasId() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
required sint32 id = 1;
hasId() - Method in interface promc.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required sint32 id = 1;
hasId() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
hasId() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
required sint32 id = 1;
hasId() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required sint32 id = 1;
hasId() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
hasId() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
required sint32 id = 1;
hasId() - Method in interface pronlo.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required sint32 id = 1;
hasId() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
hasId() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
required sint32 id = 1;
hasId() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required sint32 id = 1;
hasId() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
hasId() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
required sint32 id = 1;
hasId() - Method in interface proreco.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required sint32 id = 1;
hasID1() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID1 = 4;
hasID1() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional int32 ID1 = 4;
hasID1() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 ID1 = 4;
hasId1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
hasId1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 id1 = 1;
hasId1() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id1 = 1;
hasID1() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID1 = 4;
hasID1() - Method in class promc.io.ProMC.ProMCEvent.Event
optional int32 ID1 = 4;
hasID1() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 ID1 = 4;
hasId1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
hasId1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 id1 = 1;
hasId1() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id1 = 1;
hasId1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
hasId1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 id1 = 1;
hasId1() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id1 = 1;
hasId1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
hasId1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 id1 = 1;
hasId1() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id1 = 1;
hasID2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID2 = 5;
hasID2() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional int32 ID2 = 5;
hasID2() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 ID2 = 5;
hasId2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
hasId2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 id2 = 2;
hasId2() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id2 = 2;
hasID2() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID2 = 5;
hasID2() - Method in class promc.io.ProMC.ProMCEvent.Event
optional int32 ID2 = 5;
hasID2() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 ID2 = 5;
hasId2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
hasId2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 id2 = 2;
hasId2() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id2 = 2;
hasId2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
hasId2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 id2 = 2;
hasId2() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id2 = 2;
hasId2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
hasId2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 id2 = 2;
hasId2() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 id2 = 2;
hasIntercept() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
A getter method which determines whether a constant is included.
hasIntercept() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns true if the regression model has been computed including an intercept.
hasIntercept() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns true if the model includes an intercept term.
hasIntercept() - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Returns true if a constant has been included false otherwise.
hasIsFixedBins() - Method in class promc.io.PBufFile.Record.H1D.Builder
required bool isFixedBins = 17;
hasIsFixedBins() - Method in class promc.io.PBufFile.Record.H1D
required bool isFixedBins = 17;
hasIsFixedBins() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
required bool isFixedBins = 17;
hasIsFixedBins() - Method in class promc.io.PBufFile.Record.H2D.Builder
required bool isFixedBins = 13;
hasIsFixedBins() - Method in class promc.io.PBufFile.Record.H2D
required bool isFixedBins = 13;
hasIsFixedBins() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
required bool isFixedBins = 13;
hasJets() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Jets jets = 3;
hasJets() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Jets jets = 3;
hasJets() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Jets jets = 3;
hasKey() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
hasKey() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
hasKey() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
hasKey() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
hasKey() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
hasKey() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
hasKey() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
required string key = 1;
hasKey() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
required string key = 1;
hasKey() - Method in interface proeic.io.ProMCStatFile.ProMCStat.MetaFloatOrBuilder
required string key = 1;
hasKey() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
required string key = 1;
hasKey() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
required string key = 1;
hasKey() - Method in interface proeic.io.ProMCStatFile.ProMCStat.MetaIntOrBuilder
required string key = 1;
hasKey() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
hasKey() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
hasKey() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
hasKey() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
hasKey() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
hasKey() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
hasKey() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
hasKey() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
hasKey() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
hasKey() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
hasKey() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
hasKey() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
hasKey() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
hasKey() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required string key = 1;
hasKey() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required string key = 1;
hasKey() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
hasKey() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
required string key = 1;
hasKey() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required string key = 1;
hasLeftDetector() - Method in interface hep.lcio.event.MCParticle
True if the particle left the world volume undecayed.
hasLeftDetector() - Method in class hep.lcio.implementation.event.IMCParticle
 
hasLengthUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
hasLengthUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 LengthUnit = 17;
hasLengthUnit() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 LengthUnit = 17;
hasLengthUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
hasLengthUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 LengthUnit = 17;
hasLengthUnit() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 LengthUnit = 17;
hasLengthUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
hasLengthUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 LengthUnit = 17;
hasLengthUnit() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 LengthUnit = 17;
hasLengthUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
hasLengthUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 LengthUnit = 17;
hasLengthUnit() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 LengthUnit = 17;
hasLifetime() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
hasLifetime() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float lifetime = 5;
hasLifetime() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float lifetime = 5;
hasLifetime() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
hasLifetime() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float lifetime = 5;
hasLifetime() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float lifetime = 5;
hasLifetime() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
hasLifetime() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float lifetime = 5;
hasLifetime() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float lifetime = 5;
hasLifetime() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
hasLifetime() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float lifetime = 5;
hasLifetime() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float lifetime = 5;
hasListener(EventListener) - Method in class org.jfree.chart.annotations.AbstractAnnotation
Returns true if the specified object is registered with the annotation as a listener.
hasListener(EventListener) - Method in class org.jfree.chart.axis.Axis
Returns true if the specified object is registered with the dataset as a listener.
hasListener(EventListener) - Method in class org.jfree.chart.plot.dial.AbstractDialLayer
Returns true if the specified object is registered with the dataset as a listener.
hasListener(EventListener) - Method in interface org.jfree.chart.plot.dial.DialLayer
Returns true if the specified listener is currently registered with the this layer.
hasListener(EventListener) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns true if the specified object is registered with the dataset as a listener.
hasListener(EventListener) - Method in class org.jfree.data.general.AbstractDataset
Returns true if the specified object is registered with the dataset as a listener.
HasListI - Interface in org.lsmp.djep.groupJep.interfaces
Group implements a List function [a,b,c].
hasLuminosityAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
hasLuminosityAccumulated() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional double luminosity_accumulated = 5;
hasLuminosityAccumulated() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional double luminosity_accumulated = 5;
hasLuminosityAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
hasLuminosityAccumulated() - Method in class promc.io.ProMCStatFile.ProMCStat
optional double luminosity_accumulated = 5;
hasLuminosityAccumulated() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional double luminosity_accumulated = 5;
hasLuminosityAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
hasLuminosityAccumulated() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional double luminosity_accumulated = 5;
hasLuminosityAccumulated() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional double luminosity_accumulated = 5;
hasLuminosityAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
hasLuminosityAccumulated() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional double luminosity_accumulated = 5;
hasLuminosityAccumulated() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional double luminosity_accumulated = 5;
hasMass() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
hasMass() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
required double mass = 2;
hasMass() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required double mass = 2;
hasMass() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
hasMass() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
required double mass = 2;
hasMass() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required double mass = 2;
hasMass() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
hasMass() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
required double mass = 2;
hasMass() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required double mass = 2;
hasMass() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
hasMass() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
required double mass = 2;
hasMass() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required double mass = 2;
hasMatchingModifiers(MouseEvent) - Method in class org.jfree.chart.fx.interaction.AbstractMouseHandlerFX
Returns true if the specified mouse event has modifier keys that match this handler.
hasMatchingModifiers(MouseEvent) - Method in interface org.jfree.chart.fx.interaction.MouseHandlerFX
Returns true if the specified mouse event has modifier keys that match this handler.
hasMax() - Method in class promc.io.PBufFile.Record.F1D.Builder
optional double max = 4;
hasMax() - Method in class promc.io.PBufFile.Record.F1D
optional double max = 4;
hasMax() - Method in interface promc.io.PBufFile.Record.F1DOrBuilder
optional double max = 4;
hasMax() - Method in class promc.io.PBufFile.Record.H1D.Builder
required double max = 10;
hasMax() - Method in class promc.io.PBufFile.Record.H1D
required double max = 10;
hasMax() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
required double max = 10;
hasMaxX() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double maxX = 4;
hasMaxX() - Method in class promc.io.PBufFile.Record.F2D
optional double maxX = 4;
hasMaxX() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
optional double maxX = 4;
hasMaxY() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double maxY = 6;
hasMaxY() - Method in class promc.io.PBufFile.Record.F2D
optional double maxY = 6;
hasMaxY() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
optional double maxY = 6;
hasMean() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double mean = 16;
hasMean() - Method in class promc.io.PBufFile.Record.H1D
optional double mean = 16;
hasMean() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional double mean = 16;
hasMin() - Method in class promc.io.PBufFile.Record.F1D.Builder
optional double min = 3;
hasMin() - Method in class promc.io.PBufFile.Record.F1D
optional double min = 3;
hasMin() - Method in interface promc.io.PBufFile.Record.F1DOrBuilder
optional double min = 3;
hasMin() - Method in class promc.io.PBufFile.Record.H1D.Builder
required double min = 9;
hasMin() - Method in class promc.io.PBufFile.Record.H1D
required double min = 9;
hasMin() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
required double min = 9;
hasMinX() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double minX = 3;
hasMinX() - Method in class promc.io.PBufFile.Record.F2D
optional double minX = 3;
hasMinX() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
optional double minX = 3;
hasMinY() - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double minY = 5;
hasMinY() - Method in class promc.io.PBufFile.Record.F2D
optional double minY = 5;
hasMinY() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
optional double minY = 5;
hasMissingET() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.MissingET missingET = 10;
hasMissingET() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.MissingET missingET = 10;
hasMissingET() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.MissingET missingET = 10;
HasModI - Interface in org.lsmp.djep.groupJep.interfaces
Group has a mod operator a % b.
hasMomentumUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
hasMomentumUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 MomentumUnit = 16;
hasMomentumUnit() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 MomentumUnit = 16;
hasMomentumUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
hasMomentumUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 MomentumUnit = 16;
hasMomentumUnit() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 MomentumUnit = 16;
hasMomentumUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
hasMomentumUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 MomentumUnit = 16;
hasMomentumUnit() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 MomentumUnit = 16;
hasMomentumUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
hasMomentumUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 MomentumUnit = 16;
hasMomentumUnit() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 MomentumUnit = 16;
hasMPI() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 MPI = 3;
hasMPI() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional int32 MPI = 3;
hasMPI() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 MPI = 3;
hasMPI() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 MPI = 3;
hasMPI() - Method in class promc.io.ProMC.ProMCEvent.Event
optional int32 MPI = 3;
hasMPI() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 MPI = 3;
hasMuons() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Muons muons = 7;
hasMuons() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Muons muons = 7;
hasMuons() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Muons muons = 7;
hasNAccepted() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
hasNAccepted() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional int32 nAccepted = 8;
hasNAccepted() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nAccepted = 8;
hasNAccepted() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
hasNAccepted() - Method in class promc.io.ProMCStatFile.ProMCStat
optional int32 nAccepted = 8;
hasNAccepted() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nAccepted = 8;
hasNAccepted() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
hasNAccepted() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional int32 nAccepted = 8;
hasNAccepted() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nAccepted = 8;
hasNAccepted() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
hasNAccepted() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional int32 nAccepted = 8;
hasNAccepted() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nAccepted = 8;
hasName() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
hasName() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
hasName() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
hasName() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
hasName() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
hasName() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
hasName() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
hasName() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
hasName() - Method in interface proeic.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
hasName() - Method in class promc.io.PBufFile.Record.Builder
optional string name = 1;
hasName() - Method in class promc.io.PBufFile.Record.F1D.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.F1D
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.F1DOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.F2D.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.F2D
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.F2DOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.FND.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.FND
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.FNDOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.FPR.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.FPR
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.FPROrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.H1D.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.H1D
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.H2D.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.H2D
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record
optional string name = 1;
hasName() - Method in class promc.io.PBufFile.Record.P0D.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.P0D
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.P0DOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.P0I.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.P0I
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.P0IOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.P1D.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.P1D
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.P1DOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.PND.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.PND
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.PNDOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.PNI.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.PNI
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.PNIOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.PXY.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.PXY
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.PXYOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
required string name = 1 [default = "none"];
hasName() - Method in class promc.io.PBufFile.Record.PXYZ
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.Record.PXYZOrBuilder
required string name = 1 [default = "none"];
hasName() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional string name = 1;
hasName() - Method in class promc.io.PEventFile.HEvent.Builder
optional string name = 2;
hasName() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
optional string name = 1;
hasName() - Method in class promc.io.PEventFile.HEvent.Entry
optional string name = 1;
hasName() - Method in interface promc.io.PEventFile.HEvent.EntryOrBuilder
optional string name = 1;
hasName() - Method in class promc.io.PEventFile.HEvent.Group.Builder
optional string name = 1;
hasName() - Method in class promc.io.PEventFile.HEvent.Group
optional string name = 1;
hasName() - Method in interface promc.io.PEventFile.HEvent.GroupOrBuilder
optional string name = 1;
hasName() - Method in class promc.io.PEventFile.HEvent
optional string name = 2;
hasName() - Method in interface promc.io.PEventFile.HEventOrBuilder
optional string name = 2;
hasName() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
hasName() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
hasName() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
hasName() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
hasName() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
hasName() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
hasName() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
hasName() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
hasName() - Method in interface promc.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
hasName() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
hasName() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
hasName() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
hasName() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
hasName() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
hasName() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
hasName() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
hasName() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
hasName() - Method in interface pronlo.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
hasName() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
hasName() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional string name = 12;
hasName() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
hasName() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
required string name = 3;
hasName() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
required string name = 3;
hasName() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string name = 12;
hasName() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
hasName() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
required string name = 4;
hasName() - Method in interface proreco.io.ProMCStatFile.ProMCStat.ProcessDataOrBuilder
required string name = 4;
hasNameLengthUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
hasNameLengthUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
hasNameLengthUnit() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
hasNameLengthUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
hasNameLengthUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
hasNameLengthUnit() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
hasNameLengthUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
hasNameLengthUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
hasNameLengthUnit() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
hasNameLengthUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
hasNameLengthUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional string NameLengthUnit = 19;
hasNameLengthUnit() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameLengthUnit = 19;
hasNameMomentumUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
hasNameMomentumUnit() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
hasNameMomentumUnit() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
hasNameMomentumUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
hasNameMomentumUnit() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
hasNameMomentumUnit() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
hasNameMomentumUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
hasNameMomentumUnit() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
hasNameMomentumUnit() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
hasNameMomentumUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
hasNameMomentumUnit() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional string NameMomentumUnit = 18;
hasNameMomentumUnit() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional string NameMomentumUnit = 18;
hasNentries() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional int32 nentries = 12;
hasNentries() - Method in class promc.io.PBufFile.Record.H1D
optional int32 nentries = 12;
hasNentries() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional int32 nentries = 12;
hasNentries() - Method in class promc.io.PBufFile.Record.H2D.Builder
optional int32 nentries = 12;
hasNentries() - Method in class promc.io.PBufFile.Record.H2D
optional int32 nentries = 12;
hasNentries() - Method in interface promc.io.PBufFile.Record.H2DOrBuilder
optional int32 nentries = 12;
hasNeventsFailed() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
hasNeventsFailed() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional int32 nevents_failed = 2;
hasNeventsFailed() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_failed = 2;
hasNeventsFailed() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
hasNeventsFailed() - Method in class promc.io.ProMCStatFile.ProMCStat
optional int32 nevents_failed = 2;
hasNeventsFailed() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_failed = 2;
hasNeventsFailed() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
hasNeventsFailed() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional int32 nevents_failed = 2;
hasNeventsFailed() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_failed = 2;
hasNeventsFailed() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
hasNeventsFailed() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional int32 nevents_failed = 2;
hasNeventsFailed() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_failed = 2;
hasNeventsRequested() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
hasNeventsRequested() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional int32 nevents_requested = 1;
hasNeventsRequested() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_requested = 1;
hasNeventsRequested() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
hasNeventsRequested() - Method in class promc.io.ProMCStatFile.ProMCStat
optional int32 nevents_requested = 1;
hasNeventsRequested() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_requested = 1;
hasNeventsRequested() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
hasNeventsRequested() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional int32 nevents_requested = 1;
hasNeventsRequested() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_requested = 1;
hasNeventsRequested() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
hasNeventsRequested() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional int32 nevents_requested = 1;
hasNeventsRequested() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nevents_requested = 1;
hasNext() - Method in class hep.physics.filter.Filter
 
hasNext() - Method in class jhplot.math.exp4j.tokenizer.Tokenizer
 
hasNext() - Method in class org.apache.commons.io.LineIterator
Indicates whether the Reader has more lines.
hasNext() - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
hasNext() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
hasNext() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap.Iterator
Check if there is a next element in the map.
hasNext() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap.Iterator
Check if there is a next element in the map.
hasNSelected() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
hasNSelected() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional int32 nSelected = 7;
hasNSelected() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nSelected = 7;
hasNSelected() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
hasNSelected() - Method in class promc.io.ProMCStatFile.ProMCStat
optional int32 nSelected = 7;
hasNSelected() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nSelected = 7;
hasNSelected() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
hasNSelected() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional int32 nSelected = 7;
hasNSelected() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nSelected = 7;
hasNSelected() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
hasNSelected() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional int32 nSelected = 7;
hasNSelected() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nSelected = 7;
hasNTried() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
hasNTried() - Method in class proeic.io.ProMCStatFile.ProMCStat
optional int32 nTried = 6;
hasNTried() - Method in interface proeic.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nTried = 6;
hasNTried() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
hasNTried() - Method in class promc.io.ProMCStatFile.ProMCStat
optional int32 nTried = 6;
hasNTried() - Method in interface promc.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nTried = 6;
hasNTried() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
hasNTried() - Method in class pronlo.io.ProMCStatFile.ProMCStat
optional int32 nTried = 6;
hasNTried() - Method in interface pronlo.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nTried = 6;
hasNTried() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
hasNTried() - Method in class proreco.io.ProMCStatFile.ProMCStat
optional int32 nTried = 6;
hasNTried() - Method in interface proreco.io.ProMCStatFile.ProMCStatOrBuilder
optional int32 nTried = 6;
hasNumber() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
hasNumber() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional int32 Number = 1;
hasNumber() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Number = 1;
hasNumber() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
hasNumber() - Method in class promc.io.ProMC.ProMCEvent.Event
optional int32 Number = 1;
hasNumber() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Number = 1;
hasNumber() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
hasNumber() - Method in class pronlo.io.ProMC.ProMCEvent.Event
optional int32 Number = 1;
hasNumber() - Method in interface pronlo.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Number = 1;
hasOption(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
hasOverflow() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double overflow = 14;
hasOverflow() - Method in class promc.io.PBufFile.Record.H1D
optional double overflow = 14;
hasOverflow() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional double overflow = 14;
hasP0D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0D p0D = 3;
hasP0D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.P0D p0D = 3;
hasP0D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.P0D p0D = 3;
hasP0I() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0I p0I = 2;
hasP0I() - Method in class promc.io.PBufFile.Record
optional .promc.Record.P0I p0I = 2;
hasP0I() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.P0I p0I = 2;
hasP1D() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P1D p1D = 6;
hasP1D() - Method in class promc.io.PBufFile.Record
optional .promc.Record.P1D p1D = 6;
hasP1D() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.P1D p1D = 6;
hasParticleById(int) - Static method in class j4np.physics.PDGDatabase
 
hasParticles() - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
hasParticles() - Method in class proeic.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
hasParticles() - Method in interface proeic.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
hasParticles() - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
hasParticles() - Method in class promc.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
hasParticles() - Method in interface promc.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
hasParticles() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
hasParticles() - Method in class pronlo.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
hasParticles() - Method in interface pronlo.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
hasParticles() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
hasParticles() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Particles particles = 2;
hasParticles() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Particles particles = 2;
hasPDF1() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float PDF1 = 6;
hasPDF1() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float PDF1 = 6;
hasPDF1() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float PDF1 = 6;
hasPdf1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
hasPdf1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf1 = 8;
hasPdf1() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf1 = 8;
hasPDF1() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float PDF1 = 6;
hasPDF1() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float PDF1 = 6;
hasPDF1() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float PDF1 = 6;
hasPdf1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
hasPdf1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf1 = 8;
hasPdf1() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf1 = 8;
hasPdf1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
hasPdf1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf1 = 8;
hasPdf1() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf1 = 8;
hasPdf1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
hasPdf1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf1 = 8;
hasPdf1() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf1 = 8;
hasPDF2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float PDF2 = 7;
hasPDF2() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float PDF2 = 7;
hasPDF2() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float PDF2 = 7;
hasPdf2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
hasPdf2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf2 = 9;
hasPdf2() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf2 = 9;
hasPDF2() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float PDF2 = 7;
hasPDF2() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float PDF2 = 7;
hasPDF2() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float PDF2 = 7;
hasPdf2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
hasPdf2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf2 = 9;
hasPdf2() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf2 = 9;
hasPdf2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
hasPdf2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf2 = 9;
hasPdf2() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf2 = 9;
hasPdf2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
hasPdf2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf2 = 9;
hasPdf2() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf2 = 9;
hasPdfId1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
hasPdfId1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id1 = 3;
hasPdfId1() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id1 = 3;
hasPdfId1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
hasPdfId1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id1 = 3;
hasPdfId1() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id1 = 3;
hasPdfId1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
hasPdfId1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id1 = 3;
hasPdfId1() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id1 = 3;
hasPdfId1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
hasPdfId1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id1 = 3;
hasPdfId1() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id1 = 3;
hasPdfId2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
hasPdfId2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id2 = 4;
hasPdfId2() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id2 = 4;
hasPdfId2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
hasPdfId2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id2 = 4;
hasPdfId2() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id2 = 4;
hasPdfId2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
hasPdfId2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id2 = 4;
hasPdfId2() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id2 = 4;
hasPdfId2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
hasPdfId2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional int32 pdf_id2 = 4;
hasPdfId2() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional int32 pdf_id2 = 4;
hasPhotons() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Photons photons = 9;
hasPhotons() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Photons photons = 9;
hasPhotons() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Photons photons = 9;
hasPND() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PND pND = 13;
hasPND() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PND pND = 13;
hasPND() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PND pND = 13;
hasPNI() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PNI pNI = 14;
hasPNI() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PNI pNI = 14;
hasPNI() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PNI pNI = 14;
HasPowerI - Interface in org.lsmp.djep.groupJep.interfaces
Group has a power operator a ^ b.
hasProcessID() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
hasProcessID() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional int32 Process_ID = 2;
hasProcessID() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Process_ID = 2;
hasProcessID() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
hasProcessID() - Method in class promc.io.ProMC.ProMCEvent.Event
optional int32 Process_ID = 2;
hasProcessID() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Process_ID = 2;
hasProcessID() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
hasProcessID() - Method in class pronlo.io.ProMC.ProMCEvent.Event
optional int32 Process_ID = 2;
hasProcessID() - Method in interface pronlo.io.ProMC.ProMCEvent.EventOrBuilder
optional int32 Process_ID = 2;
hasPXY() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXY pXY = 4;
hasPXY() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PXY pXY = 4;
hasPXY() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PXY pXY = 4;
hasPXYZ() - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXYZ pXYZ = 5;
hasPXYZ() - Method in class promc.io.PBufFile.Record
optional .promc.Record.PXYZ pXYZ = 5;
hasPXYZ() - Method in interface promc.io.PBufFile.RecordOrBuilder
optional .promc.Record.PXYZ pXYZ = 5;
hasQ2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Q2 = 16;
hasQ2() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float Q2 = 16;
hasQ2() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float Q2 = 16;
hasRequestedEvents() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
hasRequestedEvents() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double requested_events = 21;
hasRequestedEvents() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double requested_events = 21;
hasRequestedEvents() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
hasRequestedEvents() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double requested_events = 21;
hasRequestedEvents() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double requested_events = 21;
hasRequestedEvents() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
hasRequestedEvents() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double requested_events = 21;
hasRequestedEvents() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double requested_events = 21;
hasRequestedEvents() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
hasRequestedEvents() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double requested_events = 21;
hasRequestedEvents() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double requested_events = 21;
hasRms() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double rms = 15;
hasRms() - Method in class promc.io.PBufFile.Record.H1D
optional double rms = 15;
hasRms() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional double rms = 15;
hasS() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
hasS() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double s = 11;
hasS() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double s = 11;
hasS() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
hasS() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double s = 11;
hasS() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double s = 11;
hasS() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
hasS() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double s = 11;
hasS() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double s = 11;
hasS() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
hasS() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double s = 11;
hasS() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double s = 11;
hasScale() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Scale = 12;
hasScale() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float Scale = 12;
hasScale() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float Scale = 12;
hasScale() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Scale = 12;
hasScale() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float Scale = 12;
hasScale() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float Scale = 12;
hasScalePDF() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Scale_PDF = 10;
hasScalePDF() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float Scale_PDF = 10;
hasScalePDF() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float Scale_PDF = 10;
hasScalepdf() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
hasScalepdf() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double scalepdf = 7;
hasScalepdf() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double scalepdf = 7;
hasScalePDF() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Scale_PDF = 10;
hasScalePDF() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float Scale_PDF = 10;
hasScalePDF() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float Scale_PDF = 10;
hasScalepdf() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
hasScalepdf() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double scalepdf = 7;
hasScalepdf() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double scalepdf = 7;
hasScalepdf() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
hasScalepdf() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double scalepdf = 7;
hasScalepdf() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double scalepdf = 7;
hasScalepdf() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
hasScalepdf() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double scalepdf = 7;
hasScalepdf() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double scalepdf = 7;
hasSpace() - Method in class org.apache.commons.io.input.buffer.CircularByteBuffer
Returns, whether there is currently room for a single byte in the buffer.
hasSpace(int) - Method in class org.apache.commons.io.input.buffer.CircularByteBuffer
Returns, whether there is currently room for the given number of bytes in the buffer.
hasSumOfInversions() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns whether sumOfInversions() can return meaningful results.
hasSumOfLogarithms() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Tells whether sumOfLogarithms() can return meaningful results.
hasSumOfPowers(int) - Method in class cern.hep.aida.bin.MightyStaticBin1D
Tells whether sumOfPowers(k) can return meaningful results.
hasTimestamp() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
hasTimestamp() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
required uint64 timestamp = 4;
hasTimestamp() - Method in interface proeic.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 timestamp = 4;
hasTimestamp() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
hasTimestamp() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
required uint64 timestamp = 4;
hasTimestamp() - Method in interface promc.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 timestamp = 4;
hasTimestamp() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
hasTimestamp() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
required uint64 timestamp = 4;
hasTimestamp() - Method in interface pronlo.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 timestamp = 4;
hasTimestamp() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
hasTimestamp() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
required uint64 timestamp = 4;
hasTimestamp() - Method in interface proreco.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 timestamp = 4;
hasTracks() - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Tracks tracks = 8;
hasTracks() - Method in class proreco.io.ProMC.ProMCEvent
optional .promc.ProMCEvent.Tracks tracks = 8;
hasTracks() - Method in interface proreco.io.ProMC.ProMCEventOrBuilder
optional .promc.ProMCEvent.Tracks tracks = 8;
hasUnderflow() - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double underflow = 13;
hasUnderflow() - Method in class promc.io.PBufFile.Record.H1D
optional double underflow = 13;
hasUnderflow() - Method in interface promc.io.PBufFile.Record.H1DOrBuilder
optional double underflow = 13;
hasValidValue() - Method in interface org.lsmp.djep.matrixJep.MatrixVariableI
Is the value of this variable meaningful?
hasValidValue() - Method in class org.nfunk.jep.Variable
Is the value of this variable valid?
hasValue() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
hasValue() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required double value = 2;
hasValue() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required double value = 2;
hasValue() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
hasValue() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
required sint64 value = 2;
hasValue() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required sint64 value = 2;
hasValue() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
required double value = 2;
hasValue() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
required double value = 2;
hasValue() - Method in interface proeic.io.ProMCStatFile.ProMCStat.MetaFloatOrBuilder
required double value = 2;
hasValue() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
required sint64 value = 2;
hasValue() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
required sint64 value = 2;
hasValue() - Method in interface proeic.io.ProMCStatFile.ProMCStat.MetaIntOrBuilder
required sint64 value = 2;
hasValue() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
hasValue() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required double value = 2;
hasValue() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required double value = 2;
hasValue() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
hasValue() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
required sint64 value = 2;
hasValue() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required sint64 value = 2;
hasValue() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
hasValue() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required double value = 2;
hasValue() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required double value = 2;
hasValue() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
hasValue() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
required sint64 value = 2;
hasValue() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required sint64 value = 2;
hasValue() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
hasValue() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
required double value = 2;
hasValue() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder
required double value = 2;
hasValue() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
hasValue() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
required sint64 value = 2;
hasValue() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder
required sint64 value = 2;
hasVars() - Method in class promc.io.PBufFile.Record.FND.Builder
required string vars = 3;
hasVars() - Method in class promc.io.PBufFile.Record.FND
required string vars = 3;
hasVars() - Method in interface promc.io.PBufFile.Record.FNDOrBuilder
required string vars = 3;
hasVersion() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
hasVersion() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
required uint64 version = 1;
hasVersion() - Method in interface proeic.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 version = 1;
hasVersion() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
hasVersion() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
required uint64 version = 1;
hasVersion() - Method in interface promc.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 version = 1;
hasVersion() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
hasVersion() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
required uint64 version = 1;
hasVersion() - Method in interface pronlo.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 version = 1;
hasVersion() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
hasVersion() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
required uint64 version = 1;
hasVersion() - Method in interface proreco.io.ProMCDescriptionFile.ProMCDescriptionOrBuilder
required uint64 version = 1;
hasWeight() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional double Weight = 14;
hasWeight() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional double Weight = 14;
hasWeight() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional double Weight = 14;
hasWeight() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
hasWeight() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double weight = 20;
hasWeight() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double weight = 20;
hasWeight() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional double Weight = 14;
hasWeight() - Method in class promc.io.ProMC.ProMCEvent.Event
optional double Weight = 14;
hasWeight() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional double Weight = 14;
hasWeight() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
hasWeight() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double weight = 20;
hasWeight() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double weight = 20;
hasWeight() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
hasWeight() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double weight = 20;
hasWeight() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double weight = 20;
hasWeight() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
hasWeight() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double weight = 20;
hasWeight() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double weight = 20;
hasWidth() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
hasWidth() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float width = 4;
hasWidth() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float width = 4;
hasWidth() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
hasWidth() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float width = 4;
hasWidth() - Method in interface promc.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float width = 4;
hasWidth() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
hasWidth() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float width = 4;
hasWidth() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float width = 4;
hasWidth() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
hasWidth() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
optional float width = 4;
hasWidth() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder
optional float width = 4;
hasX() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X = 15;
hasX() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float X = 15;
hasX() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float X = 15;
hasX1() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X1 = 8;
hasX1() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float X1 = 8;
hasX1() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float X1 = 8;
hasX1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
hasX1() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double x1 = 5;
hasX1() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x1 = 5;
hasX1() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float X1 = 8;
hasX1() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float X1 = 8;
hasX1() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float X1 = 8;
hasX1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
hasX1() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double x1 = 5;
hasX1() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x1 = 5;
hasX1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
hasX1() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double x1 = 5;
hasX1() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x1 = 5;
hasX1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
hasX1() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double x1 = 5;
hasX1() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x1 = 5;
hasX2() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X2 = 9;
hasX2() - Method in class proeic.io.ProMC.ProMCEvent.Event
optional float X2 = 9;
hasX2() - Method in interface proeic.io.ProMC.ProMCEvent.EventOrBuilder
optional float X2 = 9;
hasX2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
hasX2() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
optional double x2 = 6;
hasX2() - Method in interface proeic.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x2 = 6;
hasX2() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float X2 = 9;
hasX2() - Method in class promc.io.ProMC.ProMCEvent.Event
optional float X2 = 9;
hasX2() - Method in interface promc.io.ProMC.ProMCEvent.EventOrBuilder
optional float X2 = 9;
hasX2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
hasX2() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
optional double x2 = 6;
hasX2() - Method in interface promc.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x2 = 6;
hasX2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
hasX2() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
optional double x2 = 6;
hasX2() - Method in interface pronlo.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x2 = 6;
hasX2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
hasX2() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
optional double x2 = 6;
hasX2() - Method in interface proreco.io.ProMCHeaderFile.ProMCHeaderOrBuilder
optional double x2 = 6;
haveSameEvenness(int, int) - Static method in class net.jafama.NumbersUtils
 
haveSameEvenness(long, long) - Static method in class net.jafama.NumbersUtils
 
haveSameSign(int, int) - Static method in class net.jafama.NumbersUtils
 
haveSameSign(long, long) - Static method in class net.jafama.NumbersUtils
 
hbar_Planck - Static variable in class cern.clhep.PhysicalConstants
 
hbarc - Static variable in class cern.clhep.PhysicalConstants
 
hbarc_squared - Static variable in class cern.clhep.PhysicalConstants
 
HBook - Class in jhplot.io
This class is used to book histograms for writing and reading.
HBook(String, String) - Constructor for class jhplot.io.HBook
Initialize HBook and tell what to do.
HBook(String) - Constructor for class jhplot.io.HBook
Initialize HBook class for reading a file.
HChart - Class in jhplot
Create various charts, such as pie, histograms, bar charts including 3D emulation, lines.
HChart(String, int, int, int, int, boolean) - Constructor for class jhplot.HChart
Create HChart canvas with a several chart plots
HChart(String, int, int) - Constructor for class jhplot.HChart
Construct a HChart canvas with a single plot/graph
HChart(String, int, int, boolean) - Constructor for class jhplot.HChart
Construct a HChart canvas with a single plot/graph
HChart(String, int, int, int, int) - Constructor for class jhplot.HChart
Construct a HChart canvas with plots/graphs
HChart(String) - Constructor for class jhplot.HChart
Construct a HChart canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
HChart() - Constructor for class jhplot.HChart
Construct a HChart canvas with a plot with the default parameters 600 by 400, and 10% space for the global title "Default"
HCluster - Class in jhplot
A Canvas to build a canvas for interactive data clustering.
HCluster() - Constructor for class jhplot.HCluster
Show a frame for clustering.
HCluster(DataHolder) - Constructor for class jhplot.HCluster
Show jMinHEP frame for clustering analysis.
HDataBase - Class in jhplot.io
This raw-level database allows to store and retrieve objects.
HDataBase(String, String) - Constructor for class jhplot.io.HDataBase
Create a new persistent database.
HDataBase(String) - Constructor for class jhplot.io.HDataBase
Open the database file for reading.
HeaderCount - Class in hep.lcio.util
Utility method for counting the number of runs and events in an LCIO file.
HeaderCount() - Constructor for class hep.lcio.util.HeaderCount
 
HeaderCountCommandHandler - Class in hep.lcio.util
Command line handling for the count command.
HeatMapDataset - Interface in org.jfree.data.general
A dataset that represents a rectangular grid of (x, y, z) values.
HeatMapUtilities - Class in org.jfree.data.general
A utility class for the HeatMapDataset.
HeatMapUtilities() - Constructor for class org.jfree.data.general.HeatMapUtilities
 
HEIGHT - Static variable in class jplot.JPlot
 
HEIGHTS_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
HEIGHTS_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
HelP - Static variable in interface jminhep.gui.Constants
 
HelpBrowser - Class in jhplot.gui
A browser of ScaVis documentaion.
HelpBrowser(String) - Constructor for class jhplot.gui.HelpBrowser
Show online browser
HelpBrowser(URL) - Constructor for class jhplot.gui.HelpBrowser
Show online browser
HelpDialog - Class in jhplot.utils
A class to build a help for each canvas.
HelpDialog(Component, String) - Constructor for class jhplot.utils.HelpDialog
Show a help frame
henry - Static variable in class cern.clhep.Units
 
hep.lcio.data - package hep.lcio.data
The package hep.lcio.data has been removed - interfaces are now all defined in hep.lcio.event.
hep.lcio.event - package hep.lcio.event
Primary user interface for LCIO.
hep.lcio.example - package hep.lcio.example
Simple usage examples.
hep.lcio.exceptions - package hep.lcio.exceptions
Exceptions thrown by LCIO.
hep.lcio.implementation.event - package hep.lcio.implementation.event
 
hep.lcio.implementation.io - package hep.lcio.implementation.io
Default IO implementation.
hep.lcio.implementation.sio - package hep.lcio.implementation.sio
SIO specific LCIO implementation.
hep.lcio.io - package hep.lcio.io
Interfaces for IO library.
hep.lcio.test - package hep.lcio.test
 
hep.lcio.util - package hep.lcio.util
Utilities for use with LCIO.
hep.physics.event - package hep.physics.event
Basic HEP event classes.
hep.physics.event.generator - package hep.physics.event.generator
Event generator infrastructure
hep.physics.event.generator.diagnostic - package hep.physics.event.generator.diagnostic
Diagnostic event generator
hep.physics.filter - package hep.physics.filter
Particle selection utilities.
hep.physics.jet - package hep.physics.jet
Jet finding and event shape utilities.
hep.physics.matrix - package hep.physics.matrix
Simple matrix package.
hep.physics.particle - package hep.physics.particle
Simple HEP particle classes.
hep.physics.particle.properties - package hep.physics.particle.properties
Simple HEP particle property classes.
hep.physics.stdhep.convert - package hep.physics.stdhep.convert
A package which can be used to convert between StdhepEvents and the much more OO HepEvent representation.
hep.physics.vec - package hep.physics.vec
General classes for operating on 3- and 4- vectors.
Hep3Matrix - Interface in hep.physics.vec
Hep 3x3 matrices
Hep3Matrix - Class in hephysics.vec
Hep 3x3 matrices
Hep3Matrix(int, int) - Constructor for class hephysics.vec.Hep3Matrix
 
Hep3Matrix(double[][]) - Constructor for class hephysics.vec.Hep3Matrix
Creates a new instance of BasicMatrix
Hep3Matrix() - Constructor for class hephysics.vec.Hep3Matrix
 
Hep3Matrix(double, double, double, double, double, double, double, double, double) - Constructor for class hephysics.vec.Hep3Matrix
 
Hep3Matrix(Matrix) - Constructor for class hephysics.vec.Hep3Matrix
 
Hep3Vector - Interface in hep.physics.vec
Interface to be implemented by 3 Vectors.
Hep3Vector - Class in hephysics.vec
Basic implementation of a Hep3Vector
Hep3Vector() - Constructor for class hephysics.vec.Hep3Vector
New 3-vector
Hep3Vector(double, double, double) - Constructor for class hephysics.vec.Hep3Vector
Define a 3-vector
Hep3Vector(double[]) - Constructor for class hephysics.vec.Hep3Vector
Create a BasicHep3Vector from a double array
Hep3Vector(float[]) - Constructor for class hephysics.vec.Hep3Vector
Define a new vector
hep_pascal - Static variable in class cern.clhep.Units
 
HEParticle - Class in hephysics.particle
a HEP-type basic particle based on 4-Lorentz vector.
HEParticle(String, double) - Constructor for class hephysics.particle.HEParticle
Define a particle with a name and mass
HEParticle(double, double, double) - Constructor for class hephysics.particle.HEParticle
Define a 3-momentum for a given particle.
HEParticle(double, double, double, double, double) - Constructor for class hephysics.particle.HEParticle
Define a 4-momentum and energy particle
HEParticle(HepLorentzVector, HepLorentzVector, double) - Constructor for class hephysics.particle.HEParticle
Define a particle in momentum and position
HEParticle(double, double, double, double) - Constructor for class hephysics.particle.HEParticle
Define a particle in momentum space.
HEParticle(String, double, double, double, double, double) - Constructor for class hephysics.particle.HEParticle
Define a Lorentz particle in momentum space.
HEPEvent - Interface in hep.physics.event
A simple event structure.
hephysics.hepsim - package hephysics.hepsim
 
hephysics.jet - package hephysics.jet
Java implementation of the longitudinally invariant kT, Cambridge/Aachen and anti-KT clustering algorithms using the recombination method.
hephysics.matrix - package hephysics.matrix
Simple matrix package.
hephysics.particle - package hephysics.particle
Define various Lorentz-type particles.
hephysics.vec - package hephysics.vec
Lorentz-type vectors and transformations.
HepLorentzVector - Interface in hep.physics.vec
Interface to be implemented by 4 Vectors.
HepLorentzVector - Class in hephysics.vec
a HepLorentzVector (4-vector).
HepLorentzVector() - Constructor for class hephysics.vec.HepLorentzVector
Default Lorentz vector constructor
HepLorentzVector(double, double, double, double) - Constructor for class hephysics.vec.HepLorentzVector
Define a Lorentz vector This can either be (x,y,z,time) or (px,py,pz,energy)
HepLorentzVector(double[], double) - Constructor for class hephysics.vec.HepLorentzVector
Define a Lorentz vector
HepLorentzVector(float[], double) - Constructor for class hephysics.vec.HepLorentzVector
Define a Lorentz vector
HepLorentzVector(Hep3Vector, double) - Constructor for class hephysics.vec.HepLorentzVector
Define Lorentz vector
HepsimGUI - Class in jhepsim
Application
HepsimGUI(String) - Constructor for class jhepsim.HepsimGUI
 
hermite(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegratorFactory
Creates a Gauss-Hermite integrator of the given order.
HermiteInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Polynomial interpolator using both sample values and sample derivatives.
HermiteInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.HermiteInterpolator
Create an empty interpolator.
HermiteRuleFactory - Class in org.apache.commons.math3.analysis.integration.gauss
Factory that creates a Gauss-type quadrature rule using Hermite polynomials of the first kind.
HermiteRuleFactory() - Constructor for class org.apache.commons.math3.analysis.integration.gauss.HermiteRuleFactory
 
hertz - Static variable in class cern.clhep.Units
 
hessianG2Tolerance() - Method in class org.freehep.math.minuit.MnStrategy
 
hessianGradientNCycles() - Method in class org.freehep.math.minuit.MnStrategy
 
hessianNCycles() - Method in class org.freehep.math.minuit.MnStrategy
 
hessianStepTolerance() - Method in class org.freehep.math.minuit.MnStrategy
 
HexDump - Class in org.apache.commons.io
Dumps data in hexadecimal format.
HexDump() - Constructor for class org.apache.commons.io.HexDump
Instances should NOT be constructed in standard programming.
HexNumberFormat - Class in org.jfree.chart.util
A custom number formatter that formats numbers as hexadecimal strings.
HexNumberFormat() - Constructor for class org.jfree.chart.util.HexNumberFormat
Creates a new instance with 8 digits.
HexNumberFormat(int) - Constructor for class org.jfree.chart.util.HexNumberFormat
Creates a new instance with the specified number of digits.
HFile - Class in jhplot.io
Write or read objects in sequential order using the Java serialization.
HFile(String, String, boolean, int) - Constructor for class jhplot.io.HFile
Open a file to write/read objects to/from a serialized file in sequential order.
HFile(String, String, boolean) - Constructor for class jhplot.io.HFile
Open a file to write/read objects to/from a serialized file in sequential order.
HFile(String) - Constructor for class jhplot.io.HFile
Open file for reading objects from a serialized file in sequential order.
HFile(String, String) - Constructor for class jhplot.io.HFile
Open file for reading objects from a serialized file in sequential order.
HFileDIF - Class in jhplot.io
Write or read data in DIF format.
HFileDIF(String, String) - Constructor for class jhplot.io.HFileDIF
Open a file to write/read data to/from a DIF file.
HFileDIF(String) - Constructor for class jhplot.io.HFileDIF
Open file for reading.
HFileMap<K1,K2> - Class in jhplot.io
Hash map for internal repsentation of data inside HFile.
HFileMap() - Constructor for class jhplot.io.HFileMap
 
HFileMap(int) - Constructor for class jhplot.io.HFileMap
 
HFileXML - Class in jhplot.io
Open a XML file to write/read objects in sequential order using java serialization in XML.
HFileXML(String, String, int) - Constructor for class jhplot.io.HFileXML
Open a XML file to write or read objects to/from a serialized file in sequential order.
HFileXML(String, String) - Constructor for class jhplot.io.HFileXML
Open a XML file to write or read objects to/from a serialized file in sequential order.
HFileXML(String) - Constructor for class jhplot.io.HFileXML
Open a XML file to write or read objects to/from a serialized file in sequential order.
HFit - Class in jhplot
Main class for fit data or histograms.
HFit() - Constructor for class jhplot.HFit
Show an empty fit frame.
HFit(HPlot, String) - Constructor for class jhplot.HFit
Show an empty fit frame and pass HPlot object.
HFit(HPlot, H1D) - Constructor for class jhplot.HFit
Show a fit frame for a selected histogram.
HFit(HPlot, P1D) - Constructor for class jhplot.HFit
Show a fit frame for a selected histogram.
HFit(HPlot, String, Object, String) - Constructor for class jhplot.HFit
Show a fit frame for a selected histogram.
HFitter - Class in jhplot
Fit data (H1D or P1D).
HFitter(String) - Constructor for class jhplot.HFitter
Create a fitter using some method.
HFitter() - Constructor for class jhplot.HFitter
Create a fitter with the Chi2 method by default.
HIDDEN - Static variable in class org.apache.commons.io.filefilter.HiddenFileFilter
Singleton instance of hidden filter
HiddenFileFilter - Class in org.apache.commons.io.filefilter
This filter accepts Files that are hidden.
hide() - Method in class jplot.GraphLabel
 
hide(boolean) - Method in class jplot.GraphLabel
sets the hide attribute of this label
hide(String) - Method in class jplot.XMLRead
Hides an element or a context from the current vector.
hideZoomRectangle() - Method in class org.jfree.chart.fx.ChartViewer
Hides the zoom rectangle.
HierarchicalAlg - Class in jminhep.algorithms
Carry out pairwise agglomerations.
HierarchicalAlg(DataHolder) - Constructor for class jminhep.algorithms.HierarchicalAlg
Build a hierarchical algorithm.
HIGH_END - Static variable in class org.jfree.chart.axis.AxisLabelLocation
Axis label at the top.
HighamHall54FieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 5(4) Higham and Hall integrator for Ordinary Differential Equations.
HighamHall54FieldIntegrator(Field<T>, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.HighamHall54FieldIntegrator
Simple constructor.
HighamHall54FieldIntegrator(Field<T>, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.HighamHall54FieldIntegrator
Simple constructor.
HighamHall54Integrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 5(4) Higham and Hall integrator for Ordinary Differential Equations.
HighamHall54Integrator(double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.HighamHall54Integrator
Simple constructor.
HighamHall54Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.HighamHall54Integrator
Simple constructor.
HighLowItemLabelGenerator - Class in org.jfree.chart.labels
A standard item label generator for plots that use data from a OHLCDataset.
HighLowItemLabelGenerator() - Constructor for class org.jfree.chart.labels.HighLowItemLabelGenerator
Creates an item label generator using the default date and number formats.
HighLowItemLabelGenerator(DateFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.HighLowItemLabelGenerator
Creates a tool tip generator using the supplied date formatter.
HighLowRenderer - Class in org.jfree.chart.renderer.xy
A renderer that draws high/low/open/close markers on an XYPlot (requires a OHLCDataset).
HighLowRenderer() - Constructor for class org.jfree.chart.renderer.xy.HighLowRenderer
The default constructor.
histClone(String) - Method in class org.jlab.groot.data.H1F
returns a copy of the histogram with different name.
histClone(String) - Method in class org.jlab.groot.data.H2F
 
histF() - Method in class jhplot.HPlot
Return IHistogramFactory associated with the plot
HISTO - Static variable in class jplot.LinePars
 
histogram(IHistogram1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Fills all cells of the given vector into the given histogram.
histogram(IHistogram2D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Fills all cells of the given vectors into the given histogram.
histogram(IHistogram2D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Fills all cells of the given vectors into the given histogram.
histogram(IHistogram3D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Fills all cells of the given vectors into the given histogram.
HISTOGRAM - Static variable in class org.jlab.groot.base.DatasetAttributes
 
Histogram1D - Class in cern.hep.aida.ref
A reference implementation of hep.aida.IHistogram1D.
Histogram1D(String, double[]) - Constructor for class cern.hep.aida.ref.Histogram1D
Creates a variable-width histogram.
Histogram1D(String, int, double, double) - Constructor for class cern.hep.aida.ref.Histogram1D
Creates a fixed-width histogram.
Histogram1D(String, IAxis) - Constructor for class cern.hep.aida.ref.Histogram1D
Creates a histogram with the given axis binning.
Histogram2D - Class in cern.hep.aida.ref
A reference implementation of hep.aida.IHistogram2D.
Histogram2D(String, double[], double[]) - Constructor for class cern.hep.aida.ref.Histogram2D
Creates a variable-width histogram.
Histogram2D(String, int, double, double, int, double, double) - Constructor for class cern.hep.aida.ref.Histogram2D
Creates a fixed-width histogram.
Histogram2D(String, IAxis, IAxis) - Constructor for class cern.hep.aida.ref.Histogram2D
Creates a histogram with the given axis binning.
HISTOGRAM2D - Static variable in class org.jlab.groot.base.DatasetAttributes
 
Histogram2DPlotter - Class in org.jlab.groot.graphics
 
Histogram2DPlotter(IDataSet) - Constructor for class org.jlab.groot.graphics.Histogram2DPlotter
 
Histogram3D - Class in cern.hep.aida.ref
A reference implementation of hep.aida.IHistogram3D.
Histogram3D(String, double[], double[], double[]) - Constructor for class cern.hep.aida.ref.Histogram3D
Creates a variable-width histogram.
Histogram3D(String, int, double, double, int, double, double, int, double, double) - Constructor for class cern.hep.aida.ref.Histogram3D
Creates a fixed-width histogram.
Histogram3D(String, IAxis, IAxis, IAxis) - Constructor for class cern.hep.aida.ref.Histogram3D
Creates a histogram with the given axis binning.
HistogramBin - Class in org.jfree.data.statistics
A bin for the HistogramDataset class.
HistogramBin(double, double) - Constructor for class org.jfree.data.statistics.HistogramBin
Creates a new bin.
HistogramDataset - Class in org.jfree.data.statistics
A dataset that can be used for creating histograms.
HistogramDataset() - Constructor for class org.jfree.data.statistics.HistogramDataset
Creates a new (empty) dataset with a default type of HistogramType.FREQUENCY.
HistogramPlotter - Class in org.jlab.groot.graphics
 
HistogramPlotter(IDataSet) - Constructor for class org.jlab.groot.graphics.HistogramPlotter
 
HistogramPlotter(IDataSet, String) - Constructor for class org.jlab.groot.graphics.HistogramPlotter
 
HistogramType - Class in org.jfree.data.statistics
A class for creating constants to represent the histogram type.
hit(Rectangle, Shape, boolean) - Method in class org.jfree.chart.fx.FXGraphics2D
Returns true if the rectangle (in device space) intersects with the shape (the interior, if onStroke is false, otherwise the stroked outline of the shape).
HitHistogram - Class in org.apache.commons.math3.ml.neuralnet.twod.util
Computes the hit histogram.
HitHistogram(boolean, DistanceMeasure) - Constructor for class org.apache.commons.math3.ml.neuralnet.twod.util.HitHistogram
 
HKey - Class in jhplot
Create an interactive key label in the USER or NDC coordinates.
HKey(String, Font, Color) - Constructor for class jhplot.HKey
Create a key label.
HKey(String, double, double, Font, Color, String, Object) - Constructor for class jhplot.HKey
Make a key for a function, data points or histograms (F1D, H1D, P1D).
HKey(String, double, double, Font, String, Object) - Constructor for class jhplot.HKey
Make a key for a function, data points or histograms (F1D, H1D, P1D).
HKey(String, double, double, String, Object) - Constructor for class jhplot.HKey
Make a key for a function, data points or histograms (F1D, H1D, P1D).
HKey(String, double, double, Object) - Constructor for class jhplot.HKey
Make a key for a function, data points or histograms (F1D, H1D, P1D).
HKey(String, Object) - Constructor for class jhplot.HKey
Make a key for a function, data points or histograms (F1D, H1D, P1D) at the default position.
HKey(String, Font) - Constructor for class jhplot.HKey
Make a key label (color- black)
HKey(String) - Constructor for class jhplot.HKey
Make a key label with default attributes
HKey(String, double, double) - Constructor for class jhplot.HKey
Make a key label with specific coordinated in the data system
HKey(String, double, double, String) - Constructor for class jhplot.HKey
Make a label with specific coordinates.
HLabel - Class in jhplot
Create an interactive Label in the USER or NDC coordinates.
HLabel(String, Font, Color) - Constructor for class jhplot.HLabel
Make a text label at (0,0) in the data coordinates (USER).
HLabel(String, Font) - Constructor for class jhplot.HLabel
Make a label (color- black)
HLabel(String) - Constructor for class jhplot.HLabel
Make a label with default attributes
HLabel(String, double, double) - Constructor for class jhplot.HLabel
Make a label with specific coordinated in the data system
HLabel(String, double, double, String) - Constructor for class jhplot.HLabel
Make a label with specific coordinates.
HLabelEq - Class in jhplot
Create an equation using the LaTex syntax.
HLabelEq(String, int, Color) - Constructor for class jhplot.HLabelEq
Make a label with equation using the LaTeX syntax
HLabelEq(String, int) - Constructor for class jhplot.HLabelEq
Make a equation label (color- black)
HLabelEq(String) - Constructor for class jhplot.HLabelEq
Make a label with default attributes
HLabelEq(String, double, double) - Constructor for class jhplot.HLabelEq
Make a equation label with specific coordinated in the data system
HLabelEq(String, double, double, String) - Constructor for class jhplot.HLabelEq
Make a label with specific coordinates.
HMLabel - Class in jhplot
Create an interactive multi-line label in the USER or NDC coordinates.
HMLabel(String[], Font, Color) - Constructor for class jhplot.HMLabel
Make a multitext label
HMLabel(String[], Font) - Constructor for class jhplot.HMLabel
Make a multitext label (black color is used).
HMLabel(String[]) - Constructor for class jhplot.HMLabel
Make a multitext label with default attributes.
HMLabel(String[], double, double) - Constructor for class jhplot.HMLabel
Make a label with specific coordinated in the data system
HMLabel(String[], double, double, String) - Constructor for class jhplot.HMLabel
Make a label with specific coordinates.
HMSNumberFormat - Class in org.jfree.chart.util
A custom number formatter that formats numbers (in seconds) as HH:MM:SS.
HMSNumberFormat() - Constructor for class org.jfree.chart.util.HMSNumberFormat
Creates a new instance.
homoscedasticT(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
homoscedasticT(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
homoscedasticT(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a 2-sample t statistic, under the hypothesis of equal subpopulation variances.
homoscedasticT(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a 2-sample t statistic, comparing the means of the datasets described by two StatisticalSummary instances, under the assumption of equal subpopulation variances.
homoscedasticTTest(double[], double[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
homoscedasticTTest(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
homoscedasticTTest(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays, under the assumption that the two samples are drawn from subpopulations with equal variances.
homoscedasticTTest(double[], double[], double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha, assuming that the subpopulation variances are equal.
homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances, under the hypothesis of equal subpopulation variances.
HORIZONTAL - Static variable in class org.jfree.chart.plot.PlotOrientation
For a plot where the range axis is horizontal.
HOUR - Static variable in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of version 1.0.13, use DateTickUnitType instead.
HOUR - Static variable in class org.jfree.chart.axis.DateTickUnitType
Hour.
Hour - Class in org.jfree.data.time
Represents an hour in a specific day.
Hour() - Constructor for class org.jfree.data.time.Hour
Constructs a new Hour, based on the system date/time.
Hour(int, Day) - Constructor for class org.jfree.data.time.Hour
Constructs a new Hour.
Hour(int, int, int, int) - Constructor for class org.jfree.data.time.Hour
Creates a new hour.
Hour(Date) - Constructor for class org.jfree.data.time.Hour
Constructs a new instance, based on the supplied date/time and the default time zone.
Hour(Date, TimeZone) - Constructor for class org.jfree.data.time.Hour
Deprecated.
As of 1.0.13, use the constructor that specifies the locale also.
Hour(Date, TimeZone, Locale) - Constructor for class org.jfree.data.time.Hour
Constructs a new instance, based on the supplied date/time evaluated in the specified time zone.
HOUR_SEGMENT_SIZE - Static variable in class org.jfree.chart.axis.SegmentedTimeline
Defines a one hour segment size in ms.
House - Class in Jampack
House provides static methods to generate and apply Householder transformations.
House() - Constructor for class Jampack.House
 
HParam - Class in jhplot
Global setting for all DMelt jhplot class methods for mathematical calculations.
HParam() - Constructor for class jhplot.HParam
 
HPlot - Class in jhplot
HPlot class to create a canvas with several plots.
HPlot(String, int, int, int, int, boolean) - Constructor for class jhplot.HPlot
Create HPlot canvas with several plots.
HPlot(String, int, int, int, int) - Constructor for class jhplot.HPlot
Create HPlot canvas with several plots.
HPlot(String, int, int) - Constructor for class jhplot.HPlot
Construct a HPlot canvas with a single plot.
HPlot(String, int, int, boolean) - Constructor for class jhplot.HPlot
Construct a HPlot canvas with a single plot.
HPlot(String) - Constructor for class jhplot.HPlot
Construct a HPlot canvas with a plot with the size 600x400.
HPlot() - Constructor for class jhplot.HPlot
Construct a HPlot canvas with a single plot with the size 600x400.
HPlot3D - Class in jhplot
Create a interactive canvas to show objects in 3D.
HPlot3D(String, int, int, int, int, boolean) - Constructor for class jhplot.HPlot3D
Create interactive 3D canvas to display data.
HPlot3D(String, int, int, int, int) - Constructor for class jhplot.HPlot3D
Create a 3D canvas to display data.
HPlot3D(String, int, int) - Constructor for class jhplot.HPlot3D
Construct a 3D canvas with a single plot/graph
HPlot3D(String) - Constructor for class jhplot.HPlot3D
Construct a 3D canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
HPlot3D() - Constructor for class jhplot.HPlot3D
Construct a 3D canvas with a plot with the default parameters 600 by 400, and 10% space for the global title "Default"
HPlot3DP - Class in jhplot
Create a frame for showing 3D parametric functions.
HPlot3DP(String, int, int, int, int, boolean) - Constructor for class jhplot.HPlot3DP
Create a canvas with several plots showing 3D function
HPlot3DP(String, int, int) - Constructor for class jhplot.HPlot3DP
Construct a canvas with a single plot/graph
HPlot3DP(String, int, int, int, int) - Constructor for class jhplot.HPlot3DP
Construct a canvas with plots/graphs
HPlot3DP(String) - Constructor for class jhplot.HPlot3DP
Construct a canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
HPlot3DP() - Constructor for class jhplot.HPlot3DP
Construct a canvas with a plot with the default parameters 600 by 400, and 10% space for the global title "Default"
HPlotJas - Class in jhplot
Create a canvas using the JAS plotter API.
HPlotJas(String, int, int, ArrayList<Object>) - Constructor for class jhplot.HPlotJas
Create HPlot canvas with several plots.
HPlotJas(String, ArrayList<Object>) - Constructor for class jhplot.HPlotJas
Construct a Jas frame and prepare for plotting.
HPlotJas(ArrayList<Object>) - Constructor for class jhplot.HPlotJas
Construct a Jas frame and prepare for plotting.
HPlotJas(String) - Constructor for class jhplot.HPlotJas
Construct a Jas canvas with a plot with the size 600x400.
HPlotJas() - Constructor for class jhplot.HPlotJas
Construct a HPlot canvas with a single plot with the size 600x400.
HProf1D - Class in jhplot
Create profile histogram in 1D.
HProf1D() - Constructor for class jhplot.HProf1D
Build 1D histogram.
HProf1D(String, int, double, double) - Constructor for class jhplot.HProf1D
Build 1D profile histogram
HProf1D(String, double[]) - Constructor for class jhplot.HProf1D
Create 1D profile histogram with variable bin size.
HProf1D(String, IAxis) - Constructor for class jhplot.HProf1D
Create 1D histogram with variable bin size.
HProf1D(Profile1D) - Constructor for class jhplot.HProf1D
Create H1D histogram from JAIDA Histogram1D class.
HProf1D(IProfile1D) - Constructor for class jhplot.HProf1D
Create profile histogram from JAIDA class
HProf1D(String, HProf1D) - Constructor for class jhplot.HProf1D
Create profile histogram from another instance.
HProf1D(TProfile) - Constructor for class jhplot.HProf1D
Create profile histogram from JAIDA histogram class
HProf2D - Class in jhplot
Profile histogram in 2D.
HProf2D(String, int, double, double, int, double, double) - Constructor for class jhplot.HProf2D
Create 2D histogram
HProf2D(String, double[], double[]) - Constructor for class jhplot.HProf2D
Create 2D profile histogram with variable bin size.
HProf2D(Profile2D) - Constructor for class jhplot.HProf2D
Create a H2D histogram from JAIDA histogram
HShape - Class in jhplot.shapes
Main class to build a JAVA 2D primitives
HShape(double, double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.HShape
Build a primitive
HShape() - Constructor for class jhplot.shapes.HShape
Build a default primitive
HShape(double, double, double, double) - Constructor for class jhplot.shapes.HShape
Build a primitive using the default color and stroke
HShape(double[], double[], Stroke, Color) - Constructor for class jhplot.shapes.HShape
Build a primitive using polyline.
HTable - Class in jhplot
Build a table in a frame to display data in various containers (P1D, H1D, F1D).
HTable(String, String[], Double[][]) - Constructor for class jhplot.HTable
Main class to build a table from Vectors.
HTable() - Constructor for class jhplot.HTable
Build a table frame to display data.
HTable(double[]) - Constructor for class jhplot.HTable
Show 1D array
HTable(double[][]) - Constructor for class jhplot.HTable
Show 2D array
HTable(H1D) - Constructor for class jhplot.HTable
Build a table frame to display data of H1D histogram Data will be formated to scientific format
HTable(P0I) - Constructor for class jhplot.HTable
Build a table frame to display P0D data container Data will be formated to scientific format
HTable(PND) - Constructor for class jhplot.HTable
Build a table frame to display PND data container Data will be formated to scientific format
HTable(PNI) - Constructor for class jhplot.HTable
Build a table frame to display PND data container Data will be formated to scientific format
HTable(P2D) - Constructor for class jhplot.HTable
Build a table frame to display P2D data container Data will be formated to scientific format
HTable(P3D) - Constructor for class jhplot.HTable
Build a table frame to display P3D data container Data will be formated to scientific format
HTable(F1D) - Constructor for class jhplot.HTable
Build a table frame to display data of F1D function.
HTable(DataHolder) - Constructor for class jhplot.HTable
Build a table frame to display multidimensional data
HTable(P1D) - Constructor for class jhplot.HTable
Build a table frame to display P1D data container
HTable(P0D) - Constructor for class jhplot.HTable
Build a table frame to display P0D data container
htmlEncoded(String) - Static method in class jhepsim.Util
Substitutes conflicting characters in text with html masked expressions.
htmlEncoded(String) - Static method in class jhplot.utils.Util
Substitutes conflicting characters in text with html masked expressions.
htmlEncoded(String) - Static method in class jminhep.utils.Util
Substitutes conflicting characters in text with html masked expressions.
htmlEscape(String) - Static method in class org.jfree.chart.imagemap.ImageMapUtilities
Returns a string that is equivalent to the input string, but with special characters converted to HTML escape sequences.
Hyperbolic - Class in cern.jet.random
Hyperbolic distribution.
Hyperbolic(double, double, RandomEngine) - Constructor for class cern.jet.random.Hyperbolic
Constructs a Beta distribution.
HyperGeometric - Class in cern.jet.random
HyperGeometric distribution; See the math definition The hypergeometric distribution with parameters N, n and s is the probability distribution of the random variable X, whose value is the number of successes in a sample of n items from a population of size N that has s 'success' items and N - s 'failure' items.
HyperGeometric(int, int, int, RandomEngine) - Constructor for class cern.jet.random.HyperGeometric
Constructs a HyperGeometric distribution.
Hypergeometric - Class in jhplot.math.num.pdf
The Hypergeometric distribution.
Hypergeometric() - Constructor for class jhplot.math.num.pdf.Hypergeometric
Default constructor.
Hypergeometric(int, int, int) - Constructor for class jhplot.math.num.pdf.Hypergeometric
Create a distribution with the given number of failures, number of successes, and sample size.
HypergeometricDistribution - Class in org.apache.commons.math3.distribution
Implementation of the hypergeometric distribution.
HypergeometricDistribution(int, int, int) - Constructor for class org.apache.commons.math3.distribution.HypergeometricDistribution
Construct a new hypergeometric distribution with the specified population size, number of successes in the population, and sample size.
HypergeometricDistribution(RandomGenerator, int, int, int) - Constructor for class org.apache.commons.math3.distribution.HypergeometricDistribution
Creates a new hypergeometric distribution.
Hyperplane<S extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface represents an hyperplane of a space.
hypot(double, double) - Static method in class Jama.util.Maths
sqrt(a^2 + b^2) without under/overflow.
hypot(double, double) - Static method in class jhplot.math.kalman.jama.Maths
sqrt(a^2 + b^2) without under/overflow.
hypot(double, double) - Static method in class jhplot.math.Mathfun
sqrt(a^2 + b^2) without under/overflow.
hypot(ValueErr, ValueErr) - Method in class jhplot.math.ValueErr
Returns the length of the hypotenuse of a and b i.e.
hypot(double, double) - Static method in class net.jafama.FastMath
 
hypot(double, double, double) - Static method in class net.jafama.FastMath
 
hypot(double, double) - Static method in class net.jafama.StrictFastMath
 
hypot(double, double, double) - Static method in class net.jafama.StrictFastMath
 
hypot(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Returns the hypotenuse of a triangle with sides this and y - sqrt(this2 +y2) avoiding intermediate overflow or underflow.
hypot(DerivativeStructure, DerivativeStructure) - Static method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Returns the hypotenuse of a triangle with sides x and y - sqrt(x2 +y2) avoiding intermediate overflow or underflow.
hypot(SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Returns the hypotenuse of a triangle with sides this and y - sqrt(this2 +y2) avoiding intermediate overflow or underflow.
hypot(SparseGradient, SparseGradient) - Static method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Returns the hypotenuse of a triangle with sides x and y - sqrt(x2 +y2) avoiding intermediate overflow or underflow.
hypot(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Returns the hypotenuse of a triangle with sides this and y - sqrt(this2 +y2) avoiding intermediate overflow or underflow.
hypot(T) - Method in interface org.apache.commons.math3.RealFieldElement
Returns the hypotenuse of a triangle with sides this and y - sqrt(this2 +y2) avoiding intermediate overflow or underflow.
hypot(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Returns the hypotenuse of a triangle with sides this and y - sqrt(this2 +y2) avoiding intermediate overflow or underflow.
hypot(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Returns the hypotenuse of a triangle with sides x and y - sqrt(x2 +y2)
avoiding intermediate overflow or underflow.
hypotenuse(ValueErr, ValueErr, double) - Method in class jhplot.math.ValueErr
Returns the length of the hypotenuse of a and b i.e.
hypotenuse(double, double) - Method in class jhplot.math.ValueErr
Returns the length of the hypotenuse of a and b i.e.
hypWithCovariance(double, double, double) - Method in class jhplot.math.ValueErr
Private methods.

I

I - Static variable in class Jampack.Z
Imaginary unit.
I - Static variable in class org.apache.commons.math3.complex.Complex
The square root of -1.
I - Static variable in class org.apache.commons.math3.complex.Quaternion
i
i0(double) - Static method in class cern.jet.math.Bessel
Returns the modified Bessel function of order 0 of the argument.
i0e(double) - Static method in class cern.jet.math.Bessel
Returns the exponentially scaled modified Bessel function of order 0 of the argument.
i1(double) - Static method in class cern.jet.math.Bessel
Returns the modified Bessel function of order 1 of the argument.
i1e(double) - Static method in class cern.jet.math.Bessel
Returns the exponentially scaled modified Bessel function of order 1 of the argument.
IAxis - Interface in colt.hep.aida
An IAxis represents a binned histogram axis.
IAxisFrame - Interface in org.jlab.groot.base
 
ibeta(double, double, double) - Static method in class graph.SpecialFunction
 
ICalorimeterHit - Class in hep.lcio.implementation.event
A default implementation of CalorimeterHit
ICalorimeterHit() - Constructor for class hep.lcio.implementation.event.ICalorimeterHit
 
ICluster - Class in hep.lcio.implementation.event
 
ICluster() - Constructor for class hep.lcio.implementation.event.ICluster
 
Id - Class in org.lsmp.djep.vectorJep.function
Creates an identity matrix.
Id() - Constructor for class org.lsmp.djep.vectorJep.function.Id
 
ID1_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
ID1_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
ID1_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
ID1_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
ID1_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
ID1_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
ID1_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
ID2_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
ID2_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
ID2_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
ID2_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
ID2_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
ID2_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
ID2_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
ID_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
ID_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
ID_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
ID_FIELD_NUMBER - Static variable in class promc.io.PEventFile.HEvent
 
ID_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
ID_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
ID_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
ID_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent.Particles
 
ID_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
ID_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
ID_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
ID_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
ID_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
IDA_FIELD_NUMBER - Static variable in class promc.io.PEventFile.HEvent.Entry
 
IDA_FIELD_NUMBER - Static variable in class promc.io.PEventFile.HEvent
 
idamax(DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Returns the index of largest absolute value; i such that |x[i]| == max(|x[0]|,|x[1]|,...)..
idamax(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
idamax(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
IDATA_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
IDATA_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
IDATA_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent.Event
 
IDataSet - Interface in org.jlab.groot.data
 
IDataSetPlotter - Interface in org.jlab.groot.graphics
 
Identifier() - Method in class org.nfunk.jep.Parser
 
identity(int) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs an identity matrix (having ones on the diagonal and zeros elsewhere).
identity - Static variable in class cern.jet.math.Functions
Function that returns its argument.
identity - Static variable in class cern.jet.math.IntFunctions
Function that returns its argument.
identity() - Static method in class hep.physics.vec.BasicHep3Matrix
 
identity() - Static method in class hephysics.vec.Hep3Matrix
 
identity(int, int) - Static method in class Jama.Matrix
Generate identity matrix
identity(int) - Static method in class jhplot.math.DoubleArray
Generates an m x m identity matrix.
identity(int, int) - Static method in class jhplot.math.kalman.jama.Matrix
Generate identity matrix
identity() - Method in class jhplot.math.kalman.jama.Matrix
Generate identity matrix
identity(int, int, double) - Static method in class jhplot.math.kalman.jama.Matrix
Generate identity matrix
identity(int) - Static method in class jhplot.math.SortUtils
Create identity permutation, that is {0, 1, ..., n}
identity() - Static method in interface org.apache.commons.io.function.IOFunction
Returns a IOFunction that always returns its input argument.
Identity - Class in org.apache.commons.math3.analysis.function
Identity function.
Identity() - Constructor for class org.apache.commons.math3.analysis.function.Identity
 
IDENTITY - Static variable in class org.apache.commons.math3.complex.Quaternion
Identity quaternion.
IDENTITY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Identity rotation.
identityPermutation(int) - Static method in class org.apache.commons.math3.genetics.RandomKey
Generates a representation corresponding to an identity permutation of length l which can be passed to the RandomKey constructor.
IdentityPreconditioner() - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
 
IdentityPreconditioner() - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
Deprecated.
 
IEEEremainder - Static variable in class cern.jet.math.Functions
Function that returns Math.IEEEremainder(a,b).
IEEEremainder(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns Math.IEEEremainder(a,b).
IEEEremainder(double, double) - Static method in class net.jafama.FastMath
 
IEEEremainder(double, double) - Static method in class net.jafama.StrictFastMath
 
IEEEremainder(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Computes the remainder as prescribed by the IEEE 754 standard.
If - Class in org.nfunk.jep.function
The if(condExpr,posExpr,negExpr) function.
If() - Constructor for class org.nfunk.jep.function.If
 
igam(double, double) - Static method in class graph.SpecialFunction
 
igamc(double, double) - Static method in class graph.SpecialFunction
 
IHistogram - Interface in colt.hep.aida
A common base interface for IHistogram1D, IHistogram2D and IHistogram3D.
IHistogram1D - Interface in colt.hep.aida
A Java interface corresponding to the AIDA 1D Histogram.
IHistogram2D - Interface in colt.hep.aida
A Java interface corresponding to the AIDA 2D Histogram.
IHistogram3D - Interface in colt.hep.aida
A Java interface corresponding to the AIDA 3D Histogram.
iiX - Variable in class jminhep.gui.Plotter
 
iiY - Variable in class jminhep.gui.Plotter
 
ILCCollection - Class in hep.lcio.implementation.event
A default implementation of LCCollection
ILCCollection(String) - Constructor for class hep.lcio.implementation.event.ILCCollection
 
ILCCollection(String, int, int) - Constructor for class hep.lcio.implementation.event.ILCCollection
 
ILCEvent - Class in hep.lcio.implementation.event
A default implementation of LCEvent
ILCEvent() - Constructor for class hep.lcio.implementation.event.ILCEvent
 
ILCFactory - Interface in hep.lcio.io
Factory to create LCWriter and Reader object for the known data formats, e.g.
ILCFloatVec - Class in hep.lcio.implementation.event
 
ILCFloatVec() - Constructor for class hep.lcio.implementation.event.ILCFloatVec
 
ILCGenericObject - Class in hep.lcio.implementation.event
Default Implementation of LCGenericObject.
ILCGenericObject() - Constructor for class hep.lcio.implementation.event.ILCGenericObject
Default C'tor - assumes fixedSize==false.
ILCGenericObject(int, int, int) - Constructor for class hep.lcio.implementation.event.ILCGenericObject
C'tor for fixed size objects
ILCIntVec - Class in hep.lcio.implementation.event
 
ILCIntVec() - Constructor for class hep.lcio.implementation.event.ILCIntVec
 
ILCParameters - Class in hep.lcio.implementation.event
Implementation of generic named parameters.
ILCParameters() - Constructor for class hep.lcio.implementation.event.ILCParameters
 
ILCRelation - Class in hep.lcio.implementation.event
Represents a single relationship
ILCRelation(LCObject, LCObject) - Constructor for class hep.lcio.implementation.event.ILCRelation
 
ILCRelation(LCObject, LCObject, float) - Constructor for class hep.lcio.implementation.event.ILCRelation
 
ILCRunHeader - Class in hep.lcio.implementation.event
A default implementation of LCRunHeader
ILCRunHeader() - Constructor for class hep.lcio.implementation.event.ILCRunHeader
 
ILCStrVec - Class in hep.lcio.implementation.event
 
ILCStrVec() - Constructor for class hep.lcio.implementation.event.ILCStrVec
 
IllConditionedOperatorException - Exception in org.apache.commons.math3.linear
An exception to be thrown when the condition number of a RealLinearOperator is too high.
IllConditionedOperatorException(double) - Constructor for exception org.apache.commons.math3.linear.IllConditionedOperatorException
Creates a new instance of this class.
IllinoisSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Illinois method for root-finding (approximating a zero of a univariate real function).
IllinoisSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
Construct a solver with default accuracy (1e-6).
IllinoisSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
Construct a solver.
IllinoisSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
Construct a solver.
IllinoisSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
Construct a solver.
im - Variable in class Jampack.Z
The imaginary part of Z.
im(Object) - Method in class org.nfunk.jep.function.Imaginary
 
im() - Method in class org.nfunk.jep.type.Complex
Returns the imaginary component of this object
imag() - Method in class jhplot.math.Complex
Imaginary part of this Complex number (the y-coordinate in rectangular coordinates).
IMAGE - Static variable in class jhplot.shapes.HShape
 
image - Variable in class jplot3dp.MathParser.Token
The string image of the token.
image - Variable in class org.nfunk.jep.Token
The string image of the token.
ImageEncoder - Interface in org.jfree.chart.encoders
Interface for abstracting different types of image encoders.
ImageEncoderFactory - Class in org.jfree.chart.encoders
Factory class for returning ImageEncoders for different ImageFormats.
ImageEncoderFactory() - Constructor for class org.jfree.chart.encoders.ImageEncoderFactory
 
ImageFormat - Interface in org.jfree.chart.encoders
Interface used for referencing different image formats.
ImageMapUtilities - Class in org.jfree.chart.imagemap
Collection of utility methods related to producing image maps.
ImageMapUtilities() - Constructor for class org.jfree.chart.imagemap.ImageMapUtilities
 
IMAGES - Static variable in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Constant for the type of rendering (images only).
ImageTitle - Class in org.jfree.chart.title
A chart title that displays an image.
ImageTitle(Image) - Constructor for class org.jfree.chart.title.ImageTitle
Creates a new image title.
ImageTitle(Image, RectangleEdge, HorizontalAlignment, VerticalAlignment) - Constructor for class org.jfree.chart.title.ImageTitle
Creates a new image title.
ImageTitle(Image, int, int, RectangleEdge, HorizontalAlignment, VerticalAlignment, RectangleInsets) - Constructor for class org.jfree.chart.title.ImageTitle
Creates a new image title with the given image scaled to the given width and height in the given location.
ImageType - Enum in jhplot.io.images
Enumerator for supported export plot file types.
Imaginary - Class in org.nfunk.jep.function
 
Imaginary() - Constructor for class org.nfunk.jep.function.Imaginary
 
IMCParticle - Class in hep.lcio.implementation.event
A default implementation of MCParticle.
IMCParticle() - Constructor for class hep.lcio.implementation.event.IMCParticle
 
importFileToGrid(String, SparseVectorGrid, int) - Static method in class org.jlab.groot.matrix.SparseGridIO
 
importHipo(String) - Static method in class org.jlab.groot.matrix.SparseGridIO
 
importText(int[], String, int[]) - Static method in class org.jlab.groot.matrix.SparseGridIO
 
inc - Static variable in class cern.jet.math.IntFunctions
Function that returns a++.
inc(long) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Increments the internal attributes of this segment by a number of segments.
inc() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Increments the internal attributes of this segment by one segment.
incompleteBeta(double, double, double) - Static method in class cern.jet.stat.Gamma
Returns the Incomplete Beta Function evaluated from zero to xx; formerly named ibeta.
incompleteBeta(double, double, double) - Static method in class jhplot.stat.Statistics
Returns the Incomplete Beta Function evaluated from zero to xx.
incompleteBetaFraction1(double, double, double) - Static method in class jhplot.stat.Statistics
Continued fraction expansion #1 for incomplete beta integral.
incompleteBetaFraction2(double, double, double) - Static method in class jhplot.stat.Statistics
Continued fraction expansion #2 for incomplete beta integral.
incompleteGamma(double, double) - Static method in class cern.jet.stat.Gamma
Returns the Incomplete Gamma function; formerly named igamma.
incompleteGammaComplement(double, double) - Static method in class cern.jet.stat.Gamma
Returns the Complemented Incomplete Gamma function; formerly named igamc.
InconsistentStateAt2PiWrapping() - Constructor for exception org.apache.commons.math3.geometry.spherical.oned.ArcsSet.InconsistentStateAt2PiWrapping
Simple constructor.
incr - Variable in class jplot3dp.ModelView.AxesDefinition
 
increment(int, int, double, double) - Static method in class jhplot.math.DoubleArray
Provides an mxn matrix.
increment(int, double, double) - Static method in class jhplot.math.DoubleArray
Provides a sequence of successive values in an array.
increment(int, int, double[], double[]) - Static method in class jhplot.math.DoubleArray
Generates an mxn matrix.
increment(double, double, double) - Static method in class jhplot.math.DoubleArray
Generates an array of successive values from begin to end with step size pitch.
increment() - Method in interface org.apache.commons.io.file.Counters.Counter
Adds one to this counter.
increment(double[]) - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
Increment the covariance matrix with one row of data.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
Add a new vector to the sample.
increment(double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
Add a new vector to the sample.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Updates the internal state of the statistic to reflect the addition of the new value.
increment(int) - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Performs multiple increments.
increment() - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Adds the increment value to the current iteration count.
incrementAll(double[]) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation just calls AbstractStorelessUnivariateStatistic.increment(double) in a loop over the input array.
incrementAll(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation just calls AbstractStorelessUnivariateStatistic.increment(double) in a loop over the specified portion of the input array.
incrementAll(double[]) - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect addition of all values in the values array.
incrementAll(double[], int, int) - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect addition of the values in the designated portion of the values array.
incrementalUpdate(DoubleArrayList, int, int, double[]) - Static method in class cern.jet.stat.Descriptive
Incrementally maintains and updates minimum, maximum, sum and sum of squares of a data sequence.
incrementalUpdateSumsOfPowers(DoubleArrayList, int, int, int, int, double[]) - Static method in class cern.jet.stat.Descriptive
Incrementally maintains and updates various sums of powers of the form Sum(data[i]k).
incrementalWeightedUpdate(DoubleArrayList, DoubleArrayList, int, int, double[]) - Static method in class cern.jet.stat.Descriptive
Incrementally maintains and updates sum and sum of squares of a weighted data sequence.
incrementBinContent(int) - Method in class org.jlab.groot.data.H1F
Increments the content in the specified bin by one.
incrementBinContent(int, double) - Method in class org.jlab.groot.data.H1F
Increments the content in the specified bin by the entered weight.
incrementCount(int) - Method in class org.apache.commons.math3.util.Incrementor
Deprecated.
Performs multiple increments.
incrementCount() - Method in class org.apache.commons.math3.util.Incrementor
Deprecated.
Adds one to the current iteration count.
incrementCount() - Method in class org.jfree.data.statistics.HistogramBin
Increments the item count.
incrementElement(int, int, double) - Method in class hep.physics.matrix.SymmetricMatrix
Increment a specific element
incrementElement(int, int, double) - Method in class hephysics.matrix.SymmetricMatrix
Increment a specific element
incrementExact(int) - Static method in class org.apache.commons.math3.util.FastMath
Increment a number, detecting overflows.
incrementExact(long) - Static method in class org.apache.commons.math3.util.FastMath
Increment a number, detecting overflows.
incrementIterationCount() - Method in class org.apache.commons.math3.util.IterationManager
Increments the iteration count by one, and throws an exception if the maximum number of iterations is reached.
Incrementor - Class in org.apache.commons.math3.util
Deprecated.
Incrementor() - Constructor for class org.apache.commons.math3.util.Incrementor
Deprecated.
Default constructor.
Incrementor(int) - Constructor for class org.apache.commons.math3.util.Incrementor
Deprecated.
Defines a maximal count.
Incrementor(int, Incrementor.MaxCountExceededCallback) - Constructor for class org.apache.commons.math3.util.Incrementor
Deprecated.
Defines a maximal count and a callback method to be triggered at counter exhaustion.
Incrementor.MaxCountExceededCallback - Interface in org.apache.commons.math3.util
Deprecated.
Defines a method to be called at counter exhaustion.
incrementValue(Comparable<?>, long) - Method in class org.apache.commons.math3.stat.Frequency
Increments the frequency count for v.
incrementValue(int, long) - Method in class org.apache.commons.math3.stat.Frequency
Increments the frequency count for v.
incrementValue(long, long) - Method in class org.apache.commons.math3.stat.Frequency
Increments the frequency count for v.
incrementValue(char, long) - Method in class org.apache.commons.math3.stat.Frequency
Increments the frequency count for v.
incrementValue(double, Comparable, Comparable) - Method in class org.jfree.data.category.DefaultCategoryDataset
Adds the specified value to an existing value in the dataset (if the existing value is null, it is treated as if it were 0.0).
INDENTIFIER1 - Static variable in interface org.nfunk.jep.ParserConstants
 
INDENTIFIER2 - Static variable in interface org.nfunk.jep.ParserConstants
 
IndeterminateMatrixException() - Constructor for exception hep.physics.matrix.MatrixOp.IndeterminateMatrixException
 
IndeterminateMatrixException() - Constructor for exception hephysics.matrix.MatrixOp.IndeterminateMatrixException
 
index(String) - Method in class org.freehep.math.minuit.MnApplication
convert name into external number of parameter
index(String) - Method in class org.freehep.math.minuit.MnUserParameterState
convert name into external number of parameter
INDEX - Static variable in class org.jfree.chart.util.XYCoordinateType
The (x, y) coordinates represent indices in a dataset.
IndexFunction - Interface in jhplot.math
BSD License
indexOf(boolean) - Method in class cern.colt.list.AbstractBooleanList
Returns the index of the first occurrence of the specified element.
indexOf(byte) - Method in class cern.colt.list.AbstractByteList
Returns the index of the first occurrence of the specified element.
indexOf(char) - Method in class cern.colt.list.AbstractCharList
Returns the index of the first occurrence of the specified element.
indexOf(double) - Method in class cern.colt.list.AbstractDoubleList
Returns the index of the first occurrence of the specified element.
indexOf(float) - Method in class cern.colt.list.AbstractFloatList
Returns the index of the first occurrence of the specified element.
indexOf(int) - Method in class cern.colt.list.AbstractIntList
Returns the index of the first occurrence of the specified element.
indexOf(long) - Method in class cern.colt.list.AbstractLongList
Returns the index of the first occurrence of the specified element.
indexOf(short) - Method in class cern.colt.list.AbstractShortList
Returns the index of the first occurrence of the specified element.
indexOf(Object, boolean) - Method in class cern.colt.list.ObjectArrayList
Returns the index of the first occurrence of the specified element.
indexOf(double, double) - Method in class jhplot.P1D
Searches the list front to back for the index of value, starting at offset.
indexOf(CategoryDataset) - Method in class org.jfree.chart.plot.CategoryPlot
Returns the index of the specified dataset, or -1 if the dataset does not belong to the plot.
indexOf(XYDataset) - Method in class org.jfree.chart.plot.PolarPlot
Returns the index of the specified dataset, or -1 if the dataset does not belong to the plot.
indexOf(XYDataset) - Method in class org.jfree.chart.plot.XYPlot
Returns the index of the specified dataset, or -1 if the dataset does not belong to the plot.
indexOf(Comparable) - Method in class org.jfree.data.ComparableObjectSeries
Returns the index of the item with the specified x-value, or a negative index if the series does not contain an item with that x-value.
indexOf(Comparable) - Method in class org.jfree.data.general.AbstractSeriesDataset
Returns the index of the named series, or -1.
indexOf(Comparable) - Method in interface org.jfree.data.general.SeriesDataset
Returns the index of the series with the specified key, or -1 if there is no such series in the dataset.
indexOf(TimeSeries) - Method in class org.jfree.data.time.TimeSeriesCollection
Returns the index of the specified series, or -1 if that series is not present in the dataset.
indexOf(Comparable) - Method in class org.jfree.data.xy.DefaultXYDataset
Returns the index of the series with the specified key, or -1 if there is no such series in the dataset.
indexOf(Comparable) - Method in class org.jfree.data.xy.DefaultXYZDataset
Returns the index of the series with the specified key, or -1 if there is no such series in the dataset.
indexOf(VectorSeries) - Method in class org.jfree.data.xy.VectorSeriesCollection
Returns the index of the specified series, or -1 if that series is not present in the dataset.
indexOf(Number) - Method in class org.jfree.data.xy.XYSeries
Returns the index of the item with the specified x-value, or a negative index if the series does not contain an item with that x-value.
indexOf(XYSeries) - Method in class org.jfree.data.xy.XYSeriesCollection
Returns the index of the specified series, or -1 if that series is not present in the dataset.
indexOfExtension(String) - Static method in class org.apache.commons.io.FilenameUtils
Returns the index of the last extension separator character, which is a dot.
indexOfFromTo(int, int, boolean) - Method in class cern.colt.bitvector.BitVector
Returns the index of the first occurrence of the specified state.
indexOfFromTo(boolean, int, int) - Method in class cern.colt.list.AbstractBooleanList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(byte, int, int) - Method in class cern.colt.list.AbstractByteList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(char, int, int) - Method in class cern.colt.list.AbstractCharList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(double, int, int) - Method in class cern.colt.list.AbstractDoubleList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(float, int, int) - Method in class cern.colt.list.AbstractFloatList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(int, int, int) - Method in class cern.colt.list.AbstractIntList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(long, int, int) - Method in class cern.colt.list.AbstractLongList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(short, int, int) - Method in class cern.colt.list.AbstractShortList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(boolean, int, int) - Method in class cern.colt.list.BooleanArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(byte, int, int) - Method in class cern.colt.list.ByteArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(char, int, int) - Method in class cern.colt.list.CharArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(double, int, int) - Method in class cern.colt.list.DoubleArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(float, int, int) - Method in class cern.colt.list.FloatArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(int, int, int) - Method in class cern.colt.list.IntArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(long, int, int) - Method in class cern.colt.list.LongArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(Object, int, int, boolean) - Method in class cern.colt.list.ObjectArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(short, int, int) - Method in class cern.colt.list.ShortArrayList
Returns the index of the first occurrence of the specified element.
indexOfLastSeparator(String) - Static method in class org.apache.commons.io.FilenameUtils
Returns the index of the last directory separator character.
indexOfX(double) - Method in class jhplot.P1D
Searches the list front to back for the index of value, starting at offset.
indexOfY(double) - Method in class jhplot.P1D
Searches for a Y value starting at offset.
IndexPlot - Static variable in class jhplot.HChart
 
indexX() - Method in interface org.jfree.data.contour.ContourDataset
Deprecated.
Returns an int array contain the index into the x values.
indexX() - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns an int array contain the index into the x values.
indexX(int) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Given index k, returns the column index containing k.
indexY(int) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Given index k, return the row index containing k.
indexZ(int, int) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Given column and row indices, returns the k index.
inducedPermutation(List<S>, List<S>) - Static method in class org.apache.commons.math3.genetics.RandomKey
Generates a representation of a permutation corresponding to a permutation which yields permutedData when applied to originalData.
inExceptionSegments() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns true if we are an exception segment.
inExcludeSegments() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns true if we are an excluded segment.
INF - Static variable in class org.apache.commons.math3.complex.Complex
A complex number representing "+INF + INFi"
INFINITE - Static variable in class org.apache.commons.math3.dfp.Dfp
Indicator value for Infinity.
INFINITE_WINDOW - Static variable in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Represents an infinite window size.
InfiniteCircularInputStream - Class in org.apache.commons.io.input
An InputStream that infinitely repeats the provided bytes.
InfiniteCircularInputStream(byte[]) - Constructor for class org.apache.commons.io.input.InfiniteCircularInputStream
Creates an instance from the specified array of bytes.
INFO - Static variable in class hep.lcio.util.ObjectComparator
 
info() - Method in class hephysics.jet.JetN2
Return information about the jet setting.
INFO - Static variable in class org.jfree.chart.JFreeChart
Information about the project.
iniData(H1D, String) - Method in class fitter.Fitter
 
iniData(P1D, String) - Method in class fitter.Fitter
 
INIFILE - Static variable in class jhepsim.SetEnv
 
INIFILE - Static variable in class jminhep.gui.SetEnv
 
iniFunc() - Method in class fitter.Fitter
 
inIncludeSegments() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns true if we are an included segment and we are not an exception.
init() - Static method in class jhepsim.Options
Initializes this service with attempting to load the parameter file.
init() - Static method in class jhepsim.SetEnv
 
init(String) - Method in class jhplot.FNon
 
init() - Static method in class jhplot.JHPlot
Initialization.
init() - Method in class jhplot.stat.limit.LimitCalculatorGui
 
init() - Static method in class jminhep.clcontrol.Global
 
init() - Static method in class jminhep.gui.SetEnv
 
init(String) - Static method in class jminhep.utils.ResourceLoader
 
init() - Method in class jplot3dp.UVModeller
 
init(Tailer) - Method in interface org.apache.commons.io.input.TailerListener
The tailer will call this method during construction, giving the listener a method of stopping the tailer.
init(Tailer) - Method in class org.apache.commons.io.input.TailerListenerAdapter
The tailer will call this method during construction, giving the listener a method of stopping the tailer.
init(FieldODEStateAndDerivative<T>, T) - Method in class org.apache.commons.math3.ode.ContinuousOutputFieldModel
Initialize step handler at the start of an ODE integration.
init(double, double[], double) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Initialize step handler at the start of an ODE integration.
init(double, double[], double) - Method in class org.apache.commons.math3.ode.events.EventFilter
Initialize event handler at the start of an ODE integration.
init(double, double[], double) - Method in interface org.apache.commons.math3.ode.events.EventHandler
Initialize event handler at the start of an ODE integration.
init(FieldODEStateAndDerivative<T>, T) - Method in interface org.apache.commons.math3.ode.events.FieldEventHandler
Initialize event handler at the start of an ODE integration.
init(T, T[], T) - Method in class org.apache.commons.math3.ode.FieldExpandableODE
Initialize equations at the start of an ODE integration.
init(T, T[], T[], T) - Method in interface org.apache.commons.math3.ode.FieldSecondaryEquations
Initialize equations at the start of an ODE integration.
init(T, T[], T) - Method in interface org.apache.commons.math3.ode.FirstOrderFieldDifferentialEquations
Initialize equations at the start of an ODE integration.
init(double, double[], double) - Method in class org.apache.commons.math3.ode.sampling.DummyStepHandler
Initialize step handler at the start of an ODE integration.
init(FieldODEStateAndDerivative<T>, T) - Method in interface org.apache.commons.math3.ode.sampling.FieldFixedStepHandler
Initialize step handler at the start of an ODE integration.
init(FieldODEStateAndDerivative<T>, T) - Method in interface org.apache.commons.math3.ode.sampling.FieldStepHandler
Initialize step handler at the start of an ODE integration.
init(FieldODEStateAndDerivative<T>, T) - Method in class org.apache.commons.math3.ode.sampling.FieldStepNormalizer
Initialize step handler at the start of an ODE integration.
init(double, double[], double) - Method in interface org.apache.commons.math3.ode.sampling.FixedStepHandler
Initialize step handler at the start of an ODE integration.
init(double, double[], double) - Method in interface org.apache.commons.math3.ode.sampling.StepHandler
Initialize step handler at the start of an ODE integration.
init(double, double[], double) - Method in class org.apache.commons.math3.ode.sampling.StepNormalizer
Initialize step handler at the start of an ODE integration.
init() - Method in class org.jfree.chart.servlet.DisplayChart
Init method.
init(List<Double>) - Method in class org.jlab.groot.graphics.GraphicsAxis.GraphicsAxisTicks
 
init(TreeProvider) - Method in class org.jlab.groot.studio.StudioUI
 
init() - Method in class org.lsmp.djepExamples.Console
Applet initialization
init() - Method in class org.lsmp.djepExamples.DJepApplet
Applet initialisation
init() - Method in class org.nfunk.jepexamples.Evaluator
The initialization function of the applet.
init() - Method in class org.nfunk.jepexamples.Fractal
Initializes the applet Fractal
init() - Method in class org.nfunk.jepexamples.FunctionPlotter
Initializes the applet FunctionPlotter
initAttributes() - Method in class org.jlab.groot.data.H1F
 
initBranches(String[]) - Method in class org.jlab.groot.tree.TreeTextFile
 
initColorMap() - Static method in class org.jlab.groot.base.ColorPalette
 
initDatasets() - Method in class org.jlab.groot.tree.DatasetDescriptor
 
initFunTab() - Method in class org.nfunk.jep.JEP
Creates a new FunctionTable object as funTab.
InitialGuess - Class in org.apache.commons.math3.optim
Starting point (first guess) of the optimization procedure.
InitialGuess(double[]) - Constructor for class org.apache.commons.math3.optim.InitialGuess
 
InitialGuess - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
InitialGuess(double[]) - Constructor for class org.apache.commons.math3.optimization.InitialGuess
Deprecated.
 
initialise(Graphics2D, Rectangle2D, PiePlot, Integer, PlotRenderingInfo) - Method in class org.jfree.chart.plot.PiePlot
Initialises the drawing procedure.
initialise(Graphics2D, Rectangle2D, PiePlot, Integer, PlotRenderingInfo) - Method in class org.jfree.chart.plot.RingPlot
Initialises the plot state (which will store the total of all dataset values, among other things).
initialise(Graphics2D, Rectangle2D, CategoryPlot, int, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Initialises the renderer and returns a state object that will be used for the remainder of the drawing process for a single chart.
initialise(Graphics2D, Rectangle2D, CategoryPlot, int, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.category.BarRenderer
Initialises the renderer and returns a state object that will be passed to subsequent calls to the drawItem method.
initialise(Graphics2D, Rectangle2D, CategoryPlot, int, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Initialises the renderer and returns a state object that will be passed to subsequent calls to the drawItem method.
initialise(Graphics2D, Rectangle2D, CategoryPlot, int, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Initialises the renderer.
initialise(Graphics2D, Rectangle2D, CategoryPlot, int, PlotRenderingInfo) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Initialises the renderer.
initialise(Graphics2D, Rectangle2D, CategoryPlot, int, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.category.LevelRenderer
Initialises the renderer and returns a state object that will be passed to subsequent calls to the drawItem method.
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Initialises the renderer and returns a state object that should be passed to all subsequent calls to the drawItem() method.
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Initialises the renderer then returns the number of 'passes' through the data that the renderer will require (usually just one).
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.DeviationRenderer
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.SamplingXYLineRenderer
Initialises the renderer.
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Initialises the renderer.
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.StackedXYBarRenderer
Initialises the renderer and returns a state object that should be passed to all subsequent calls to the drawItem() method.
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Initialises the renderer.
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Initialises the renderer and returns a state object that should be passed to all subsequent calls to the drawItem() method.
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Initialises the renderer and returns a state object that should be passed to all subsequent calls to the drawItem() method.
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Initialises the renderer and returns a state object that should be passed to subsequent calls to the drawItem() method.
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Initialises the renderer then returns the number of 'passes' through the data that the renderer will require (usually just one).
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Initialises the renderer.
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.XYSplineRenderer
Initialises the renderer.
initialise(Graphics2D, Rectangle2D, XYPlot, XYDataset, PlotRenderingInfo) - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Initialises the renderer.
initialise() - Method in class org.lsmp.djepExamples.Console
sets up all the needed objects.
initialise() - Method in class org.lsmp.djepExamples.DJepApplet
sets up all the needed objects.
initialise() - Method in class org.lsmp.djepExamples.DJepConsole
 
initialise() - Method in class org.lsmp.djepExamples.GroupConsole
 
initialise(Group) - Method in class org.lsmp.djepExamples.GroupConsole
 
initialise() - Method in class org.lsmp.djepExamples.JamaConsole
 
initialise() - Method in class org.lsmp.djepExamples.MatrixConsole
 
initialise() - Method in class org.lsmp.djepExamples.ObserverConsole
 
initialise() - Method in class org.lsmp.djepExamples.SJepConsole
 
initialise() - Method in class org.lsmp.djepExamples.VectorConsole
 
initialise() - Method in class org.lsmp.djepExamples.XJepConsole
 
initializationPerformed(IterationEvent) - Method in interface org.apache.commons.math3.util.IterationListener
Invoked after completion of the initial phase of the iterative algorithm (prior to the main iteration loop).
initialize() - Method in interface jhplot.math.num.IterativeMethod.IterativeState
Initialize the state to begin an iterative evaluation.
initialize() - Method in class org.apache.commons.io.monitor.FileAlterationObserver
Initializes the observer.
initialize() - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Called to initialize the palette's color indexes
initialize() - Method in class org.jfree.chart.plot.GreyPalette
Deprecated.
Intializes the palette's indices.
initialize() - Method in class org.jfree.chart.plot.RainbowPalette
Deprecated.
Intializes the palettes indexes
initialize(Object[], Object[], Object[]) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Initialises the dataset.
initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in interface org.apache.commons.math3.ode.MultistepIntegrator.NordsieckTransformer
Deprecated.
Initialize the high order scaled derivatives at step start.
initializeHighOrderDerivatives(T, T[], T[][], T[][]) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckFieldTransformer
Initialize the high order scaled derivatives at step start.
initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
Initialize the high order scaled derivatives at step start.
initializeStep(boolean, int, T[], FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
Initialize the integration step.
initializeStep(boolean, int, double[], double, double[], double[], double[], double[]) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Initialize the integration step.
initMouse() - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
initSymTab() - Method in class org.nfunk.jep.JEP
Creates a new SymbolTable object as symTab.
initSystemFonts() - Static method in class org.jlab.groot.base.FontProperties
 
initTimer(int) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
initTreeIcons() - Static method in class org.jlab.groot.tree.Tree
initializes UI
initUI() - Method in class org.jlab.groot.graphics.EmbeddedPad.EmbeddedPadConfigurationPane
 
inportTextFill(String[], int[], double[], double[], String, int) - Static method in class org.jlab.groot.matrix.SparseGridIO
 
input_file - Static variable in class jminhep.gui.Main
 
inputLoop() - Method in class org.lsmp.djepExamples.Console
The main input loop for interactive operation.
insert(String, Object) - Method in class jhplot.io.HDataBase
Insert an object with a key
insert(double[], int, double...) - Static method in class jhplot.math.DoubleArray
Insert any number of values, or a single array, between 2 elements of an array.
insert(int[], int, int...) - Static method in class jhplot.math.IntegerArray
 
insert(int[], int, int) - Static method in class jminhep.utils.ArrayOps
#10 Insert val into nums at the specified index.
insert(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Deprecated.
Insert an element in the tree.
insertColumn(int[][], int[], int) - Static method in class jhplot.math.IntegerArray
 
insertColumns(double[][], int, double[]...) - Static method in class jhplot.math.DoubleArray
Insert any number of arrays between 2 columns of a matrix.
insertColumns(int[][], int[][], int) - Static method in class jhplot.math.IntegerArray
 
insertCut(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Insert a cut sub-hyperplane in a node.
insertData(int, DataArray) - Method in class jplot.JPlot
 
insertDatafile(File) - Method in class jplot.JPlot
 
insertDataReader(BufferedReader, LinePars) - Method in class jplot.JPlot
 
insertEquationData(double[], double[]) - Method in class org.apache.commons.math3.ode.EquationsMapper
Insert equation data into a complete state or derivative array.
insertEquationData(int, T[], T[]) - Method in class org.apache.commons.math3.ode.FieldEquationsMapper
Insert equation data into a complete state or derivative array.
insertInTree(BSPTree<S>, boolean) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
insertInTree(BSPTree<S>, boolean, BSPTree.VanishingCutHandler<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Insert the instance into another tree.
insertRecord(RecordWriter) - Method in class jhplot.io.db.BaseRecordsFile
Adds the given record to the database.
insertRow(int[][], int[], int) - Static method in class jhplot.math.IntegerArray
 
insertRows(double[][], int, double[]...) - Static method in class jhplot.math.DoubleArray
Insert any number of arrays between 2 rows of a matrix.
insertRows(int[][], int[][], int) - Static method in class jhplot.math.IntegerArray
 
insertValue(int, Comparable, double) - Method in class org.jfree.data.DefaultKeyedValues
Inserts a new value at the specified position in the dataset or, if there is an existing item with the specified key, updates the value for that item and moves it to the specified position.
insertValue(int, Comparable, Number) - Method in class org.jfree.data.DefaultKeyedValues
Inserts a new value at the specified position in the dataset or, if there is an existing item with the specified key, updates the value for that item and moves it to the specified position.
insertValue(int, Comparable, double) - Method in class org.jfree.data.general.DefaultPieDataset
Inserts a new value at the specified position in the dataset or, if there is an existing item with the specified key, updates the value for that item and moves it to the specified position.
insertValue(int, Comparable, Number) - Method in class org.jfree.data.general.DefaultPieDataset
Inserts a new value at the specified position in the dataset or, if there is an existing item with the specified key, updates the value for that item and moves it to the specified position.
insertValue(int, Comparable, Object) - Method in class org.jfree.data.KeyedObjects
Inserts a new value at the specified position in the dataset or, if there is an existing item with the specified key, updates the value for that item and moves it to the specified position.
INSIDE1 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE1.
INSIDE10 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE10.
INSIDE11 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE11.
INSIDE12 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE12.
INSIDE2 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE2.
INSIDE3 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE3.
INSIDE4 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE4.
INSIDE5 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE5.
INSIDE6 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE6.
INSIDE7 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE7.
INSIDE8 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE8.
INSIDE9 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
INSIDE9.
inSort(double[]) - Static method in class jminhep.utils.VEC
Method to sort a double vector, by inefficient straight insertion See section 8.1, p.
installUI(JComponent) - Method in class net.java.dev.colorchooser.ColorChooserUI
 
instance() - Static method in class hep.lcio.util.CommandLineTool
Get an instance of CommandLineTool.
INSTANCE - Static variable in class org.apache.commons.io.filefilter.DirectoryFileFilter
Singleton instance of directory filter.
INSTANCE - Static variable in class org.apache.commons.io.filefilter.FalseFileFilter
Singleton instance of false filter.
INSTANCE - Static variable in class org.apache.commons.io.filefilter.TrueFileFilter
Singleton instance of true filter.
INSTANCE - Static variable in class org.apache.commons.io.output.NullAppendable
A singleton.
InsufficientDataException - Exception in org.apache.commons.math3.exception
Exception to be thrown when there is insufficient data to perform a computation.
InsufficientDataException() - Constructor for exception org.apache.commons.math3.exception.InsufficientDataException
Construct the exception.
InsufficientDataException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.InsufficientDataException
Construct the exception with a specific context.
int2double(int[][]) - Static method in class jhplot.math.IntegerArray
 
int2double(int[]) - Static method in class jhplot.math.IntegerArray
 
IntArrayList - Class in cern.colt.list
Resizable list holding int elements; implemented with arrays.
IntArrayList() - Constructor for class cern.colt.list.IntArrayList
Constructs an empty list.
IntArrayList(int[]) - Constructor for class cern.colt.list.IntArrayList
Constructs a list containing the specified elements.
IntArrayList(int) - Constructor for class cern.colt.list.IntArrayList
Constructs an empty list with the specified initial capacity.
intAsUnsigned(int) - Static method in class net.jafama.NumbersUtils
 
IntBuffer - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target IntBufferConsumer to which data is automatically flushed upon buffer overflow.
IntBuffer(IntBufferConsumer, int) - Constructor for class cern.colt.buffer.IntBuffer
Constructs and returns a new buffer with the given target.
IntBuffer2D - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target IntBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
IntBuffer2D(IntBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.IntBuffer2D
Constructs and returns a new buffer with the given target.
IntBuffer2DConsumer - Interface in cern.colt.buffer
Target of a streaming IntBuffer2D into which data is flushed upon buffer overflow.
IntBuffer3D - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target IntBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
IntBuffer3D(IntBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.IntBuffer3D
Constructs and returns a new buffer with the given target.
IntBuffer3DConsumer - Interface in cern.colt.buffer
Target of a streaming IntBuffer3D into which data is flushed upon buffer overflow.
IntBufferConsumer - Interface in cern.colt.buffer
Target of a streaming IntBuffer into which data is flushed upon buffer overflow.
IntComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
IntDoubleFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes two arguments.
IntDoubleProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
INTEGER_LITERAL - Static variable in interface org.nfunk.jep.ParserConstants
 
IntegerArray - Class in jhplot.math
BSD License
IntegerArray() - Constructor for class jhplot.math.IntegerArray
 
IntegerDistribution - Interface in org.apache.commons.math3.distribution
Interface for distributions on the integers.
Integers - Class in org.lsmp.djep.groupJep.groups
The group of integers, implemented as a BigInteger.
Integers() - Constructor for class org.lsmp.djep.groupJep.groups.Integers
Operations on the reals (Implemented as BigInteger).
IntegerSequence - Class in org.apache.commons.math3.util
Provides a sequence of integers.
IntegerSequence.Incrementor - Class in org.apache.commons.math3.util
Utility that increments a counter until a maximum is reached, at which point, the instance will by default throw a MaxCountExceededException.
IntegerSequence.Incrementor.MaxCountExceededCallback - Interface in org.apache.commons.math3.util
Defines a method to be called at counter exhaustion.
IntegerSequence.Range - Class in org.apache.commons.math3.util
Generates a sequence of integers.
integral() - Method in class jhplot.F1D
Integral using fastest trapezium rule method.
integral(double, double) - Method in class jhplot.F1D
Integral using fastest trapezium rule method.
integral(String, int, double, double) - Method in class jhplot.F1D
Numerical integration.
integral(int, double, double) - Method in class jhplot.F1D
Numerical integration using trapezium rule.
integral(int, double, double, double, double) - Method in class jhplot.F2D
Numerical integration using trapezium rule.
integral(double, double, double, double) - Method in class jhplot.F2D
Integral using fastest trapezium rule method.
integral() - Method in class jhplot.F2D
Integral using fastest trapezium rule method.
integral(int, int, double, double, double, double) - Method in class jhplot.F2D
Finds the volume under the surface described by the function f(x, y) for a <= x <= b, c <= y <= d.
integral() - Method in class jhplot.H1D
Sum of all heights
integral(int, int, boolean) - Method in class jhplot.H1D
Integrate a histogram between two bin indices (between 1 and max number) The integral is computed as the sum of bin contents in the range if the last parameter is false.
integral(int, int) - Method in class jhplot.H1D
Integrate a histogram between two bin indices (between 1 and max number) By default the integral is computed as the sum of bin contents in the range.
integral(int, int, int, int) - Method in class jhplot.H2D
Integrate histogram between two indices.
integral(int, int, int, int, boolean) - Method in class jhplot.H2D
Integrate histogram between two indices.
integral(int, int) - Method in class jhplot.P1D
Integrate P1D between two indices (between 1 and max index)
integral() - Method in class jhplot.P1D
Integrate P1D (sum up all Y values)
integral() - Method in class org.jlab.groot.data.H1F
 
integral(int, int) - Method in class org.jlab.groot.data.H1F
 
integral(int) - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
IntegralDomainI - Interface in org.lsmp.djep.groupJep.interfaces
A RingI which has a multiplicative indentity.
integralRange(double, double, double, double, boolean) - Method in class jhplot.H2D
Integrate histogram in the range.
integralRegion(double, double, boolean) - Method in class jhplot.H1D
Integrate histogram in a region between Xmin and Xmax.
integralRegion(double, double) - Method in class jhplot.H1D
Integrate histogram in a region between Xmin and Xmax.
integrate(double, double) - Method in class jhplot.math.num.integration.AdaptiveIntegrator
Evaluate the definite integral from a to b.
integrate(double, double) - Method in class jhplot.math.num.integration.RombergIntegrator
Evaluate the definite integral from a to b.
integrate(double, double) - Method in class jhplot.math.num.integration.SimpsonsIntegrator
Evaluate the definite integral from a to b.
integrate(double, double) - Method in class jhplot.math.num.integration.TrapezoidalIntegrator
Evaluate the definite integral from a to b.
integrate(int, UnivariateFunction, double, double) - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Integrate the function in the given interval.
integrate(UnivariateFunction) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegrator
Returns an estimate of the integral of f(x) * w(x), where w is a weight function that depends on the actual flavor of the Gauss integration scheme.
integrate(UnivariateFunction) - Method in class org.apache.commons.math3.analysis.integration.gauss.SymmetricGaussIntegrator
Returns an estimate of the integral of f(x) * w(x), where w is a weight function that depends on the actual flavor of the Gauss integration scheme.
integrate(int, UnivariateFunction, double, double) - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Integrate the function in the given interval.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Integrate the differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Integrate a set of differential equations up to the given time.
integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Integrate the differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in interface org.apache.commons.math3.ode.FirstOrderIntegrator
Integrate the differential equations up to the given time.
integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsBashforthFieldIntegrator
Integrate the differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsBashforthIntegrator
Integrate a set of differential equations up to the given time.
integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsFieldIntegrator
Integrate the differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
Integrate a set of differential equations up to the given time.
integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsMoultonFieldIntegrator
Integrate the differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsMoultonIntegrator
Integrate a set of differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Integrate a set of differential equations up to the given time.
integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Integrate the differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Integrate a set of differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Integrate a set of differential equations up to the given time.
integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.apache.commons.math3.ode.nonstiff.RungeKuttaFieldIntegrator
Integrate the differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.RungeKuttaIntegrator
Integrate a set of differential equations up to the given time.
integrate(SecondOrderDifferentialEquations, double, double[], double[], double, double[], double[]) - Method in interface org.apache.commons.math3.ode.SecondOrderIntegrator
Integrate the differential equations up to the given time
INTERMEDIATE - Static variable in interface hep.physics.particle.Particle
 
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.AkimaSplineInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolator
Deprecated.
Compute an interpolating function for the dataset.
interpolate(double[], double[], double[][]) - Method in interface org.apache.commons.math3.analysis.interpolation.BivariateGridInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.DividedDifferenceInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LinearInterpolator
Computes a linear interpolating function for the data set.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Compute an interpolating function by performing a loess fit on the data at the original abscissae and then building a cubic spline with a SplineInterpolator on the resulting fit.
interpolate(double[][], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
Deprecated.
Computes an interpolating function for the data set.
interpolate(double[][], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.MicrosphereProjectionInterpolator
Computes an interpolating function for the data set.
interpolate(double[][], double[]) - Method in interface org.apache.commons.math3.analysis.interpolation.MultivariateInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.NevilleInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math3.analysis.interpolation.PiecewiseBicubicSplineInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
Deprecated.
Compute an interpolating function for the dataset.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.SplineInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[], double[], double[][][]) - Method in class org.apache.commons.math3.analysis.interpolation.TricubicInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[], double[], double[][][]) - Method in class org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolator
Deprecated.
Compute an interpolating function for the dataset.
interpolate(double[], double[], double[], double[][][]) - Method in interface org.apache.commons.math3.analysis.interpolation.TrivariateGridInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[]) - Method in interface org.apache.commons.math3.analysis.interpolation.UnivariateInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.UnivariatePeriodicInterpolator
Compute an interpolating function for the dataset.
InterpolatingMicrosphere - Class in org.apache.commons.math3.analysis.interpolation
Utility class for the MicrosphereProjectionInterpolator algorithm.
InterpolatingMicrosphere(int, int, double, double, double, UnitSphereRandomVectorGenerator) - Constructor for class org.apache.commons.math3.analysis.interpolation.InterpolatingMicrosphere
Create a sphere from randomly sampled vectors.
InterpolatingMicrosphere2D - Class in org.apache.commons.math3.analysis.interpolation
Utility class for the MicrosphereProjectionInterpolator algorithm.
InterpolatingMicrosphere2D(int, double, double, double) - Constructor for class org.apache.commons.math3.analysis.interpolation.InterpolatingMicrosphere2D
Create a sphere from vectors regularly sampled around a circle.
interrupted - Variable in class jplot3d.JSurface
 
intersect(long, long) - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Returns a segment that is the intersection of this segment and the interval.
intersection(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get the intersection point of the instance and another line.
intersection(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the intersection of a line with the instance.
intersection(Plane) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build the line shared by the instance and another plane.
intersection(Plane, Plane, Plane) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the intersection point of three planes.
intersection(SubLine, boolean) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubLine
Get the intersection of the instance and another sub-line.
intersection(Line) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the intersection point of the instance and another line.
intersection(SubLine, boolean) - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Get the intersection of the instance and another sub-line.
intersection(SubHyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Get the parts of a sub-hyperplane that are contained in the region.
intersection(SubHyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Get the parts of a sub-hyperplane that are contained in the region.
intersection(Region<S>, Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Compute the intersection of two regions.
intersects(double, double) - Method in class org.jfree.data.Range
Returns true if the range intersects with the specified range, and false otherwise.
intersects(Range) - Method in class org.jfree.data.Range
Returns true if the range intersects with the specified range, and false otherwise.
Interval - Class in org.apache.commons.math3.geometry.euclidean.oned
This class represents a 1D interval.
Interval(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Interval
Simple constructor.
IntervalBarRenderer - Class in org.jfree.chart.renderer.category
A renderer that handles the drawing of bars for a bar plot where each bar has a high and low value.
IntervalBarRenderer() - Constructor for class org.jfree.chart.renderer.category.IntervalBarRenderer
Constructs a new renderer.
IntervalCategoryDataset - Interface in org.jfree.data.category
A category dataset that defines a value range for each series/category combination.
IntervalCategoryItemLabelGenerator - Class in org.jfree.chart.labels
A label generator for plots that use data from an IntervalCategoryDataset.
IntervalCategoryItemLabelGenerator() - Constructor for class org.jfree.chart.labels.IntervalCategoryItemLabelGenerator
Creates a new generator with a default number formatter.
IntervalCategoryItemLabelGenerator(String, NumberFormat) - Constructor for class org.jfree.chart.labels.IntervalCategoryItemLabelGenerator
Creates a new generator with the specified number formatter.
IntervalCategoryItemLabelGenerator(String, DateFormat) - Constructor for class org.jfree.chart.labels.IntervalCategoryItemLabelGenerator
Creates a new generator with the specified date formatter.
IntervalCategoryToolTipGenerator - Class in org.jfree.chart.labels
A tooltip generator for plots that use data from an IntervalCategoryDataset.
IntervalCategoryToolTipGenerator() - Constructor for class org.jfree.chart.labels.IntervalCategoryToolTipGenerator
Creates a new generator with a default number formatter.
IntervalCategoryToolTipGenerator(String, NumberFormat) - Constructor for class org.jfree.chart.labels.IntervalCategoryToolTipGenerator
Creates a new generator with the specified number formatter.
IntervalCategoryToolTipGenerator(String, DateFormat) - Constructor for class org.jfree.chart.labels.IntervalCategoryToolTipGenerator
Creates a new generator with the specified date formatter.
IntervalMarker - Class in org.jfree.chart.plot
Represents an interval to be highlighted in some way.
IntervalMarker(double, double) - Constructor for class org.jfree.chart.plot.IntervalMarker
Constructs an interval marker.
IntervalMarker(double, double, Paint) - Constructor for class org.jfree.chart.plot.IntervalMarker
Creates a new interval marker with the specified range and fill paint.
IntervalMarker(double, double, Paint, Stroke, Paint, Stroke, float) - Constructor for class org.jfree.chart.plot.IntervalMarker
Constructs an interval marker.
IntervalsSet - Class in org.apache.commons.math3.geometry.euclidean.oned
This class represents a 1D region: a set of intervals.
IntervalsSet(double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build an intervals set representing the whole real line.
IntervalsSet(double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build an intervals set corresponding to a single interval.
IntervalsSet(BSPTree<Euclidean1D>, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build an intervals set from an inside/outside BSP tree.
IntervalsSet(Collection<SubHyperplane<Euclidean1D>>, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build an intervals set from a Boundary REPresentation (B-rep).
IntervalsSet() - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Deprecated.
as of 3.1 replaced with IntervalsSet.IntervalsSet(double)
IntervalsSet(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Deprecated.
IntervalsSet(BSPTree<Euclidean1D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Deprecated.
IntervalsSet(Collection<SubHyperplane<Euclidean1D>>) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Deprecated.
IntervalUtils - Class in org.apache.commons.math3.stat.interval
Factory methods to generate confidence intervals for a binomial proportion.
IntervalXYDataset - Interface in org.jfree.data.xy
An extension of the XYDataset interface that allows an x-interval and a y-interval to be defined.
IntervalXYDelegate - Class in org.jfree.data.xy
A delegate that handles the specification or automatic calculation of the interval surrounding the x-values in a dataset.
IntervalXYDelegate(XYDataset) - Constructor for class org.jfree.data.xy.IntervalXYDelegate
Creates a new delegate that.
IntervalXYDelegate(XYDataset, boolean) - Constructor for class org.jfree.data.xy.IntervalXYDelegate
Creates a new delegate for the specified dataset.
IntervalXYItemLabelGenerator - Class in org.jfree.chart.labels
An item label generator for datasets that implement the IntervalXYDataset interface.
IntervalXYItemLabelGenerator() - Constructor for class org.jfree.chart.labels.IntervalXYItemLabelGenerator
Creates an item label generator using default number formatters.
IntervalXYItemLabelGenerator(String, NumberFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.IntervalXYItemLabelGenerator
Creates an item label generator using the specified number formatters.
IntervalXYItemLabelGenerator(String, DateFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.IntervalXYItemLabelGenerator
Creates an item label generator using the specified formatters.
IntervalXYItemLabelGenerator(String, NumberFormat, DateFormat) - Constructor for class org.jfree.chart.labels.IntervalXYItemLabelGenerator
Creates an item label generator using the specified formatters (a number formatter for the x-values and a date formatter for the y-values).
IntervalXYItemLabelGenerator(String, DateFormat, DateFormat) - Constructor for class org.jfree.chart.labels.IntervalXYItemLabelGenerator
Creates a label generator using the specified date formatters.
IntervalXYZDataset - Interface in org.jfree.data.xy
An extension of the XYZDataset interface that allows a range of data to be defined for any of the X values, the Y values, and the Z values.
IntFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes a single argument and returns a single value.
IntFunctions - Class in cern.jet.math
Integer Function objects to be passed to generic methods.
intFunctions - Static variable in class cern.jet.math.IntFunctions
Little trick to allow for "aliasing", that is, renaming this class.
intHash(long) - Static method in class net.jafama.NumbersUtils
If the specified value is in int range, the returned value is identical.
IntIntDoubleFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes three arguments.
IntIntDoubleProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes three arguments and does not return a value.
IntIntFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes two arguments and returns a single value.
IntIntIntProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes three arguments and does not return a value.
IntIntProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
IntListAdapter - Class in cern.colt.list.adapter
Adapter that permits an AbstractIntList to be viewed and treated as a JDK 1.2 AbstractList.
IntListAdapter(AbstractIntList) - Constructor for class cern.colt.list.adapter.IntListAdapter
Constructs a list backed by the specified content list.
intLog10() - Method in class org.apache.commons.math3.dfp.Dfp
Get the exponent of the greatest power of 10 that is less than or equal to abs(this).
intMaskLSBits0(int) - Static method in class net.jafama.NumbersUtils
 
intMaskLSBits1(int) - Static method in class net.jafama.NumbersUtils
 
intMaskMSBits0(int) - Static method in class net.jafama.NumbersUtils
 
intMaskMSBits1(int) - Static method in class net.jafama.NumbersUtils
 
IntObjectProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
IntProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
intValue() - Method in class org.apache.commons.math3.dfp.Dfp
Convert this to an integer.
intValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as an int.
intValue() - Method in class org.apache.commons.math3.fraction.Fraction
Gets the fraction as an int.
intValue() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation performs casting to a int.
intValue() - Method in class org.lsmp.djep.groupJep.groups.Quaternions.Quaternion
 
intValue() - Method in class org.lsmp.djep.groupJep.values.Permutation
 
intValue() - Method in class org.lsmp.djep.groupJep.values.Polynomial
value of constant coeff.
intValue() - Method in class org.lsmp.djep.groupJep.values.Rational
 
intValue() - Method in class org.lsmp.djep.sjep.PConstant
 
intValue() - Method in class org.lsmp.djep.vectorJep.values.Scaler
value of constant coeff.
intValue(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
Returns the int value represented by node
intValue() - Method in class org.nfunk.jep.type.Complex
Returns real part.
IntWrapper - Class in net.jafama
 
IntWrapper() - Constructor for class net.jafama.IntWrapper
 
inv - Static variable in class cern.jet.math.Functions
Function that returns 1.0 / a.
Inv - Class in Jampack
Inv computes the inverse of a matrix.
Inv() - Constructor for class Jampack.Inv
 
inv_center_reduce(double[]) - Method in class jhplot.stat.PCA
 
inv_center_reduce(double[][]) - Method in class jhplot.stat.PCA
 
invalidate() - Static method in class jplot3d.SurfaceVertex
Invalidates all vertices.
invalidateAll() - Method in class org.lsmp.djep.djep.DVariable
makes value and values of all derivatives invalid.
invalidateRangeInfo() - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Invalidates the range info.
InvalidMatrixException(String) - Constructor for exception hep.physics.matrix.MatrixOp.InvalidMatrixException
 
InvalidMatrixException(String) - Constructor for exception hephysics.matrix.MatrixOp.InvalidMatrixException
 
InvalidRepresentationException - Exception in org.apache.commons.math3.genetics
Exception indicating that the representation of a chromosome is not valid.
InvalidRepresentationException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.genetics.InvalidRepresentationException
Construct an InvalidRepresentationException with a specialized message.
invariantMass() - Method in class hephysics.vec.HepLorentzVector
Same as m().
invariantMass2() - Method in class hephysics.vec.HepLorentzVector
Same as m2().
inverse(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the inverse or pseudo-inverse of matrix A.
inverse(Matrix, MutableMatrix) - Static method in class hep.physics.matrix.MatrixOp
Invert matrix mIn and write it to matrix mOut.
inverse(Matrix) - Static method in class hep.physics.matrix.MatrixOp
Convenience method to invert a matrix in one step.
inverse(Hep3Matrix) - Static method in class hep.physics.vec.VecOp
 
inverse(Matrix, MutableMatrix) - Static method in class hephysics.matrix.MatrixOp
Invert matrix mIn and write it to matrix mOut.
inverse(Hep3Matrix) - Static method in class hephysics.vec.VecOp
 
inverse() - Method in class j4np.physics.TransMatrix
 
inverse() - Method in class Jama.Matrix
Matrix inverse or pseudoinverse
inverse() - Method in class jhplot.math.kalman.jama.Matrix
Matrix inverse or pseudoinverse
inverse(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
inverse(int[]) - Static method in class jhplot.math.SortUtils
Compute inverse permutation
inverse() - Method in class jhplot.math.ValueErr
Returns the inverse (1/a) of a ValueErr number
inverse(ValueErr) - Method in class jhplot.math.ValueErr
Returns the reciprocal (1/a) of a ValueErr number (a)
Inverse - Class in org.apache.commons.math3.analysis.function
Inverse function.
Inverse() - Constructor for class org.apache.commons.math3.analysis.function.Inverse
 
inverse() - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Computes the inverse of this diagonal matrix.
inverse(double) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Computes the inverse of this diagonal matrix.
inverse(RealMatrix) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Computes the inverse of the given matrix.
inverse(RealMatrix, double) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Computes the inverse of the given matrix.
inverse() - Method in class org.lsmp.djep.groupJep.values.Rational
 
Inverse - Class in org.lsmp.djep.jama
Find the inverses of a matrix.
Inverse() - Constructor for class org.lsmp.djep.jama.Inverse
 
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Beta
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Binomial
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Cauchy
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.ChiSquared
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.ContinuousDistribution
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.DiscreteDistribution
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Exponential
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.FDistribution
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Gamma
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Geometric
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Hypergeometric
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Laplace
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Logistic
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.LogNormal
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.NegativeBinomial
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Normal
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Poisson
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Rayleigh
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.TDistribution
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Uniform
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Weibull
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.GeometricDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.GumbelDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.LevyDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.LogisticDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Computes the quantile function of this distribution.
inverseErf(double) - Static method in class jhplot.math.num.special.Erf
Returns the inverse error function erf-1(y).
inverseLU(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
inverseQR(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
invert() - Method in class hep.physics.matrix.BasicMatrix
 
invert() - Method in interface hep.physics.matrix.MutableMatrix
Invert this matrix (into itself)
invert() - Method in class hep.physics.matrix.SymmetricMatrix
 
invert() - Method in class hep.physics.vec.BasicHep3Matrix
 
invert() - Method in class hephysics.matrix.BasicMatrix
 
invert() - Method in interface hephysics.matrix.MutableMatrix
Invert this matrix (into itself)
invert() - Method in class hephysics.matrix.SymmetricMatrix
 
invert() - Method in class hephysics.vec.Hep3Matrix
 
invert() - Method in class j4np.physics.LorentzVector
 
invert() - Method in class j4np.physics.Vector3
 
invert(double[]) - Static method in class jhplot.math.ArrayMathUtils
Inverts an array from left to right.
invert(int[]) - Static method in class jhplot.math.ArrayMathUtils
Inverts an array from left to right.
invert() - Method in class org.lsmp.djep.sjep.AbstractPNode
 
invert() - Method in class org.lsmp.djep.sjep.Monomial
 
invert() - Method in class org.lsmp.djep.sjep.PConstant
 
invert() - Method in interface org.lsmp.djep.sjep.PNodeI
inverts node i.e.
invertIndex(int[]) - Static method in class jhplot.math.Sorting
 
invertPalette() - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Inverts Palette
invGamma1pm1(double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the value of 1 / Γ(1 + x) - 1 for -0.5 ≤ x ≤ 1.5.
invSqrtQuick(double) - Static method in class net.jafama.FastMath
Quick inverse of square root, with a max relative error of about 3.44e-2 for values in [Double.MIN_NORMAL,Double.MAX_VALUE], and worse accuracy outside this range.
invSqrtQuick(double) - Static method in class net.jafama.StrictFastMath
Quick inverse of square root, with a max relative error of about 3.44e-2 for values in [Double.MIN_NORMAL,Double.MAX_VALUE], and worse accuracy outside this range.
IO - Class in jhplot
Methods used for input-output serialization of Java objects.
IO() - Constructor for class jhplot.IO
 
IOCase - Enum in org.apache.commons.io
Enumeration of IO case sensitivity.
IOConsumer<T> - Interface in org.apache.commons.io.function
Like Consumer but throws IOException.
IOExceptionList - Exception in org.apache.commons.io
A IOException based on a list of Throwable causes.
IOExceptionList(List<? extends Throwable>) - Constructor for exception org.apache.commons.io.IOExceptionList
Creates a new exception caused by a list of exceptions.
IOExceptionWithCause - Exception in org.apache.commons.io
Deprecated.
(since 2.5) use IOException instead
IOExceptionWithCause(String, Throwable) - Constructor for exception org.apache.commons.io.IOExceptionWithCause
Deprecated.
Constructs a new instance with the given message and cause.
IOExceptionWithCause(Throwable) - Constructor for exception org.apache.commons.io.IOExceptionWithCause
Deprecated.
Constructs a new instance with the given cause.
IOFileFilter - Interface in org.apache.commons.io.filefilter
An interface which brings the FileFilter and FilenameFilter interfaces together.
IOFunction<T,R> - Interface in org.apache.commons.io.function
Like Function but throws IOException.
IOIndexedException - Exception in org.apache.commons.io
A IOException associated with a source index.
IOIndexedException(int, Throwable) - Constructor for exception org.apache.commons.io.IOIndexedException
Creates a new exception.
IOSupplier<T> - Interface in org.apache.commons.io.function
Like Supplier but throws IOException.
IOUtils - Class in org.apache.commons.io
General IO stream manipulation utilities.
IOUtils() - Constructor for class org.apache.commons.io.IOUtils
Instances should NOT be constructed in standard programming.
IParticleID - Class in hep.lcio.implementation.event
 
IParticleID() - Constructor for class hep.lcio.implementation.event.IParticleID
 
IRawCalorimeterHit - Class in hep.lcio.implementation.event
A default implementation of CalorimeterHit
IRawCalorimeterHit() - Constructor for class hep.lcio.implementation.event.IRawCalorimeterHit
 
IReconstructedParticle - Class in hep.lcio.implementation.event
Implementation of ReconstructedParticle
IReconstructedParticle() - Constructor for class hep.lcio.implementation.event.IReconstructedParticle
 
is0D() - Method in class org.lsmp.djep.vectorJep.Dimensions
Is it 0D, ie a simple number.
is1D() - Method in class org.lsmp.djep.vectorJep.Dimensions
Is it 1D, ie a vector [1,2,3].
is2D() - Method in class org.lsmp.djep.vectorJep.Dimensions
Is it 2D, ie a matrix [[1,2,3],[4,5,6]].
is3D() - Method in class jhplot.Plottable
Is this plot for 3D canvas.
ISAACRandom - Class in org.apache.commons.math3.random
ISAAC: a fast cryptographic pseudo-random number generator
ISAAC (Indirection, Shift, Accumulate, Add, and Count) generates 32-bit random numbers.
ISAACRandom() - Constructor for class org.apache.commons.math3.random.ISAACRandom
Creates a new ISAAC random number generator.
ISAACRandom(long) - Constructor for class org.apache.commons.math3.random.ISAACRandom
Creates a new ISAAC random number generator using a single long seed.
ISAACRandom(int[]) - Constructor for class org.apache.commons.math3.random.ISAACRandom
Creates a new ISAAC random number generator using an int array seed.
isActive() - Method in class jplot.GraphLabel
 
isActive() - Method in class org.jlab.groot.tree.TreeCut
 
isAdvanceLineVisible() - Method in class org.jfree.chart.axis.CyclicNumberAxis
The advance line is the line drawn at the limit of the current cycle, when erasing the previous cycle.
isAllowedOperatorChar(char) - Static method in class jhplot.math.exp4j.operator.Operator
Check if a character is an allowed operator char
isAlphabetic(int) - Static method in class jhplot.math.exp4j.tokenizer.Tokenizer
 
isAngleGridlinesVisible() - Method in class org.jfree.chart.plot.PolarPlot
Returns true if the angular gridlines are visible, and false otherwise.
isAngleLabelsVisible() - Method in class org.jfree.chart.plot.PolarPlot
Returns a flag that controls whether or not the angle labels are visible.
isAssociative() - Method in class org.lsmp.djep.xjep.XOperator
 
isAutoPrune() - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns the flag that controls whether or not x-values are removed from the dataset when the corresponding y-values are all null.
isAutoRange() - Method in class org.jfree.chart.axis.ValueAxis
Returns the flag that controls whether or not the axis range is automatically adjusted to fit the data values.
isAutoScale() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
isAutoScaleZ() - Method in interface jplot3d.SurfaceModel
 
isAutoScaleZ() - Method in class jplot3d.SurfaceModelCanvas
 
isAutoTickUnitSelection() - Method in class org.jfree.chart.axis.ValueAxis
Returns a flag indicating whether or not the tick unit is automatically selected from a range of standard tick units.
isAutoWidth() - Method in class org.jfree.data.xy.CategoryTableXYDataset
Returns whether the interval width is automatically calculated or not.
isAutoWidth() - Method in class org.jfree.data.xy.DefaultTableXYDataset
Returns whether the interval width is automatically calculated or not.
isAutoWidth() - Method in class org.jfree.data.xy.IntervalXYDelegate
Returns true if the interval width is automatically calculated, and false otherwise.
isAutoWidth() - Method in class org.jfree.data.xy.XYSeriesCollection
Returns whether the interval width is automatically calculated or not.
isAxisAutoScale() - Method in class org.jlab.groot.base.AxisAttributes
 
isAxisGrid() - Method in class org.jlab.groot.base.AxisAttributes
 
isAxisLineVisible() - Method in class org.jfree.chart.axis.Axis
A flag that controls whether or not the axis line is drawn.
isAxisShown(int) - Method in class jhplot.HPlot
Returns whether an axis line will be drawn or not.
isBackscatter() - Method in interface hep.lcio.event.MCParticle
True if the particle was created by the simulator as a result of an interaction or decay in non-tracking region, e.g.
isBackscatter() - Method in class hep.lcio.implementation.event.IMCParticle
 
isBars() - Method in class jhplot.DrawOptions
Return true if histogram is shown using bars.
isBarShown() - Method in class jplot.LinePars
 
isBarsType() - Method in class jplot3d.SurfaceModelCanvas
 
isBetterScore(double, double) - Method in class org.apache.commons.math3.ml.clustering.evaluation.ClusterEvaluator
Returns whether the first evaluation score is considered to be better than the second one by this evaluator.
isBetween(double, double) - Static method in class cern.jet.math.Functions
Constructs a function that returns from<=a && a<=to.
isBetween(int, int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns from<=a && a<=to.
isBiasCorrected() - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns true iff biasCorrected property is set to true.
isBiasCorrected() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
 
isBiasCorrected() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
 
isBinary() - Method in class org.lsmp.djep.xjep.XOperator
 
isBinaryOperator(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
 
isBorder() - Method in class jhplot.gui.GHMargin
Is boarder shown?
isBorderShown() - Method in class jhplot.gui.GHPanel
is the boarder of margins shown?
isBorderVisible() - Method in class org.jfree.chart.JFreeChart
Returns a flag that controls whether or not a border is drawn around the outside of the chart.
isBothFunction() - Method in class jplot3d.SurfaceModelCanvas
 
isBoundMappedToLastCycle() - Method in class org.jfree.chart.axis.CyclicNumberAxis
The cycle bound can be associated either with the current or with the last cycle.
isBoxed - Variable in class jplot3d.JSurface
 
isBoxed() - Method in interface jplot3d.SurfaceModel
Determines whether to show bounding box.
isBoxed() - Method in class jplot3d.SurfaceModelCanvas
 
isBracketing(UnivariateFunction, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Check whether the interval bounds bracket a root.
isCasePreserving() - Method in enum org.apache.commons.io.FileSystem
Whether this file system preserves case.
isCaseSensitive() - Method in enum org.apache.commons.io.FileSystem
Whether this file system is case-sensitive.
isCaseSensitive() - Method in enum org.apache.commons.io.IOCase
Does the object represent case sensitive comparison.
isCauseOf(Throwable) - Method in class org.apache.commons.io.input.TaggedInputStream
Tests if the given exception was caused by this stream.
isCauseOf(Throwable) - Method in class org.apache.commons.io.input.TaggedReader
Tests if the given exception was caused by this reader.
isCauseOf(Exception) - Method in class org.apache.commons.io.output.TaggedOutputStream
Tests if the given exception was caused by this stream.
isCauseOf(Exception) - Method in class org.apache.commons.io.output.TaggedWriter
Tests if the given exception was caused by this writer.
isCellEditable(int, int) - Method in class org.jfree.data.time.TimeSeriesTableModel
Returns a flag indicating whether or not the specified cell is editable.
isCellEditable(int, int) - Method in class org.jfree.data.xy.XYDatasetTableModel
Returns a flag indicating whether or not the specified cell is editable.
isChartAvailable(String) - Method in class org.jfree.chart.servlet.ChartDeleter
Checks to see if a chart is in the list of charts to be deleted
isChild() - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
isCircular() - Method in class org.jfree.chart.plot.PiePlot
Returns a flag indicating whether the pie chart is circular, or stretched into an elliptical shape.
isClip() - Method in class org.jfree.chart.ClipPath
Deprecated.
Returns the clip.
isClippedToWindow() - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Returns false to indicate that this dial layer is not clipped to the dial window.
isClippedToWindow() - Method in class org.jfree.chart.plot.dial.DialBackground
Returns true to indicate that this layer should be clipped within the dial window.
isClippedToWindow() - Method in class org.jfree.chart.plot.dial.DialCap
Returns true to indicate that this layer should be clipped within the dial window.
isClippedToWindow() - Method in interface org.jfree.chart.plot.dial.DialLayer
Returns true if the drawing should be clipped to the dial window (which is defined by the DialFrame), and false otherwise.
isClippedToWindow() - Method in class org.jfree.chart.plot.dial.DialPointer
Returns true to indicate that this layer should be clipped within the dial window.
isClippedToWindow() - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Returns true to indicate that this layer should be clipped within the dial window.
isClippedToWindow() - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Returns true to indicate that this layer should be clipped within the dial window.
isClippedToWindow() - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Returns false to indicate that this dial layer is not clipped to the dial window.
isClippedToWindow() - Method in class org.jfree.chart.plot.dial.StandardDialRange
Returns true to indicate that this layer should be clipped within the dial window.
isClippedToWindow() - Method in class org.jfree.chart.plot.dial.StandardDialScale
Returns true to indicate that this layer should be clipped within the dial window.
isClippingDisabled() - Method in class org.jfree.chart.fx.FXGraphics2D
Returns the flag that controls whether or not clipping is actually applied to the JavaFX canvas.
isCloseOnClose() - Method in class org.apache.commons.io.input.RandomAccessFileInputStream
Returns whether to close the underlying file when this stream is closed.
isColumnDimension(double[][], int) - Static method in class jhplot.math.DoubleArray
Same as checkColumnDimension() but just returns a boolean value rather than throwing an exception.
isCommutative() - Method in class org.lsmp.djep.xjep.XOperator
 
isCompatible(SparseIndex) - Method in class org.jlab.groot.matrix.SparseIndex
Checks two SparseIndex classes for compatability.
isCompatibleDomainAxis(ValueAxis) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Checks the compatibility of a domain axis, returning true if the axis is compatible with the plot, and false otherwise.
isCompatibleValue(Object) - Method in class org.jfree.chart.ChartHints.Key
Returns true if val is a value that is compatible with this key, and false otherwise.
isComplex(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is an ASTConstant of type Complex
isComposite() - Method in class org.lsmp.djep.xjep.XOperator
 
isCompound() - Method in interface hep.lcio.event.ReconstructedParticle
Convenient method - same as (getParticles().size() > 0 ).
isCompound() - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
isConstant() - Method in interface org.lsmp.djep.matrixJep.MatrixVariableI
Is it constant?
isConstant(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is a ASTConstant
isConstant() - Method in class org.nfunk.jep.Variable
 
isConstantPoly(Number) - Method in interface org.lsmp.djep.groupJep.GroupI
For groups like rings of polynomials this determins if a given element is a constant polynomial.
isConstantPoly(Number) - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
Whether the given polynomial is constant.
isConstantPoly(Number) - Method in class org.lsmp.djep.groupJep.groups.Group
Default implementation.
isConstantPoly() - Method in class org.lsmp.djep.groupJep.values.Polynomial
Is this a constant polynomial?
isConstantVar(XVariable) - Method in class org.lsmp.djep.djep.DifferentiationVisitor
 
isContinuousPalettePreferred() - Method in class net.java.dev.colorchooser.ColorChooser
Determine whether the initial palette shown when clicked with no keys pressed is one showing a continuous (rainbow) palette or a set of tiles with different colors.
isContourType() - Method in class jplot3d.SurfaceModelCanvas
 
isCounterClockWise() - Method in class org.apache.commons.math3.complex.RootsOfUnity
Returns true if RootsOfUnity.computeRoots(int) was called with a positive value of its argument n.
isCounterClockwise() - Method in class org.jfree.chart.plot.PolarPlot
Get the direction for growing angle degrees.
isCreatedInSimulation() - Method in interface hep.lcio.event.MCParticle
True if the particle has been created by the simulation program (rather than the generator).
isCreatedInSimulation() - Method in class hep.lcio.implementation.event.IMCParticle
 
isDataAvailable() - Method in interface jplot3d.SurfaceModel
Sets data availability flag
isDataAvailable() - Method in class jplot3d.SurfaceModelCanvas
 
isDataFlavorSupported(DataFlavor) - Method in class org.jfree.chart.ChartTransferable
Returns true if the specified flavor is supported.
isDataFlavorSupported(DataFlavor) - Method in class org.jlab.groot.ui.TransferableImage
 
isDateAxis(int) - Method in interface org.jfree.data.contour.ContourDataset
Deprecated.
Returns true if axis are dates.
isDateAxis(int) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Returns true if axis are dates.
isDecayedInCalorimeter() - Method in interface hep.lcio.event.MCParticle
True if the particle decayed or interacted (non-continuous interaction, particle terminated) in non-tracking region.
isDecayedInCalorimeter() - Method in class hep.lcio.implementation.event.IMCParticle
 
isDecayedInTracker() - Method in interface hep.lcio.event.MCParticle
True if the particle decayed or interacted in a tracking region.
isDecayedInTracker() - Method in class hep.lcio.implementation.event.IMCParticle
 
isDefault() - Method in interface hep.lcio.event.LCCollection
True if collection is the default collection for the given type.
isDefault() - Method in class hep.lcio.implementation.event.ILCCollection
 
isDefaultPosition() - Method in class jhplot.HKey
Is this key should be set at a default position?
isDensityType() - Method in class jplot3d.SurfaceModelCanvas
 
isDiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is diagonal if A[i,j] == 0 whenever i != j.
isDiagonallyDominantByColumn(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is diagonally dominant by column if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding column.
isDiagonallyDominantByRow(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is diagonally dominant by row if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding row.
isDirect() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Check if the hyperplane orientation is direct.
isDirect() - Method in class org.apache.commons.math3.geometry.spherical.oned.LimitAngle
Check if the hyperplane orientation is direct.
isDirectory() - Method in class org.apache.commons.io.monitor.FileEntry
Indicate whether the file is a directory or not.
isDirty(String) - Method in class jplot3dp.MainComponent
 
isDisplayGrids - Variable in class jplot3d.JSurface
 
isDisplayGrids() - Method in interface jplot3d.SurfaceModel
Determines whether to show face grids.
isDisplayGrids() - Method in class jplot3d.SurfaceModelCanvas
 
isDisplayXY - Variable in class jplot3d.JSurface
 
isDisplayXY() - Method in interface jplot3d.SurfaceModel
Determines whether to show x-y ticks.
isDisplayXY() - Method in class jplot3d.SurfaceModelCanvas
 
isDisplayZ - Variable in class jplot3d.JSurface
 
isDisplayZ() - Method in interface jplot3d.SurfaceModel
Determines whether to show z ticks.
isDisplayZ() - Method in class jplot3d.SurfaceModelCanvas
 
isDistributiveOver(Operator) - Method in class org.lsmp.djep.xjep.XOperator
 
isDomainCrosshairLockedOnData() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns a flag indicating whether or not the crosshair should "lock-on" to actual data values.
isDomainCrosshairLockedOnData() - Method in class org.jfree.chart.plot.XYPlot
Returns a flag indicating whether or not the crosshair should "lock-on" to actual data values.
isDomainCrosshairVisible() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the flag that controls whether or not the domain crosshair is displayed by the plot.
isDomainCrosshairVisible() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns a flag indicating whether or not the domain crosshair is visible.
isDomainCrosshairVisible() - Method in class org.jfree.chart.plot.XYPlot
Returns a flag indicating whether or not the domain crosshair is visible.
isDomainGridlinesVisible() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the flag that controls whether the domain grid-lines are visible.
isDomainGridlinesVisible() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns true if the domain gridlines are visible, and false otherwise.
isDomainGridlinesVisible() - Method in class org.jfree.chart.plot.XYPlot
Returns true if the domain gridlines are visible, and false otherwise.
isDomainMinorGridlinesVisible() - Method in class org.jfree.chart.plot.XYPlot
Returns true if the domain minor gridlines are visible, and false otherwise.
isDomainPannable() - Method in class org.jfree.chart.plot.CategoryPlot
Returns false always, because the plot cannot be panned along the domain axis/axes.
isDomainPannable() - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Returns true if the domain is pannable for at least one subplot, and false otherwise.
isDomainPannable() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns true if panning is enabled for the domain axes, and false otherwise.
isDomainPannable() - Method in interface org.jfree.chart.plot.Pannable
Evaluates if the domain axis can be panned.
isDomainPannable() - Method in class org.jfree.chart.plot.XYPlot
Returns true if panning is enabled for the domain axes, and false otherwise.
isDomainZeroBaselineVisible() - Method in class org.jfree.chart.plot.XYPlot
Returns a flag that controls whether or not a zero baseline is displayed for the domain axis.
isDomainZoomable() - Method in class org.jfree.chart.ChartPanel
Returns the flag that determines whether or not zooming is enabled for the domain axis.
isDomainZoomable() - Method in class org.jfree.chart.plot.CategoryPlot
Returns false to indicate that the domain axes are not zoomable.
isDomainZoomable() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns false.
isDomainZoomable() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns true.
isDomainZoomable() - Method in class org.jfree.chart.plot.PolarPlot
Returns false always.
isDomainZoomable() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns false.
isDomainZoomable() - Method in class org.jfree.chart.plot.XYPlot
Returns true, indicating that the domain axis/axes for this plot are zoomable.
isDomainZoomable() - Method in interface org.jfree.chart.plot.Zoomable
Returns true if the plot's domain is zoomable, and false otherwise.
isDrawAxis() - Method in class org.jlab.groot.base.DatasetAttributes
 
isDrawBarOutline() - Method in class org.jfree.chart.renderer.category.BarRenderer
Returns a flag that controls whether or not bar outlines are drawn.
isDrawBarOutline() - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Returns a flag that controls whether or not bar outlines are drawn.
isDrawFrame() - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
isDrawLine() - Method in class jplot.LinePars
is draw a line?
isDrawLines() - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Gets whether or not lines are drawn between category points.
isDrawPath() - Method in class org.jfree.chart.ClipPath
Deprecated.
Returns the drawPath.
isDrawSymbol() - Method in class jplot.LinePars
is draw a symbol
isDualShadeMode() - Method in class jplot3d.SurfaceModelCanvas
 
isEmpty() - Method in class cern.colt.list.AbstractCollection
Tests if the receiver has no elements.
isEmpty() - Method in class cern.colt.map.AbstractMap
Returns true if the receiver contains no (key,value) associations.
isEmpty() - Method in interface jplot3d.SurfaceModel
 
isEmpty() - Method in class jplot3d.SurfaceModelCanvas
 
isEmpty(Path) - Static method in class org.apache.commons.io.file.PathUtils
Returns whether the given file or directory is empty.
isEmpty() - Method in class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
Check if the instance is empty.
isEmpty() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check if the instance is empty.
isEmpty(BSPTree<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check if the sub-tree starting at a given node is empty.
isEmpty() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Check if the instance is empty.
isEmpty() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Check if the instance is empty.
isEmpty(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Check if the sub-tree starting at a given node is empty.
isEmpty() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Check if the instance is empty.
isEmpty() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Deprecated.
Check if the tree is empty.
isEmpty() - Method in class org.apache.commons.math3.geometry.spherical.oned.SubLimitAngle
Check if the instance is empty.
isEmpty() - Method in class org.jfree.chart.block.BlockContainer
Returns true if there are no blocks in the container, and false otherwise.
isEmpty() - Method in class org.jfree.data.general.Series
Returns true if the series contains no data items, and false otherwise.
isEmptyDirectory(Path) - Static method in class org.apache.commons.io.file.PathUtils
Returns whether the directory is empty.
isEmptyFile(Path) - Static method in class org.apache.commons.io.file.PathUtils
Returns whether the given file is empty.
isEmptyOrNull(XYPlot) - Static method in class org.jfree.chart.plot.PlotUtilities
Returns true if all the datasets belonging to the specified plot are empty or null, and false otherwise.
isEmptyOrNull(PieDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns true if the dataset is empty (or null), and false otherwise.
isEmptyOrNull(CategoryDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns true if the dataset is empty (or null), and false otherwise.
isEmptyOrNull(XYDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Returns true if the dataset is empty (or null), and false otherwise.
isEnabled() - Method in class org.jfree.chart.fx.interaction.AbstractMouseHandlerFX
Returns the flag that controls whether or not the handler is enabled.
isEnabled() - Method in interface org.jfree.chart.fx.interaction.MouseHandlerFX
Returns true if the mouse handler is enabled, and false if it is disabled.
isEncodingAlpha() - Method in interface org.jfree.chart.encoders.ImageEncoder
Get whether the encoder should encode alpha transparency.
isEncodingAlpha() - Method in class org.jfree.chart.encoders.KeypointPNGEncoderAdapter
Get whether the encoder should encode alpha transparency.
isEncodingAlpha() - Method in class org.jfree.chart.encoders.SunJPEGEncoderAdapter
Returns false always, indicating that this encoder does not encode alpha transparency.
isEncodingAlpha() - Method in class org.jfree.chart.encoders.SunPNGEncoderAdapter
Get whether the encoder should encode alpha transparency (always false).
isEnforceFileExtensions() - Method in class org.jfree.chart.ChartPanel
Returns true if file extensions should be enforced, and false otherwise.
isEqual - Static variable in class cern.jet.math.Functions
Function that returns a == b.
isEqual(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a == b.
isEqual - Static variable in class cern.jet.math.IntFunctions
Function that returns a == b.
isEqual(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a == b.
IsEqual(Z, Z) - Method in class Jampack.Z
Tests two Z'z for equality.
isEquidistant(float) - Static method in class net.jafama.NumbersUtils
 
isEquidistant(double) - Static method in class net.jafama.NumbersUtils
 
isEquivilence() - Method in class org.lsmp.djep.xjep.XOperator
 
isErrX() - Method in class jhplot.DrawOptions
is error shown on X?
isErrY() - Method in class jhplot.DrawOptions
is error shown on Y?
isEvaluated() - Method in class jhplot.FND
Is the function was evaluated?
isEven(int) - Static method in class net.jafama.NumbersUtils
 
isEven(long) - Static method in class net.jafama.NumbersUtils
 
isExists(String) - Method in class jhplot.io.HDataBase
Checks if there is a record belonging to the given key.
isExists() - Method in class org.apache.commons.io.monitor.FileEntry
Indicate whether the file existed the last time it was checked.
isExpectDelay() - Method in interface jplot3d.SurfaceModel
Determines whether the delay regeneration checkbox is checked.
isExpectDelay() - Method in class jplot3d.SurfaceModelCanvas
 
isExtension(String, String) - Static method in class org.apache.commons.io.FilenameUtils
Checks whether the extension of the fileName is that specified.
isExtension(String, String...) - Static method in class org.apache.commons.io.FilenameUtils
Checks whether the extension of the fileName is one of those specified.
isExtension(String, Collection<String>) - Static method in class org.apache.commons.io.FilenameUtils
Checks whether the extension of the fileName is one of those specified.
isFastMath() - Static method in class jhplot.HParam
Check is fast math calculation enabled.
isFileNewer(File, ChronoLocalDate) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is newer than the specified ChronoLocalDate at the current time.
isFileNewer(File, ChronoLocalDate, LocalTime) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is newer than the specified ChronoLocalDate at the specified time.
isFileNewer(File, ChronoLocalDateTime<?>) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is newer than the specified ChronoLocalDateTime at the system-default time zone.
isFileNewer(File, ChronoLocalDateTime<?>, ZoneId) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is newer than the specified ChronoLocalDateTime at the specified ZoneId.
isFileNewer(File, ChronoZonedDateTime<?>) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is newer than the specified ChronoZonedDateTime.
isFileNewer(File, Date) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is newer than the specified Date.
isFileNewer(File, File) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is newer than the reference File.
isFileNewer(File, Instant) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is newer than the specified Instant.
isFileNewer(File, long) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is newer than the specified time reference.
isFileOlder(File, ChronoLocalDate) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is older than the specified ChronoLocalDate at the current time.
isFileOlder(File, ChronoLocalDate, LocalTime) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is older than the specified ChronoLocalDate at the specified LocalTime.
isFileOlder(File, ChronoLocalDateTime<?>) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is older than the specified ChronoLocalDateTime at the system-default time zone.
isFileOlder(File, ChronoLocalDateTime<?>, ZoneId) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is older than the specified ChronoLocalDateTime at the specified ZoneId.
isFileOlder(File, ChronoZonedDateTime<?>) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is older than the specified ChronoZonedDateTime.
isFileOlder(File, Date) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is older than the specified Date.
isFileOlder(File, File) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is older than the reference File.
isFileOlder(File, Instant) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is older than the specified Instant.
isFileOlder(File, long) - Static method in class org.apache.commons.io.FileUtils
Tests if the specified File is older than the specified time reference.
isFilled() - Method in class jhplot.DrawOptions
Fill or not histogram or function.
isFilled() - Method in class jhplot.FPR
Is area filled or not
isFillPath() - Method in class org.jfree.chart.ClipPath
Deprecated.
Returns the fillPath.
isFinished() - Method in class jminhep.algorithms.FuzzyCMeansAlg
This method returns true if the clustering has finished.
isFirstFunctionOnly() - Method in class jplot3d.SurfaceModelCanvas
 
isFixed() - Method in class org.jlab.groot.base.PadMargins
 
isFixedBinning() - Method in class jhplot.H1D
Return true if bins have constant bin width
isFixedBinning() - Method in class jhplot.HProf1D
Return true if bins have constant bin width
ISFIXEDBINS_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
ISFIXEDBINS_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
isFixedSize() - Method in interface hep.lcio.event.LCGenericObject
True if objects of the implementation class have a fixed size, i.e getNInt, getNFloat and getNDouble will return values that are constant during the lifetime of the object.
isFixedSize() - Method in class hep.lcio.example.CalibrationConstant
 
isFixedSize() - Method in class hep.lcio.implementation.event.ILCGenericObject
 
isFogMode() - Method in class jplot3d.SurfaceModelCanvas
 
isForward() - Method in class org.apache.commons.math3.ode.sampling.AbstractFieldStepInterpolator
Check if the natural integration direction is forward.
isForward() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Check if the natural integration direction is forward.
isForward() - Method in interface org.apache.commons.math3.ode.sampling.FieldStepInterpolator
Check if the natural integration direction is forward.
isForward() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Check if the natural integration direction is forward.
isFull() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check if the instance covers the full space.
isFull(BSPTree<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check if the sub-tree starting at a given node covers the full space.
isFull() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Check if the instance covers the full space.
isFull(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Check if the sub-tree starting at a given node covers the full space.
isFullRank() - Method in class Jama.QRDecomposition
Is the matrix full rank?
isFullRank() - Method in class jhplot.math.kalman.jama.QRDecomposition
Is the matrix full rank?
isFullRank() - Method in class jhplot.math.QRDecomposition
Is the matrix full rank?
isFunction(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is an ASTFunNode
isGrayScaleMode() - Method in class jplot3d.SurfaceModelCanvas
 
isGreater - Static variable in class cern.jet.math.Functions
Function that returns a > b.
isGreater(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a > b.
isGreater - Static variable in class cern.jet.math.IntFunctions
Function that returns a > b.
isGreater(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a > b.
isGridBandsVisible() - Method in class org.jfree.chart.axis.SymbolAxis
Returns true if the grid bands are showing, and false otherwise.
isGridToFront() - Method in class jhplot.HPlot
Flag, saying whether the grid should be drawn at the foreground or not.
isGuideLinesVisible() - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Returns a flag that controls whether or not guide lines are drawn for each data item (the lines are horizontal and vertical "crosshairs" linking the data point to the axes).
isH2F2() - Method in interface jplot3d.SurfaceModel
 
isH2F2() - Method in class jplot3d.SurfaceModelCanvas
 
isHiddenMode() - Method in class jplot3d.SurfaceModelCanvas
 
isHiddenValue(long) - Method in class org.jfree.chart.axis.DateAxis
Returns true if the axis hides this value, and false otherwise.
isHigh() - Method in class org.freehep.math.minuit.MnStrategy
 
isHighFarOut() - Method in class org.jfree.chart.renderer.OutlierListCollection
A flag to indicate the presence of one or more far out values at the top end of the range.
isHorizontal() - Method in class org.jfree.chart.plot.PlotOrientation
Returns true if this orientation is HORIZONTAL, and false otherwise.
isIdentity(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is an identity matrix if A[i,i] == 1 and all other cells are zero.
ISimCalorimeterHit - Class in hep.lcio.implementation.event
A default implementation of SimCalorimeterHit
ISimCalorimeterHit() - Constructor for class hep.lcio.implementation.event.ISimCalorimeterHit
 
ISimTrackerHit - Class in hep.lcio.implementation.event
A default implementation of SimTrackerHit
ISimTrackerHit() - Constructor for class hep.lcio.implementation.event.ISimTrackerHit
 
isInClockwiseDomain(double, double, double) - Static method in class net.jafama.FastMath
NB: Since 2*Math.PI < 2*PI, a span of 2*Math.PI does not mean full angular range.
isInClockwiseDomain(double, double, double) - Static method in class net.jafama.StrictFastMath
NB: Since 2*Math.PI < 2*PI, a span of 2*Math.PI does not mean full angular range.
isInfinite() - Method in class org.apache.commons.math3.complex.Complex
Checks whether either the real or imaginary part of this complex number takes an infinite value (either Double.POSITIVE_INFINITY or Double.NEGATIVE_INFINITY) and neither part is NaN.
isInfinite() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is infinite.
isInfinite() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in interface org.apache.commons.math3.geometry.Vector
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Check whether any coordinate of this vector is infinite and none are NaN.
isInfinite() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Check whether any coordinate of this vector is infinite and none are NaN.
isInfinite() - Method in class org.apache.commons.math3.linear.RealVector
Check whether any coordinate of this vector is infinite and none are NaN.
isInfinite() - Method in class org.apache.commons.math3.util.Decimal64
Returns true if this double precision number is infinite (Double.POSITIVE_INFINITY or Double.NEGATIVE_INFINITY).
isInfinite() - Method in class org.nfunk.jep.type.Complex
Returns true if either the real or imaginary component of this Complex is an infinite value.
isInfinity() - Method in class org.lsmp.djep.sjep.PConstant
 
isInfinity(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is a ASTConstant with a Infinite component TODO do proper treatment of signed infinity
isInitialized() - Method in class proeic.io.ProMC.ProMCEvent.Builder
 
isInitialized() - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
 
isInitialized() - Method in class proeic.io.ProMC.ProMCEvent.Event
 
isInitialized() - Method in class proeic.io.ProMC.ProMCEvent
 
isInitialized() - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
 
isInitialized() - Method in class proeic.io.ProMC.ProMCEvent.Particles
 
isInitialized() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
 
isInitialized() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
isInitialized() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
 
isInitialized() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
isInitialized() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
isInitialized() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
isInitialized() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
isInitialized() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
isInitialized() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
isInitialized() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
isInitialized() - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
 
isInitialized() - Method in class proeic.io.ProMCStatFile.ProMCStat
 
isInitialized() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
 
isInitialized() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
isInitialized() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
 
isInitialized() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
isInitialized() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
isInitialized() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
isInitialized() - Method in class promc.io.PBufFile.Record.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.F1D.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.F1D
 
isInitialized() - Method in class promc.io.PBufFile.Record.F2D.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.F2D
 
isInitialized() - Method in class promc.io.PBufFile.Record.FND.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.FND
 
isInitialized() - Method in class promc.io.PBufFile.Record.FPR.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.FPR
 
isInitialized() - Method in class promc.io.PBufFile.Record.H1D.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.H1D
 
isInitialized() - Method in class promc.io.PBufFile.Record.H2D.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.H2D
 
isInitialized() - Method in class promc.io.PBufFile.Record
 
isInitialized() - Method in class promc.io.PBufFile.Record.P0D.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.P0D
 
isInitialized() - Method in class promc.io.PBufFile.Record.P0I.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.P0I
 
isInitialized() - Method in class promc.io.PBufFile.Record.P1D.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.P1D
 
isInitialized() - Method in class promc.io.PBufFile.Record.PND.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.PND
 
isInitialized() - Method in class promc.io.PBufFile.Record.PNI.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.PNI
 
isInitialized() - Method in class promc.io.PBufFile.Record.PXY.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.PXY
 
isInitialized() - Method in class promc.io.PBufFile.Record.PXYZ.Builder
 
isInitialized() - Method in class promc.io.PBufFile.Record.PXYZ
 
isInitialized() - Method in class promc.io.PEventFile.HEvent.Builder
 
isInitialized() - Method in class promc.io.PEventFile.HEvent.Entry.Builder
 
isInitialized() - Method in class promc.io.PEventFile.HEvent.Entry
 
isInitialized() - Method in class promc.io.PEventFile.HEvent.Group.Builder
 
isInitialized() - Method in class promc.io.PEventFile.HEvent.Group
 
isInitialized() - Method in class promc.io.PEventFile.HEvent
 
isInitialized() - Method in class promc.io.ProMC.ProMCEvent.Builder
 
isInitialized() - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
 
isInitialized() - Method in class promc.io.ProMC.ProMCEvent.Event
 
isInitialized() - Method in class promc.io.ProMC.ProMCEvent
 
isInitialized() - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
 
isInitialized() - Method in class promc.io.ProMC.ProMCEvent.Particles
 
isInitialized() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
 
isInitialized() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
isInitialized() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
 
isInitialized() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
 
isInitialized() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
isInitialized() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
isInitialized() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
isInitialized() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
isInitialized() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
isInitialized() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
isInitialized() - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
 
isInitialized() - Method in class promc.io.ProMCStatFile.ProMCStat
 
isInitialized() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
isInitialized() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
isInitialized() - Method in class pronlo.io.ProMC.ProMCEvent.Builder
 
isInitialized() - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
 
isInitialized() - Method in class pronlo.io.ProMC.ProMCEvent.Event
 
isInitialized() - Method in class pronlo.io.ProMC.ProMCEvent
 
isInitialized() - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
 
isInitialized() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
 
isInitialized() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
 
isInitialized() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
isInitialized() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
 
isInitialized() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
isInitialized() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
isInitialized() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
isInitialized() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
isInitialized() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
isInitialized() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
isInitialized() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
isInitialized() - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
 
isInitialized() - Method in class pronlo.io.ProMCStatFile.ProMCStat
 
isInitialized() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
isInitialized() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Builder
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Event
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Jets
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.MissingET
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Muons
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Particles
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Photons
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
 
isInitialized() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
 
isInitialized() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
 
isInitialized() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
isInitialized() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
 
isInitialized() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
isInitialized() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
isInitialized() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
isInitialized() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
isInitialized() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
isInitialized() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
isInitialized() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
isInitialized() - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
 
isInitialized() - Method in class proreco.io.ProMCStatFile.ProMCStat
 
isInitialized() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
isInitialized() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
isInMemory() - Method in class org.apache.commons.io.output.DeferredFileOutputStream
Determines whether or not the data for this output stream has been retained in memory.
isInRange(int, int, int) - Static method in class net.jafama.NumbersUtils
 
isInRange(long, long, long) - Static method in class net.jafama.NumbersUtils
 
isInRange(float, float, float) - Static method in class net.jafama.NumbersUtils
Returns false if any value is NaN.
isInRange(double, double, double) - Static method in class net.jafama.NumbersUtils
Returns false if any value is NaN.
isInRangeSigned(int, int) - Static method in class net.jafama.NumbersUtils
 
isInRangeSigned(long, int) - Static method in class net.jafama.NumbersUtils
 
isInRangeUnsigned(int, int) - Static method in class net.jafama.NumbersUtils
 
isInRangeUnsigned(long, int) - Static method in class net.jafama.NumbersUtils
 
isInteger() - Method in class org.lsmp.djep.sjep.PConstant
 
isInteger(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is a ASTConstant with Double value representing an integer.
isInvalid() - Method in class jplot3d.SurfaceVertex
Determines whether this vertex is invalid, i.e has invalid coordinates value.
isInverse() - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns the inverse flag.
isInverted() - Method in class org.jfree.chart.axis.ValueAxis
Returns a flag that controls the direction of values on the axis.
isItemLabelVisible(int, int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns true if an item label is visible, and false otherwise.
isItemLabelVisible(int, int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns true if an item label is visible, and false otherwise.
isItemLabelVisible(int, int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns true if an item label is visible, and false otherwise.
isJFreeSVGAvailable() - Static method in class org.jfree.chart.util.ExportUtils
Returns true if JFreeSVG is on the classpath, and false otherwise.
isLabelOutlineVisible() - Method in class org.jfree.chart.plot.Crosshair
Returns the flag that controls the visibility of the label outline.
isLabelVisible() - Method in class org.jfree.chart.plot.Crosshair
Returns the flag that controls whether or not a label is drawn for this crosshair.
isLastPointGood() - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer.State
Returns a flag that indicates if the last point drawn (in the current series) was 'good' (non-null).
isLastPointGood() - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer.State
Returns a flag that indicates if the last point drawn (in the current series) was 'good' (non-null).
isLeaf(Object) - Method in class root.RootHistogramTreeModel
 
isLeftAssociative() - Method in class jhplot.math.exp4j.operator.Operator
Check if the operator is left associative
isLegalFileName(CharSequence) - Method in enum org.apache.commons.io.FileSystem
Checks if a candidate file name (without a path) such as "filename.ext" or "filename" is a potentially legal file name.
isLength(double[], int) - Static method in class jhplot.math.DoubleArray
Same as checkLength but returns a boolean value rather than throwing an exception.
isLess - Static variable in class cern.jet.math.Functions
Function that returns a < b.
isLess(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a < b.
isLess - Static variable in class cern.jet.math.IntFunctions
Function that returns a < b.
isLess(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a < b.
isLightlike(double) - Method in class hephysics.vec.HepLorentzVector
is spacelike?
isLimited() - Method in class org.jlab.groot.math.UserParameter
 
isLineIntersectingLine(int, int, int, int, int, int, int, int) - Static method in class jplot.Geometry
Check if two line segments intersects.
isLineIntersectingRectangle(int, int, int, int, int, int, int, int) - Static method in class jplot.Geometry
Check if a specified line intersects a specified rectangle.
isLineVisible() - Method in class org.jfree.chart.LegendItem
Returns a flag that indicates whether or not the line is visible.
isLineVisible() - Method in class org.jfree.chart.title.LegendGraphic
Returns the flag that controls whether or not the line is visible.
isLoaded() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Property indicating whether or not the distribution has been loaded.
isLog() - Method in class org.jlab.groot.base.AxisAttributes
 
isLogscale() - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns the log-scale flag.
isLow() - Method in class org.freehep.math.minuit.MnStrategy
 
isLowerBidiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is lower bidiagonal if A[i,j]==0 unless i==j || i==j+1.
isLowerTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is lower triangular if A[i,j]==0 whenever i < j.
isLowFarOut() - Method in class org.jfree.chart.renderer.OutlierListCollection
A flag to indicate the presence of one or more far out values at the bottom end of the range.
isMathematicalInteger(float) - Static method in class net.jafama.NumbersUtils
 
isMathematicalInteger(double) - Static method in class net.jafama.NumbersUtils
 
isMaxValue(Number) - Method in class org.jfree.data.general.WaferMapDataset
Tests to see if the passed value is larger than the stored maxvalue.
isMeanVisible() - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Returns the flag that controls whether or not the mean indicator is draw for each item.
isMedianVisible() - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Returns the flag that controls whether or not the median indicator is draw for each item.
isMedium() - Method in class org.freehep.math.minuit.MnStrategy
 
isMesh - Variable in class jplot3d.JSurface
 
isMesh() - Method in interface jplot3d.SurfaceModel
Determines whether to show x-y mesh.
isMesh() - Method in class jplot3d.SurfaceModelCanvas
 
isMinorTickMarksVisible() - Method in class org.jfree.chart.axis.Axis
Returns the flag that indicates whether or not the minor tick marks are showing.
isMinorTickMarksVisible() - Method in class org.jfree.chart.axis.PeriodAxis
Returns the flag that controls whether or not minor tick marks are displayed for the axis.
isMinusOne() - Method in class org.lsmp.djep.sjep.PConstant
 
isMinusOne(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is a ASTConstant with value Double(-1) or Complex(-1,0)
isMinValue(Number) - Method in class org.jfree.data.general.WaferMapDataset
Tests to see if the passed value is smaller than the stored minvalue.
isMirrorAxisShown(int) - Method in class jhplot.HPlot
Returns whether the mirror of an axis will be drawn or not.
isMonotonic(T[], MathArrays.OrderDirection, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
Check that an array is monotonically increasing or decreasing.
isMonotonic(double[], MathArrays.OrderDirection, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
Check that an array is monotonically increasing or decreasing.
isMouseWheelEnabled() - Method in class org.jfree.chart.ChartPanel
Returns true if the mouse wheel handler is enabled, and false otherwise.
isMultiple() - Method in class org.jfree.chart.renderer.OutlierList
Returns true if the list contains multiple outliers, and false otherwise.
isNaN() - Method in class org.apache.commons.math3.complex.Complex
Checks whether either or both parts of this complex number is NaN.
isNaN() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is not a number.
isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Returns true if any coordinate of this point is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Returns true if any coordinate of this vector is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Returns true if any coordinate of this point is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Returns true if any coordinate of this point is NaN; false otherwise
isNaN() - Method in interface org.apache.commons.math3.geometry.Point
Returns true if any coordinate of this point is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math3.geometry.spherical.oned.S1Point
Returns true if any coordinate of this point is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math3.geometry.spherical.twod.S2Point
Returns true if any coordinate of this point is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Check if any coordinate of this vector is NaN.
isNaN() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Check whether any coordinate of this vector is NaN.
isNaN() - Method in class org.apache.commons.math3.linear.RealVector
Check whether any coordinate of this vector is NaN.
isNaN() - Method in class org.apache.commons.math3.util.Decimal64
Returns true if this double precision number is Not-a-Number (NaN), false otherwise.
isNan() - Method in class org.lsmp.djep.sjep.PConstant
 
isNaN(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is a ASTConstant with a NaN component
isNaN() - Method in class org.nfunk.jep.type.Complex
Returns true if either the real or imaginary component of this Complex is a Not-a-Number (NaN) value.
isNaNOrInfinite(float) - Static method in class net.jafama.FastMath
 
isNaNOrInfinite(double) - Static method in class net.jafama.FastMath
 
isNaNOrInfinite(float) - Static method in class net.jafama.NumbersUtils
 
isNaNOrInfinite(double) - Static method in class net.jafama.NumbersUtils
 
isNaNOrInfinite(float) - Static method in class net.jafama.StrictFastMath
 
isNaNOrInfinite(double) - Static method in class net.jafama.StrictFastMath
 
isNaNRange() - Method in class org.jfree.data.Range
Returns true if both the lower and upper bounds are Double.NaN, and false otherwise.
isNary() - Method in class org.lsmp.djep.xjep.XOperator
 
isNegative() - Method in class org.lsmp.djep.sjep.PConstant
 
isNegative(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is an ASTConstant with a negative Double value
isNegativeArrowVisible() - Method in class org.jfree.chart.axis.ValueAxis
Returns a flag that controls whether or not the axis line has an arrow drawn that points in the negative direction for the axis.
isNextOutfile() - Method in class hep.lcio.util.LCIOSplitter
 
isNoIntercept() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
 
isNonNegative(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is non-negative if A[i,j] >= 0 holds for all cells.
isNonsingular() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns whether the matrix is nonsingular (has an inverse).
isNonsingular() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns whether the matrix is nonsingular (has an inverse).
isNonsingular() - Method in class Jama.LUDecomposition
Is the matrix nonsingular?
isNonsingular() - Method in class jhplot.math.kalman.jama.LUDecomposition
Is the matrix nonsingular?
isNonsingular() - Method in class jhplot.math.LUDecomposition
Is the matrix nonsingular?
isNonSingular() - Method in interface org.apache.commons.math3.linear.DecompositionSolver
Check if the decomposed matrix is non-singular.
isNonSingular() - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
Check if the decomposed matrix is non-singular.
isNotify() - Method in class org.jfree.chart.JFreeChart
Returns a flag that controls whether or not change events are sent to registered listeners.
isNotify() - Method in class org.jfree.chart.plot.Plot
Returns a flag that controls whether or not change events are sent to registered listeners.
isNull() - Method in class graph.TextLine
 
ISO_8859_1 - Static variable in class org.apache.commons.io.Charsets
Deprecated.
Use Java 7's StandardCharsets
IsoCurve - Class in graph
This class will calculate the constant curve of a given value passing through a grid of values.
IsoCurve() - Constructor for class graph.IsoCurve
Instantiate the class and initialize all the variables
IsoCurve(double[], int, int) - Constructor for class graph.IsoCurve
Instantiate the class and initialize all the variables.
isOdd(int) - Static method in class net.jafama.NumbersUtils
 
isOdd(long) - Static method in class net.jafama.NumbersUtils
 
isOne() - Method in class org.lsmp.djep.sjep.AbstractPNode
 
isOne() - Method in class org.lsmp.djep.sjep.PConstant
 
isOne() - Method in interface org.lsmp.djep.sjep.PNodeI
True if node represents one
isOne(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is a ASTConstant with value Double(1) or Complex(1,0)
isOperator(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is an ASTOpNode
isOperator() - Method in class org.nfunk.jep.ASTFunNode
Returns true if node is an operator.
isOptionSet(String) - Static method in class jhepsim.Options
Whether the specified (boolean) option is set to "true".
isOrdered() - Method in class org.jlab.groot.data.DataVector
 
isOrsonPDFAvailable() - Static method in class org.jfree.chart.util.ExportUtils
Returns true if OrsonPDF is on the classpath, and false otherwise.
isOrthogonal(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A square matrix A is orthogonal if A*transpose(A) = I.
isOutline() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Returns a flag that controls whether or not outlines of the areas are drawn.
isOutline() - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer2
Returns a flag that controls whether or not outlines of the areas are drawn.
isOutline() - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Returns a flag that controls whether or not outlines of the areas are drawn.
isOutlineVisible() - Method in class org.jfree.chart.annotations.XYTextAnnotation
Returns the flag that controls whether or not the outline is drawn.
isOutlineVisible() - Method in class org.jfree.chart.plot.Plot
Returns the flag that controls whether or not the plot outline is drawn.
isOverlapped(Outlier) - Method in class org.jfree.chart.renderer.OutlierList
Returns true if the outlier overlaps, and false otherwise.
isOverlay() - Method in interface hep.lcio.event.MCParticle
True if the particle has been overlayed by the simulation (or digitization) program.
isOverlay() - Method in interface hep.lcio.event.SimTrackerHit
True if the hit has been overlayed by the simulation (or digitization) program.
isOverlay() - Method in class hep.lcio.implementation.event.IMCParticle
 
isOverlay() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
isP2D() - Method in interface jplot3d.SurfaceModel
 
isP2D() - Method in class jplot3d.SurfaceModelCanvas
Is this P2D object?
isP3D() - Method in interface jplot3d.SurfaceModel
 
isP3D() - Method in class jplot3d.SurfaceModelCanvas
Is this P3D object?
isParallelTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Check the instance is parallel to another line.
isParsed() - Method in class jhplot.F1D
If the function is parsed correctly, return true.
isParsed() - Method in class jhplot.F2D
If the function is parsed correctly, return true.
isParsed() - Method in class jhplot.F3D
If the function is parsed correctly, return true.
isParsed() - Method in class jhplot.FProxy
If the function is parsed correctly, return true.
isPlotFunction1() - Method in interface jplot3d.SurfaceModel
Determines whether the first function is selected.
isPlotFunction1() - Method in class jplot3d.SurfaceModelCanvas
 
isPlotFunction2() - Method in interface jplot3d.SurfaceModel
Determines whether the first function is selected.
isPlotFunction2() - Method in class jplot3d.SurfaceModelCanvas
 
isPointInRect(Rectangle2D, double, double) - Static method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Returns true if the specified point (x, y) falls within or on the boundary of the specified rectangle.
isPointInsidePolygon(double[], double[], double, double) - Static method in class jplot.Geometry
Check if a given point is inside a given (complex) polygon.
isPointInsidePolygon(int[], int[], int, int) - Static method in class jplot.Geometry
Check if a given point is inside a given polygon.
isPointInsideRectangle(int, int, int, int, int, int) - Static method in class jplot.Geometry
Check if a specified point is inside a specified rectangle.
isPolygonIntersectingRectangle(int[], int[], int, int, int, int) - Static method in class jplot.Geometry
Check if a specified polygon intersects a specified rectangle.
isPolylineIntersectingRectangle(int[], int[], int, int, int, int) - Static method in class jplot.Geometry
Check if a specified polyline intersects a specified rectangle.
isPositive(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is positive if A[i,j] > 0 holds for all cells.
isPositive() - Method in class org.lsmp.djep.sjep.PConstant
 
isPositive(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is an ASTConstant with a positive Double value
isPositiveArrowVisible() - Method in class org.jfree.chart.axis.ValueAxis
Returns a flag that controls whether or not the axis line has an arrow drawn that points in the positive direction for the axis.
isPowerOfTwo(int) - Static method in class net.jafama.NumbersUtils
 
isPowerOfTwo(long) - Static method in class net.jafama.NumbersUtils
 
isPowerOfTwo(long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Returns true if the argument is a power of two.
isPrefix() - Method in class org.lsmp.djep.xjep.XOperator
 
isPrimary() - Method in interface hep.lcio.event.Vertex
Checks if the Vertex is the primary vertex of the event.
isPrimary() - Method in class hep.lcio.implementation.event.IVertex
 
isPrime(int) - Static method in class org.apache.commons.math3.primes.Primes
Primality test: tells if the argument is a (provable) prime or not.
isPrimitivesToFront() - Method in class jhplot.HPlot
Flag, saying whether primitives should be drawn at the foreground or not.
isProducedBySecondary() - Method in interface hep.lcio.event.SimTrackerHit
True if the particle has been created by a secondary particle that is not stored in the MCParticle collection.
isProducedBySecondary() - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
isPropagateClose() - Method in class org.apache.commons.io.input.BoundedInputStream
Indicates whether the BoundedInputStream.close() method should propagate to the underling InputStream.
isPureQuaternion(double) - Method in class org.apache.commons.math3.complex.Quaternion
Checks whether the instance is a pure quaternion within a given tolerance.
isRadiusGridlinesVisible() - Method in class org.jfree.chart.plot.PolarPlot
Returns true if the radius axis grid is visible, and false otherwise.
isRadiusMinorGridlinesVisible() - Method in class org.jfree.chart.plot.PolarPlot
Return the current value of the flag indicating if radial minor grid-lines will be drawn or not.
isRandomParticleAntiParticle() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
 
isRandomStart() - Method in class org.apache.commons.math3.genetics.CycleCrossover
Returns whether the starting index is chosen randomly or set to zero.
isRangeCrosshairLockedOnData() - Method in class org.jfree.chart.plot.CategoryPlot
Returns a flag indicating whether or not the crosshair should "lock-on" to actual data values.
isRangeCrosshairLockedOnData() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns a flag indicating whether or not the crosshair should "lock-on" to actual data values.
isRangeCrosshairLockedOnData() - Method in class org.jfree.chart.plot.XYPlot
Returns a flag indicating whether or not the crosshair should "lock-on" to actual data values.
isRangeCrosshairVisible() - Method in class org.jfree.chart.plot.CategoryPlot
Returns a flag indicating whether or not the range crosshair is visible.
isRangeCrosshairVisible() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns a flag indicating whether or not the range crosshair is visible.
isRangeCrosshairVisible() - Method in class org.jfree.chart.plot.XYPlot
Returns a flag indicating whether or not the range crosshair is visible.
isRangeGridlinesVisible() - Method in class org.jfree.chart.plot.CategoryPlot
Returns the flag that controls whether the range grid-lines are visible.
isRangeGridlinesVisible() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns true if the range axis grid is visible, and false otherwise.
isRangeGridlinesVisible() - Method in class org.jfree.chart.plot.XYPlot
Returns true if the range axis grid is visible, and false otherwise.
isRangeMinorGridlinesVisible() - Method in class org.jfree.chart.plot.CategoryPlot
Returns true if the range axis minor grid is visible, and false otherwise.
isRangeMinorGridlinesVisible() - Method in class org.jfree.chart.plot.XYPlot
Returns true if the range axis minor grid is visible, and false otherwise.
isRangePannable() - Method in class org.jfree.chart.plot.CategoryPlot
Returns true if panning is enabled for the range axes, and false otherwise.
isRangePannable() - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Returns true if the range is pannable for at least one subplot, and false otherwise.
isRangePannable() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns true if panning is enabled for the range axes, and false otherwise.
isRangePannable() - Method in interface org.jfree.chart.plot.Pannable
Evaluates if the range axis can be panned.
isRangePannable() - Method in class org.jfree.chart.plot.XYPlot
Returns true if panning is enabled for the range axis/axes, and false otherwise.
isRangeZeroBaselineVisible() - Method in class org.jfree.chart.plot.CategoryPlot
Returns a flag that controls whether or not a zero baseline is displayed for the range axis.
isRangeZeroBaselineVisible() - Method in class org.jfree.chart.plot.XYPlot
Returns a flag that controls whether or not a zero baseline is displayed for the range axis.
isRangeZoomable() - Method in class org.jfree.chart.ChartPanel
Returns the flag that determines whether or not zooming is enabled for the range axis.
isRangeZoomable() - Method in class org.jfree.chart.plot.CategoryPlot
Returns true to indicate that the range axes are zoomable.
isRangeZoomable() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns false.
isRangeZoomable() - Method in class org.jfree.chart.plot.FastScatterPlot
Returns true.
isRangeZoomable() - Method in class org.jfree.chart.plot.PolarPlot
Returns true to indicate that the range axis is zoomable.
isRangeZoomable() - Method in class org.jfree.chart.plot.ThermometerPlot
Returns true.
isRangeZoomable() - Method in class org.jfree.chart.plot.XYPlot
Returns true, indicating that the range axis/axes for this plot are zoomable.
isRangeZoomable() - Method in interface org.jfree.chart.plot.Zoomable
Returns true if the plot's range is zoomable, and false otherwise.
isReal(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is a ASTConstant with Double value
isRebinnable() - Method in class cern.hep.aida.bin.AbstractBin
Returns whether a client can obtain all elements added to the receiver.
isRebinnable() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns true.
isRebinnable() - Method in class cern.hep.aida.bin.StaticBin1D
Returns false.
isReflexive() - Method in class org.lsmp.djep.xjep.XOperator
 
isRenderAsPoints() - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the renderAsPoints.
isRequired() - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
isReservedFileName(CharSequence) - Method in enum org.apache.commons.io.FileSystem
Returns whether the given string is a reserved file name.
isResizable() - Method in class org.jfree.chart.fx.ChartCanvas
Return true to indicate the canvas is resizable.
isRestrictedToNonNegative() - Method in class org.apache.commons.math3.optim.linear.NonNegativeConstraint
Indicates whether all the variables must be restricted to non-negative values.
isRowDimension(double[][], int) - Static method in class jhplot.math.DoubleArray
Same as checkRowDimension() but just returns a boolean value rather than throwing an exception.
isSatisfied(Population) - Method in class org.apache.commons.math3.genetics.FixedElapsedTime
Determine whether or not the maximum allowed time has passed.
isSatisfied(Population) - Method in class org.apache.commons.math3.genetics.FixedGenerationCount
Determine whether or not the given number of generations have passed.
isSatisfied(Population) - Method in interface org.apache.commons.math3.genetics.StoppingCondition
Determine whether or not the given population satisfies the stopping condition.
isScaleBox - Variable in class jplot3d.JSurface
 
isScaleBox() - Method in interface jplot3d.SurfaceModel
Determines whether to scale axes and bounding box.
isScaleBox() - Method in class jplot3d.SurfaceModelCanvas
 
isSecondFunctionOnly() - Method in class jplot3d.SurfaceModelCanvas
 
isSelected(int) - Method in class jplot.DataFile
Checks whether the argument is a column selected for output.
isSelected() - Method in class jplot.Utils.LabeledTextField
 
isSelfInverse() - Method in class org.lsmp.djep.xjep.XOperator
 
isSequence(double, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Check whether the arguments form a (strictly) increasing sequence.
isSeriesFilled(int) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Returns true if the renderer should fill the specified series, and false otherwise.
isSeriesItemLabelsVisible(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns true if the item labels for a series are visible, and false otherwise.
isSeriesItemLabelsVisible(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns true if the item labels for a series are visible, and false otherwise.
isSeriesItemLabelsVisible(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns true if the item labels for a series are visible, and false otherwise.
isSeriesVisible(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns a boolean that indicates whether or not the specified series should be drawn.
isSeriesVisible(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns a boolean that indicates whether or not the specified series should be drawn (this is typically used to hide an entire series).
isSeriesVisible(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns a boolean that indicates whether or not the specified series should be drawn (this is typically used to hide an entire series).
isSeriesVisibleInLegend(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns true if the series should be shown in the legend, and false otherwise.
isSeriesVisibleInLegend(int) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Returns true if the series should be shown in the legend, and false otherwise.
isSeriesVisibleInLegend(int) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Returns true if the series should be shown in the legend, and false otherwise.
isShadowVisible() - Method in class org.jfree.chart.StandardChartTheme
Returns the shadow visibility flag.
isShapeFilled() - Method in class org.jfree.chart.LegendItem
Returns a flag that controls whether or not the shape is filled.
isShapeFilled() - Method in class org.jfree.chart.title.LegendGraphic
Returns a flag that controls whether or not the shapes are filled.
isShapeOutlineVisible() - Method in class org.jfree.chart.LegendItem
Returns the flag that controls whether or not the shape outline is visible.
isShapeOutlineVisible() - Method in class org.jfree.chart.title.LegendGraphic
Returns a flag that controls whether the shape outline is visible.
isShapesFilled() - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Returns the flag that controls whether or not the shapes are filled.
isShapeVisible() - Method in class org.jfree.chart.LegendItem
Returns a flag that indicates whether or not the shape is visible.
isShapeVisible() - Method in class org.jfree.chart.title.LegendGraphic
Returns a flag that controls whether or not the shape is visible.
isShowAxis() - Method in class org.jlab.groot.graphics.GraphicsAxis
 
isSignedPowerOfTwo(int) - Static method in class net.jafama.NumbersUtils
 
isSignedPowerOfTwo(long) - Static method in class net.jafama.NumbersUtils
 
isSimilarTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Check if the instance is similar to another line.
isSimilarTo(Plane) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Check if the instance is similar to another plane.
isSingular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is singular if it has no inverse, that is, iff det(A)==0.
isSingular(double) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns whether this diagonal matrix is singular, i.e.
isSkewSymmetric(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A square matrix A is skew-symmetric if A = -transpose(A), that is A[i,j] == -A[j,i].
isSolutionOptimal() - Method in class org.apache.commons.math3.optim.linear.SolutionCallback
Returns if the found solution is optimal.
isSortedFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Determines whether the receiver is sorted ascending, according to the natural ordering of its elements.
isSpacelike() - Method in class hephysics.vec.HepLorentzVector
Is particle spacelike (i.e restMass2() smaller than 0)
isSPD() - Method in class Jama.CholeskyDecomposition
Is the matrix symmetric and positive definite?
isSPD() - Method in class jhplot.math.CholeskyDecomposition
Is the matrix symmetric and positive definite?
isSpectrumMode() - Method in class jplot3d.SurfaceModelCanvas
 
isSquare(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is square if it has the same number of rows and columns.
isSquare(double[][]) - Static method in class jhplot.math.ArrayMathUtils
 
isSquare(float[][]) - Static method in class jhplot.math.ArrayMathUtils
 
isSquare(long[][]) - Static method in class jhplot.math.ArrayMathUtils
 
isSquare(int[][]) - Static method in class jhplot.math.ArrayMathUtils
 
isSquare(Object[][]) - Static method in class jhplot.math.ArrayMathUtils
 
isSquare() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Is this a square matrix?
isSquare() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Is this a square matrix?
isSquare() - Method in interface org.apache.commons.math3.linear.AnyMatrix
Is this a square matrix?
isStepped() - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Returns the 'is-stepped' flag.
isStopped() - Method in interface hep.lcio.event.MCParticle
True if the particle lost all kinetic energy inside the world volume and did not decay
isStopped() - Method in class hep.lcio.implementation.event.IMCParticle
 
isStrictlyLowerTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is strictly lower triangular if A[i,j]==0 whenever i <= j.
isStrictlyTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is strictly triangular if it is triangular and its diagonal elements all equal 0.
isStrictlyUpperTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is strictly upper triangular if A[i,j]==0 whenever i >= j.
isStripOutlineVisible() - Method in class org.jfree.chart.title.PaintScaleLegend
Returns the flag that controls whether or not an outline is drawn around the paint strip.
isSubplot() - Method in class org.jfree.chart.plot.Plot
Returns true if this plot is part of a combined plot structure (that is, Plot.getParent() returns a non-null value), and false otherwise.
isSubset() - Method in interface hep.lcio.event.LCCollection
True if the collection holds a subset of objects from other collections.
isSubset() - Method in class hep.lcio.implementation.event.ILCCollection
 
isSufix() - Method in class org.lsmp.djep.xjep.XOperator
 
isSupportConnected() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.FDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.GeometricDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.GumbelDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.LevyDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.LogisticDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.NakagamiDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.TDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Use this method to get information about whether the support is connected, i.e.
isSupported(String) - Method in class org.apache.commons.math3.ode.AbstractParameterizable
Check if a parameter is supported.
isSupported(String) - Method in interface org.apache.commons.math3.ode.Parameterizable
Check if a parameter is supported.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.FDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.GumbelDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.LevyDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.LogisticDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.NakagamiDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Deprecated.
to be removed in 4.0
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.TDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.FDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.GumbelDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.LaplaceDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.LevyDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.LogisticDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.NakagamiDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Deprecated.
to be removed in 4.0
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.TDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSurface() - Method in class jhplot.HPlot3D
Is the plot will be shown as a surface?
isSurfaceType() - Method in class jplot3d.SurfaceModelCanvas
 
isSymlink(File) - Static method in class org.apache.commons.io.FileUtils
Determines whether the specified file is a Symbolic Link rather than an actual file.
isSymmetric(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is symmetric if A = tranpose(A), that is A[i,j] == A[j,i].
isSymmetric(RealMatrix, double) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Checks whether a matrix is symmetric.
isSymmetric() - Method in class org.lsmp.djep.xjep.XOperator
 
isSymmetricPositiveDefinite() - Method in class cern.colt.matrix.linalg.CholeskyDecomposition
Returns whether the matrix A is symmetric and positive definite.
isTaggedWith(Throwable, Object) - Static method in exception org.apache.commons.io.TaggedIOException
Checks whether the given throwable is tagged with the given tag.
isThresholdExceeded() - Method in class org.apache.commons.io.output.ThresholdingOutputStream
Determines whether or not the configured threshold has been exceeded for this output stream.
isTickLabelsVisible() - Method in class org.jfree.chart.axis.Axis
Returns a flag indicating whether or not the tick labels are visible.
isTickMarksVisible() - Method in class org.jfree.chart.axis.Axis
Returns the flag that indicates whether or not the tick marks are showing.
isTicLabelsShown(int) - Method in class jhplot.HPlot
Returns whether or not to draw the tick labels
isTicsShown(int) - Method in class jhplot.HPlot
Returns whether or not to draw ticks (little lines on the axes).
isTimeSeries() - Method in class org.jfree.data.jdbc.JDBCXYDataset
Returns true if the dataset represents time series data, and false otherwise.
isTooltipEnabled() - Method in class org.jfree.chart.fx.ChartCanvas
Returns the flag that controls whether or not tooltips are enabled.
isTooltipEnabled() - Method in class org.jfree.chart.fx.ChartViewer
Returns the flag that controls whether or not tooltips are displayed for the chart.
isTransient() - Method in interface hep.lcio.event.LCCollection
True if collection is transient, i.e.
isTransient() - Method in class hep.lcio.implementation.event.ILCCollection
 
isTransitive() - Method in class org.lsmp.djep.xjep.XOperator
 
isTransposable() - Method in class org.apache.commons.math3.linear.RealLinearOperator
Returns true if this operator supports RealLinearOperator.operateTranspose(RealVector).
isTransposed() - Method in class org.jfree.data.gantt.XYTaskDataset
Returns a flag that indicates whether or not the dataset is transposed.
isTrapNullValues() - Method in class org.nfunk.jep.EvaluatorVisitor
Tests whether null variable values are trapped by evaluator.
isTree(String) - Method in class org.jlab.groot.studio.StudioUI
 
isTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is triangular iff it is either upper or lower triangular.
isTridiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is tridiagonal if A[i,j]==0 whenever Math.abs(i-j) > 1.
isUnary() - Method in class org.lsmp.djep.xjep.XOperator
 
isUnaryOperator(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
 
isUnitQuaternion(double) - Method in class org.apache.commons.math3.complex.Quaternion
Checks whether the instance is a unit quaternion within a given tolerance.
isUnitTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is unit triangular if it is triangular and its diagonal elements all equal 1.
isUnix() - Static method in class jplot.Utils
Says whether we're running on a UNIX platform or not.
isUpperBidiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is upper bidiagonal if A[i,j]==0 unless i==j || i==j-1.
isUpperTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is upper triangular if A[i,j]==0 whenever i > j.
isValid() - Method in class jhplot.math.exp4j.ValidationResult
Check if an expression has been validated successfully
isValid() - Method in class org.freehep.math.minuit.FunctionMinimum
In general, if this returns true, the minimizer did find a minimum without running into troubles.
isValid() - Method in class org.freehep.math.minuit.MinosError
 
isValid() - Method in class org.freehep.math.minuit.MnGlobalCorrelationCoeff
 
isValid() - Method in class org.freehep.math.minuit.MnUserParameterState
Returns true if the the state is valid, false if not
isValid(ITree) - Method in class org.jlab.groot.tree.TreeCut
 
isValid(Tree) - Method in class org.jlab.groot.tree.TreeSelector
 
isValidBitSizeForSignedInt(int) - Static method in class net.jafama.NumbersUtils
 
isValidBitSizeForSignedLong(int) - Static method in class net.jafama.NumbersUtils
 
isValidBitSizeForUnsignedInt(int) - Static method in class net.jafama.NumbersUtils
 
isValidBitSizeForUnsignedLong(int) - Static method in class net.jafama.NumbersUtils
 
isValidFunctionName(String) - Static method in class jhplot.math.exp4j.function.Function
 
isValidId(int) - Static method in class j4np.physics.PDGDatabase
 
isValidPid(int) - Static method in class j4np.physics.PDGDatabase
 
isValidPoint(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicInterpolatingFunction
Indicates whether a point is within the interpolation range.
isValidPoint(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
Deprecated.
Indicates whether a point is within the interpolation range.
isValidPoint(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.PiecewiseBicubicSplineInterpolatingFunction
Indicates whether a point is within the interpolation range.
isValidPoint(double, double, double) - Method in class org.apache.commons.math3.analysis.interpolation.TricubicInterpolatingFunction
Indicates whether a point is within the interpolation range.
isValidPoint(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Indicates whether a point is within the interpolation range.
isVariable(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is an ASTVarNode
isVertical() - Method in class graph.Axis
If the Axis is Vertical return true.
isVertical() - Method in class org.jfree.chart.plot.PlotOrientation
Returns true if this orientation is VERTICAL, and false otherwise.
isVerticalTickLabels() - Method in class org.jfree.chart.axis.ValueAxis
Returns true if the tick labels should be rotated (to vertical), and false otherwise.
isVisible() - Method in class org.jfree.chart.axis.Axis
Returns true if the axis is visible, and false otherwise.
isVisible() - Method in class org.jfree.chart.plot.Crosshair
Returns the flag that indicates whether or not the crosshair is currently visible.
isVisible() - Method in class org.jfree.chart.plot.dial.AbstractDialLayer
Returns true if this layer is visible (should be displayed), and false otherwise.
isVisible() - Method in interface org.jfree.chart.plot.dial.DialLayer
Returns a flag that indicates whether or not the layer is visible.
isVisible() - Method in class org.jfree.chart.title.Title
Returns a flag that controls whether or not the title should be drawn.
isWebFilled() - Method in class org.jfree.chart.plot.SpiderWebPlot
Method to determine if the web chart is to be filled.
isWireframeType() - Method in class jplot3d.SurfaceModelCanvas
 
isZero(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is zero if all its cells are zero.
isZero() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is equal to zero.
isZero() - Method in class org.lsmp.djep.sjep.AbstractPNode
 
isZero() - Method in class org.lsmp.djep.sjep.PConstant
 
isZero() - Method in interface org.lsmp.djep.sjep.PNodeI
True if node represents zero
isZero(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is a ASTConstant with value Double(0) or Complex(0,0)
isZero(Node, double) - Method in class org.lsmp.djep.xjep.TreeUtils
returns true if node is a ASTConstant with value Double(0) or Complex(0,0)
item1 - Variable in class jplot3d.JSurface
 
item1 - Variable in class jplot3dp.ModelView
 
item2 - Variable in class jplot3d.JSurface
 
item2 - Variable in class jplot3dp.ModelView
 
item3 - Variable in class jplot3dp.ModelView
 
item4 - Variable in class jplot3dp.ModelView
 
item5 - Variable in class jplot3dp.ModelView
 
item6 - Variable in class jplot3dp.ModelView
 
item7 - Variable in class jplot3dp.ModelView
 
ITEM_TAG - Static variable in interface org.jfree.data.xml.DatasetTags
The 'Item' element name.
ItemHandler - Class in org.jfree.data.xml
A handler for reading key-value items.
ItemHandler(RootHandler, DefaultHandler) - Constructor for class org.jfree.data.xml.ItemHandler
Creates a new item handler.
ItemLabelAnchor - Class in org.jfree.chart.labels
An enumeration of the positions that a value label can take, relative to an item in a CategoryPlot.
ItemLabelPosition - Class in org.jfree.chart.labels
The attributes that control the position of the label for each data item on a chart.
ItemLabelPosition() - Constructor for class org.jfree.chart.labels.ItemLabelPosition
Creates a new position record with default settings.
ItemLabelPosition(ItemLabelAnchor, TextAnchor) - Constructor for class org.jfree.chart.labels.ItemLabelPosition
Creates a new position record (with zero rotation).
ItemLabelPosition(ItemLabelAnchor, TextAnchor, TextAnchor, double) - Constructor for class org.jfree.chart.labels.ItemLabelPosition
Creates a new position record.
itemStateChanged(ItemEvent) - Method in class jplot.SmallToggleButton
Sets the button to the appropiate state.
iterate(IterativeMethod.IterativeState) - Method in class jhplot.math.num.IterativeMethod
Perform the iterative evaluation.
iterate() - Method in interface jhplot.math.num.IterativeMethod.IterativeState
Perform the next iteration of the iterative evaluation.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Compute the next simplex of the algorithm.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Compute the next simplex of the algorithm.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Compute the next simplex of the algorithm.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated.
Compute the next simplex of the algorithm.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated.
Compute the next simplex of the algorithm.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated.
Compute the next simplex of the algorithm.
iterateCategoryRangeBounds(CategoryDataset, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
iterateDomainBounds(XYDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Iterates over the items in an XYDataset to find the range of x-values.
iterateDomainBounds(XYDataset, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Iterates over the items in an XYDataset to find the range of x-values.
iterateFiles(File, IOFileFilter, IOFileFilter) - Static method in class org.apache.commons.io.FileUtils
Allows iteration over the files in given directory (and optionally its subdirectories).
iterateFiles(File, String[], boolean) - Static method in class org.apache.commons.io.FileUtils
Allows iteration over the files in a given directory (and optionally its subdirectories) which match an array of extensions.
iterateFilesAndDirs(File, IOFileFilter, IOFileFilter) - Static method in class org.apache.commons.io.FileUtils
Allows iteration over the files in given directory (and optionally its subdirectories).
iterateRangeBounds(CategoryDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Iterates over the data item of the category dataset to find the range bounds.
iterateRangeBounds(CategoryDataset, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Iterates over the data item of the category dataset to find the range bounds.
iterateRangeBounds(XYDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Iterates over the data item of the xy dataset to find the range bounds.
iterateRangeBounds(XYDataset, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Iterates over the data items of the xy dataset to find the range bounds.
iterateToFindDomainBounds(XYDataset, List, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the range of x-values in the specified dataset for the data items belonging to the visible series.
iterateToFindRangeBounds(CategoryDataset, List, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Iterates over the data item of the category dataset to find the range bounds.
iterateToFindRangeBounds(XYDataset, List, Range, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the range of y-values in the specified dataset for the data items belonging to the visible series and with x-values in the given range.
iterateToFindZBounds(XYZDataset, List, Range, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Returns the range of z-values in the specified dataset for the data items belonging to the visible series and with x-values in the given range.
iterateXYRangeBounds(XYDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Deprecated.
iterateZBounds(XYZDataset) - Static method in class org.jfree.data.general.DatasetUtilities
Iterates over the data item of the xyz dataset to find the z-dimension bounds.
iterateZBounds(XYZDataset, boolean) - Static method in class org.jfree.data.general.DatasetUtilities
Iterates over the data items of the xyz dataset to find the z-dimension bounds.
IterationEvent - Class in org.apache.commons.math3.util
The root class from which all events occurring while running an IterationManager should be derived.
IterationEvent(Object, int) - Constructor for class org.apache.commons.math3.util.IterationEvent
Creates a new instance of this class.
IterationListener - Interface in org.apache.commons.math3.util
The listener interface for receiving events occurring in an iterative algorithm.
IterationManager - Class in org.apache.commons.math3.util
This abstract class provides a general framework for managing iterative algorithms.
IterationManager(int) - Constructor for class org.apache.commons.math3.util.IterationManager
Creates a new instance of this class.
IterationManager(int, Incrementor.MaxCountExceededCallback) - Constructor for class org.apache.commons.math3.util.IterationManager
IterationManager(int, IntegerSequence.Incrementor.MaxCountExceededCallback) - Constructor for class org.apache.commons.math3.util.IterationManager
Creates a new instance of this class.
iterationPerformed(IterationEvent) - Method in interface org.apache.commons.math3.util.IterationListener
Invoked each time an iteration is completed (in the main iteration loop).
iterationStarted(IterationEvent) - Method in interface org.apache.commons.math3.util.IterationListener
Invoked each time a new iteration is completed (in the main iteration loop).
IterativeLegendreGaussIntegrator - Class in org.apache.commons.math3.analysis.integration
This algorithm divides the integration interval into equally-sized sub-interval and on each of them performs a Legendre-Gauss quadrature.
IterativeLegendreGaussIntegrator(int, double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.IterativeLegendreGaussIntegrator
Builds an integrator with given accuracies and iterations counts.
IterativeLegendreGaussIntegrator(int, double, double) - Constructor for class org.apache.commons.math3.analysis.integration.IterativeLegendreGaussIntegrator
Builds an integrator with given accuracies.
IterativeLegendreGaussIntegrator(int, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.IterativeLegendreGaussIntegrator
Builds an integrator with given iteration counts.
IterativeLinearSolver - Class in org.apache.commons.math3.linear
This abstract class defines an iterative solver for the linear system A · x = b.
IterativeLinearSolver(int) - Constructor for class org.apache.commons.math3.linear.IterativeLinearSolver
Creates a new instance of this class, with default iteration manager.
IterativeLinearSolver(IterationManager) - Constructor for class org.apache.commons.math3.linear.IterativeLinearSolver
Creates a new instance of this class, with custom iteration manager.
IterativeLinearSolverEvent - Class in org.apache.commons.math3.linear
This is the base class for all events occurring during the iterations of a IterativeLinearSolver.
IterativeLinearSolverEvent(Object, int) - Constructor for class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Creates a new instance of this class.
IterativeMethod - Class in jhplot.math.num
A method to solve generic problems by finding successive (and hopefully better) approximations to the solution.
IterativeMethod.IterativeState - Interface in jhplot.math.num
The current state for an iterative method.
iterator() - Method in class org.apache.commons.math3.genetics.ListPopulation
Returns an iterator over the unmodifiable list of chromosomes.
iterator() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
iterator() - Method in class org.apache.commons.math3.geometry.partitioning.NodesSet
iterator() - Method in class org.apache.commons.math3.geometry.spherical.oned.ArcsSet
iterator() - Method in class org.apache.commons.math3.linear.RealVector
Generic dense iterator.
iterator() - Method in class org.apache.commons.math3.ml.neuralnet.Network
iterator() - Method in class org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D
iterator() - Method in class org.apache.commons.math3.util.Combinations
iterator() - Method in class org.apache.commons.math3.util.IntegerSequence.Range
iterator() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Create an iterator over this counter.
iterator() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Get an iterator over map elements.
iterator() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Get an iterator over map elements.
iterator() - Method in interface org.jfree.chart.entity.EntityCollection
Returns an iterator for the entities in the collection.
iterator() - Method in class org.jfree.chart.entity.StandardEntityCollection
Returns an iterator for the entities in the collection.
iterator() - Method in class org.jfree.chart.LegendItemCollection
Returns an iterator that provides access to all the legend items.
iterator() - Method in class org.jfree.chart.renderer.OutlierListCollection
Returns an iterator for the outlier lists.
ITPCHit - Class in hep.lcio.implementation.event
A default implementation of TPCHit
ITPCHit() - Constructor for class hep.lcio.implementation.event.ITPCHit
 
ITrack - Class in hep.lcio.implementation.event
 
ITrack() - Constructor for class hep.lcio.implementation.event.ITrack
 
ITrackerData - Class in hep.lcio.implementation.event
 
ITrackerData() - Constructor for class hep.lcio.implementation.event.ITrackerData
 
ITrackerHit - Class in hep.lcio.implementation.event
 
ITrackerHit() - Constructor for class hep.lcio.implementation.event.ITrackerHit
 
ITrackerHitPlane - Class in hep.lcio.implementation.event
 
ITrackerHitPlane() - Constructor for class hep.lcio.implementation.event.ITrackerHitPlane
 
ITrackerHitZCylinder - Class in hep.lcio.implementation.event
 
ITrackerHitZCylinder() - Constructor for class hep.lcio.implementation.event.ITrackerHitZCylinder
 
ITrackerPulse - Class in hep.lcio.implementation.event
 
ITrackerPulse() - Constructor for class hep.lcio.implementation.event.ITrackerPulse
 
ITrackerRawData - Class in hep.lcio.implementation.event
 
ITrackerRawData() - Constructor for class hep.lcio.implementation.event.ITrackerRawData
 
ITrackState - Class in hep.lcio.implementation.event
 
ITrackState() - Constructor for class hep.lcio.implementation.event.ITrackState
 
ITree - Interface in org.jlab.groot.tree
 
IVertex - Class in hep.lcio.implementation.event
Implementation of Vertex
IVertex() - Constructor for class hep.lcio.implementation.event.IVertex
 

J

J - Static variable in class org.apache.commons.math3.complex.Quaternion
j
j0(double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the first kind of order 0 of the argument.
j0(double) - Static method in class graph.SpecialFunction
 
j1(double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the first kind of order 1 of the argument.
j1(double) - Static method in class graph.SpecialFunction
 
j4np.physics - package j4np.physics
 
jacobian() - Method in interface org.apache.commons.math3.analysis.DifferentiableMultivariateVectorFunction
Deprecated.
Returns the jacobian function.
JacobianFunction - Class in org.apache.commons.math3.analysis.differentiation
Class representing the Jacobian of a multivariate vector function.
JacobianFunction(MultivariateDifferentiableVectorFunction) - Constructor for class org.apache.commons.math3.analysis.differentiation.JacobianFunction
Simple constructor.
JacobianMatrices - Class in org.apache.commons.math3.ode
This class defines a set of secondary equations to compute the Jacobian matrices with respect to the initial state vector and, if any, to some parameters of the primary ODE set.
JacobianMatrices(FirstOrderDifferentialEquations, double[], String...) - Constructor for class org.apache.commons.math3.ode.JacobianMatrices
Simple constructor for a secondary equations set computing Jacobian matrices.
JacobianMatrices(MainStateJacobianProvider, String...) - Constructor for class org.apache.commons.math3.ode.JacobianMatrices
Simple constructor for a secondary equations set computing Jacobian matrices.
JacobianMatrices.MismatchedEquations - Exception in org.apache.commons.math3.ode
Special exception for equations mismatch.
JacobianMultivariateVectorOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector
Deprecated.
All classes and interfaces in this package are deprecated. The optimizers that were provided here were moved to the org.apache.commons.math3.fitting.leastsquares package (cf. MATH-1008).
JacobiPreconditioner - Class in org.apache.commons.math3.linear
This class implements the standard Jacobi (diagonal) preconditioner.
JacobiPreconditioner(double[], boolean) - Constructor for class org.apache.commons.math3.linear.JacobiPreconditioner
Creates a new instance of this class.
JadeE0JetFinder - Class in hep.physics.jet
 
JadeE0JetFinder(double) - Constructor for class hep.physics.jet.JadeE0JetFinder
 
JadeEJetFinder - Class in hep.physics.jet
 
JadeEJetFinder(double) - Constructor for class hep.physics.jet.JadeEJetFinder
 
JadeJetFinder - Class in hep.physics.jet
 
JadeJetFinder(double) - Constructor for class hep.physics.jet.JadeJetFinder
 
JadeP0JetFinder - Class in hep.physics.jet
 
JadeP0JetFinder(double) - Constructor for class hep.physics.jet.JadeP0JetFinder
 
JadePJetFinder - Class in hep.physics.jet
 
JadePJetFinder(double) - Constructor for class hep.physics.jet.JadePJetFinder
 
Jama - package Jama
 
Jama.examples - package Jama.examples
 
Jama.test - package Jama.test
 
Jama.util - package Jama.util
 
JamaConsole - Class in org.lsmp.djepExamples
has support for Jama matrix operations
JamaConsole() - Constructor for class org.lsmp.djepExamples.JamaConsole
 
JamaUtil - Class in org.lsmp.djep.jama
Utility functions for adding Jama matrix functions.
JamaUtil() - Constructor for class org.lsmp.djep.jama.JamaUtil
 
Jampack - package Jampack
 
JampackException - Exception in Jampack
This is the exception class for Jampack.
JampackException() - Constructor for exception Jampack.JampackException
 
JampackException(String) - Constructor for exception Jampack.JampackException
 
java2DToValue(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.CyclicNumberAxis
Converts a coordinate from Java 2D space to data space.
java2DToValue(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.DateAxis
Translates a Java2D coordinate into the corresponding data value.
java2DToValue(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.LogarithmicAxis
Converts a coordinate in Java2D space to the corresponding data value, assuming that the axis runs along one edge of the specified plotArea.
java2DToValue(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.LogAxis
Converts a Java2D coordinate to an axis value, assuming that the axis is aligned to the specified edge of the area.
java2DToValue(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.ModuloAxis
Translates a Java2D coordinate into a data value.
java2DToValue(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.NumberAxis
Converts a coordinate in Java2D space to the corresponding data value, assuming that the axis runs along one edge of the specified dataArea.
java2DToValue(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.PeriodAxis
Converts a coordinate in Java2D space to the corresponding data value, assuming that the axis runs along one edge of the specified dataArea.
java2DToValue(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.ValueAxis
Converts a coordinate in Java2D space to the corresponding data value, assuming that the axis runs along one edge of the specified dataArea.
javaApp - Static variable in interface jminhep.gui.Constants
 
javaApplet - Static variable in interface jminhep.gui.Constants
 
JavaCharStream - Class in org.nfunk.jep
An implementation of interface CharStream, where the stream is assumed to contain only ASCII characters (with java-like unicode escape processing).
JavaCharStream(Reader, int, int, int) - Constructor for class org.nfunk.jep.JavaCharStream
 
JavaCharStream(Reader, int, int) - Constructor for class org.nfunk.jep.JavaCharStream
 
JavaCharStream(Reader) - Constructor for class org.nfunk.jep.JavaCharStream
 
JavaCharStream(InputStream, int, int, int) - Constructor for class org.nfunk.jep.JavaCharStream
 
JavaCharStream(InputStream, int, int) - Constructor for class org.nfunk.jep.JavaCharStream
 
JavaCharStream(InputStream) - Constructor for class org.nfunk.jep.JavaCharStream
 
javascriptEscape(String) - Static method in class org.jfree.chart.imagemap.ImageMapUtilities
Returns a string that is equivalent to the input string, but with special characters converted to JavaScript escape sequences.
JboxX - Static variable in class jminhep.gui.SetEnv
 
JboxY - Static variable in class jminhep.gui.SetEnv
 
JColor - Class in jplot3d
 
JColor(int, int) - Constructor for class jplot3d.JColor
 
JComboCheckBox - Class in org.jlab.groot.ui
 
JComboCheckBox() - Constructor for class org.jlab.groot.ui.JComboCheckBox
 
JComboCheckBox(JCheckBox[]) - Constructor for class org.jlab.groot.ui.JComboCheckBox
 
JComboCheckBox(Vector) - Constructor for class org.jlab.groot.ui.JComboCheckBox
 
JComboCheckBox(ComboBoxModel) - Constructor for class org.jlab.groot.ui.JComboCheckBox
 
JDBCCategoryDataset - Class in org.jfree.data.jdbc
A CategoryDataset implementation over a database JDBC result set.
JDBCCategoryDataset(String, String, String, String) - Constructor for class org.jfree.data.jdbc.JDBCCategoryDataset
Creates a new dataset with a database connection.
JDBCCategoryDataset(Connection) - Constructor for class org.jfree.data.jdbc.JDBCCategoryDataset
Create a new dataset with the given database connection.
JDBCCategoryDataset(Connection, String) - Constructor for class org.jfree.data.jdbc.JDBCCategoryDataset
Creates a new dataset with the given database connection, and executes the supplied query to populate the dataset.
JDBCPieDataset - Class in org.jfree.data.jdbc
A PieDataset that reads data from a database via JDBC.
JDBCPieDataset(String, String, String, String) - Constructor for class org.jfree.data.jdbc.JDBCPieDataset
Creates a new JDBCPieDataset and establishes a new database connection.
JDBCPieDataset(Connection) - Constructor for class org.jfree.data.jdbc.JDBCPieDataset
Creates a new JDBCPieDataset using a pre-existing database connection.
JDBCPieDataset(Connection, String) - Constructor for class org.jfree.data.jdbc.JDBCPieDataset
Creates a new JDBCPieDataset using a pre-existing database connection.
JDBCXYDataset - Class in org.jfree.data.jdbc
This class provides an XYDataset implementation over a database JDBC result set.
JDBCXYDataset(String, String, String, String) - Constructor for class org.jfree.data.jdbc.JDBCXYDataset
Creates a new dataset (initially empty) and establishes a new database connection.
JDBCXYDataset(Connection) - Constructor for class org.jfree.data.jdbc.JDBCXYDataset
Creates a new dataset (initially empty) using the specified database connection.
JDBCXYDataset(Connection, String) - Constructor for class org.jfree.data.jdbc.JDBCXYDataset
Creates a new dataset using the specified database connection, and populates it using data obtained with the supplied query.
JDKRandomGenerator - Class in org.apache.commons.math3.random
Extension of java.util.Random to implement RandomGenerator.
JDKRandomGenerator() - Constructor for class org.apache.commons.math3.random.JDKRandomGenerator
Create a new JDKRandomGenerator with a default seed.
JDKRandomGenerator(int) - Constructor for class org.apache.commons.math3.random.JDKRandomGenerator
Create a new JDKRandomGenerator with the given seed.
JEP - Class in org.nfunk.jep
The JEP class is the main interface with which the user should interact.
JEP() - Constructor for class org.nfunk.jep.JEP
Creates a new JEP instance with the default settings.
JEP(boolean, boolean, boolean, NumberFactory) - Constructor for class org.nfunk.jep.JEP
Creates a new JEP instance with custom settings.
JepTest - Class in org.lsmp.djepJUnit
 
JepTest(String) - Constructor for class org.lsmp.djepJUnit.JepTest
 
JEPTest - Class in org.nfunk.jeptesting
This class is designed for testing the validity of JEP evaluations.
JEPTest(String) - Constructor for class org.nfunk.jeptesting.JEPTest
Creates a new JEPTest instance
jet(int) - Method in class hep.physics.jet.AbstractJetFinder
 
jet(int) - Method in class hep.physics.jet.FixNumberOfJetsFinder
 
jet(int) - Method in interface hep.physics.jet.JetFinder
calculate 4 vector sum for a jet
JetFinder - Interface in hep.physics.jet
Interface to be implemented by all jet finders
JetN2 - Class in hephysics.jet
JetN2 is an implementation of the longitudinally-invariant kT, anti-KT and Cambridge/Aachen clustering algorithms.
JetN2(double, int, String, double) - Constructor for class hephysics.jet.JetN2
Initialize calculations of the longitudinally invariant kT algorithm in inclusive mode.
JetN2(double, String, double) - Constructor for class hephysics.jet.JetN2
Initialize calculations of the longitudinally invariant kT algorithm in inclusive mode.
JetN2(double, double) - Constructor for class hephysics.jet.JetN2
Initialize calculations of the antikT algorithm.
JetN2(double) - Constructor for class hephysics.jet.JetN2
Initialize calculations of the kT algorithm.
JETS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent
 
JFreeChart - Class in org.jfree.chart
A chart class implemented using the Java 2D APIs.
JFreeChart(Plot) - Constructor for class org.jfree.chart.JFreeChart
Creates a new chart based on the supplied plot.
JFreeChart(String, Plot) - Constructor for class org.jfree.chart.JFreeChart
Creates a new chart with the given title and plot.
JFreeChart(String, Font, Plot, boolean) - Constructor for class org.jfree.chart.JFreeChart
Creates a new chart with the given title and plot.
JFreeChartEntity - Class in org.jfree.chart.entity
A class that captures information about an entire chart.
JFreeChartEntity(Shape, JFreeChart) - Constructor for class org.jfree.chart.entity.JFreeChartEntity
Creates a new chart entity.
JFreeChartEntity(Shape, JFreeChart, String) - Constructor for class org.jfree.chart.entity.JFreeChartEntity
Creates a new chart entity.
JFreeChartEntity(Shape, JFreeChart, String, String) - Constructor for class org.jfree.chart.entity.JFreeChartEntity
Creates a new chart entity.
JFreeChartResources - Class in org.jfree.chart.resources
Localised resources for JFreeChart.
JFreeChartResources() - Constructor for class org.jfree.chart.resources.JFreeChartResources
 
jhepsim - package jhepsim
 
jhplot - package jhplot
Main SCaVis numerical and graphical package
JHPlot - Class in jhplot
Show information about jHplot.
JHPlot() - Constructor for class jhplot.JHPlot
 
jhplot.fit - package jhplot.fit
Predefined fit functions for the fit panel (HFit).
jhplot.gui - package jhplot.gui
Commong GUI components
jhplot.io - package jhplot.io
jHPlot IO classes
jhplot.io.db - package jhplot.io.db
 
jhplot.io.images - package jhplot.io.images
 
jhplot.math - package jhplot.math
Math calculations and random numbers.
jhplot.math.exp4j - package jhplot.math.exp4j
 
jhplot.math.exp4j.function - package jhplot.math.exp4j.function
 
jhplot.math.exp4j.operator - package jhplot.math.exp4j.operator
 
jhplot.math.exp4j.shuntingyard - package jhplot.math.exp4j.shuntingyard
 
jhplot.math.exp4j.tokenizer - package jhplot.math.exp4j.tokenizer
 
jhplot.math.io - package jhplot.math.io
IO package for math (based on jmathtools).
jhplot.math.kalman - package jhplot.math.kalman
 
jhplot.math.kalman.jama - package jhplot.math.kalman.jama
 
jhplot.math.num - package jhplot.math.num
Common classes used throughout numerics4j.
jhplot.math.num.integration - package jhplot.math.num.integration
Function interfaces.
jhplot.math.num.pdf - package jhplot.math.num.pdf
Statistical distributions.
jhplot.math.num.random - package jhplot.math.num.random
Random number generators and random variable generators.
jhplot.math.num.root - package jhplot.math.num.root
Function interfaces.
jhplot.math.num.special - package jhplot.math.num.special
Elementary functions not provided by the Java™.
jhplot.math.pca - package jhplot.math.pca
A library implementing Principal Component Analysis (PCA) data transformation; in majority of cases the only class that the library's user should be interested in is the class.
jhplot.math.pca.covmatrixevd - package jhplot.math.pca.covmatrixevd
A package containing two different implementations of the data's covariance matrix eigenvalue decomposition.
jhplot.root - package jhplot.root
Access to ROOT files (based on Tony Johnson's RootHistogramBrowser).
jhplot.security - package jhplot.security
MD5 hash for objects or data files
jhplot.shapes - package jhplot.shapes
SCaVis package to draw java 2D primitives
jhplot.stat - package jhplot.stat
 
jhplot.stat.limit - package jhplot.stat.limit
 
jhplot.utils - package jhplot.utils
Useful classes for verious manipulations and integration with SCaVis
JHPLOT_HTTP - Static variable in class jhplot.gui.HelpBrowser
 
JHreader - Class in jhplot.io
A class to read XML file and build jHPlot graphics.
JHreader() - Constructor for class jhplot.io.JHreader
 
JHwriter - Class in jhplot.io
A class to write graphics in XML file.
JHwriter() - Constructor for class jhplot.io.JHwriter
 
jInfo - Static variable in class jminhep.clcontrol.Global
 
jj_nt - Variable in class jplot3dp.MathParser.MathParser
 
jj_nt - Variable in class org.nfunk.jep.Parser
 
jjnewLexState - Static variable in class org.nfunk.jep.ParserTokenManager
 
jjstrLiteralImages - Static variable in class jplot3dp.MathParser.MathParserTokenManager
 
jjstrLiteralImages - Static variable in class org.nfunk.jep.ParserTokenManager
 
jjtAccept(ParserVisitor, Object) - Method in class org.nfunk.jep.ASTConstant
Accept the visitor.
jjtAccept(ParserVisitor, Object) - Method in class org.nfunk.jep.ASTFunNode
Accept the visitor.
jjtAccept(ParserVisitor, Object) - Method in class org.nfunk.jep.ASTStart
Accept the visitor.
jjtAccept(ParserVisitor, Object) - Method in class org.nfunk.jep.ASTVarNode
Accept the visitor.
jjtAccept(ParserVisitor, Object) - Method in interface org.nfunk.jep.Node
Accept the visitor.
jjtAccept(ParserVisitor, Object) - Method in class org.nfunk.jep.SimpleNode
Accept the visitor.
jjtAddChild(Node, int) - Method in interface org.nfunk.jep.Node
This method tells the node to add its argument to the node's list of children.
jjtAddChild(Node, int) - Method in class org.nfunk.jep.SimpleNode
 
jjtClose() - Method in interface org.nfunk.jep.Node
This method is called after all the child nodes have been added.
jjtClose() - Method in class org.nfunk.jep.SimpleNode
 
JJTCONSTANT - Static variable in interface org.nfunk.jep.ParserTreeConstants
 
JJTFUNNODE - Static variable in interface org.nfunk.jep.ParserTreeConstants
 
jjtGetChild(int) - Method in interface org.nfunk.jep.Node
This method returns a child node.
jjtGetChild(int) - Method in class org.nfunk.jep.SimpleNode
 
jjtGetNumChildren() - Method in interface org.nfunk.jep.Node
Return the number of children the node has.
jjtGetNumChildren() - Method in class org.nfunk.jep.SimpleNode
 
jjtGetParent() - Method in interface org.nfunk.jep.Node
 
jjtGetParent() - Method in class org.nfunk.jep.SimpleNode
 
jjtNodeName - Static variable in interface org.nfunk.jep.ParserTreeConstants
 
jjtOpen() - Method in interface org.nfunk.jep.Node
This method is called after the node has been made the current node.
jjtOpen() - Method in class org.nfunk.jep.SimpleNode
 
jjtSetParent(Node) - Method in interface org.nfunk.jep.Node
This pair of methods are used to inform the node of its parent.
jjtSetParent(Node) - Method in class org.nfunk.jep.SimpleNode
 
JJTSTART - Static variable in interface org.nfunk.jep.ParserTreeConstants
 
JJTVARNODE - Static variable in interface org.nfunk.jep.ParserTreeConstants
 
JJTVOID - Static variable in interface org.nfunk.jep.ParserTreeConstants
 
JKalman - Class in jhplot.math.kalman
Kalman filter (state).
JKalman(int, int, int) - Constructor for class jhplot.math.kalman.JKalman
The construstor allocates JKalman filter and all its matrices and initializes them somehow.
JKalman(int, int) - Constructor for class jhplot.math.kalman.JKalman
Constructor in case of no control.
jminhep.algorithms - package jminhep.algorithms
 
jminhep.clcontrol - package jminhep.clcontrol
 
jminhep.cluster - package jminhep.cluster
jHepWork package for a cluster analysis.
jminhep.gui - package jminhep.gui
 
jminhep.utils - package jminhep.utils
 
jn(int, double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the first kind of order n of the argument.
jn(int, double) - Static method in class graph.SpecialFunction
 
jointMaxVal - Variable in class jhplot.stat.JointProbabilityState
 
JointProbabilityState - Class in jhplot.stat
Calculates the probabilities of each state in a joint random variable.
JointProbabilityState(double[], double[]) - Constructor for class jhplot.stat.JointProbabilityState
Constructor for the JointProbabilityState class.
jointProbMap - Variable in class jhplot.stat.JointProbabilityState
 
joule - Static variable in class cern.clhep.Units
 
JPEG - Static variable in interface org.jfree.chart.encoders.ImageFormat
Joint Photographic Experts Group format - lossy
jplot - package jplot
 
JPlot - Class in jplot
JPLOT: Jan's Plotting Program.
JPlot(JFrame, Vector, File, boolean) - Constructor for class jplot.JPlot
Principal constructor.
JPlot(JFrame) - Constructor for class jplot.JPlot
Another constructor.
JPlot(JFrame, Vector) - Constructor for class jplot.JPlot
Another constructor.
jplot.panels - package jplot.panels
 
jplot3d - package jplot3d
 
jplot3d.draw - package jplot3d.draw
 
jplot3dp - package jplot3dp
 
jplot3dp.MathParser - package jplot3dp.MathParser
 
JPoint - Class in jplot3d
The JPoint defines a plot point in terms of it's X , Y and Z value.
JPoint(double, double, double) - Constructor for class jplot3d.JPoint
Default constructor, initializes the class x- and y values.
JPoint(double, double, double, double) - Constructor for class jplot3d.JPoint
Default constructor, initializes the class x- and y values.
JPoint(double, double, double, double, Color, int) - Constructor for class jplot3d.JPoint
Default constructor, initializes the class x- and y values.
JPoint(JPoint) - Constructor for class jplot3d.JPoint
Another constructor, initializes the class x- and y values.
jSetting - Static variable in class jminhep.clcontrol.Global
 
jShowOption - Static variable in class jminhep.clcontrol.Global
 
JSurface - Class in jplot3d
The class JSurface is responsible for the generation of surface images and user mouse events handling.
JSurface() - Constructor for class jplot3d.JSurface
 
JSurface(SurfaceModel) - Constructor for class jplot3d.JSurface
The constructor of JSurface
JSurfacePanel - Class in jplot3d
 
JSurfacePanel() - Constructor for class jplot3d.JSurfacePanel
 
JThermometer - Class in org.jfree.chart.plot
An initial quick and dirty.
JThermometer() - Constructor for class org.jfree.chart.plot.JThermometer
Default constructor.

K

K - Static variable in class org.apache.commons.math3.complex.Quaternion
k
k0(double) - Static method in class cern.jet.math.Bessel
Returns the modified Bessel function of the third kind of order 0 of the argument.
k0e(double) - Static method in class cern.jet.math.Bessel
Returns the exponentially scaled modified Bessel function of the third kind of order 0 of the argument.
k1(double) - Static method in class cern.jet.math.Bessel
Returns the modified Bessel function of the third kind of order 1 of the argument.
k1e(double) - Static method in class cern.jet.math.Bessel
Returns the exponentially scaled modified Bessel function of the third kind of order 1 of the argument.
k_Boltzmann - Static variable in class cern.clhep.PhysicalConstants
 
KalmanFilter - Class in org.apache.commons.math3.filter
Implementation of a Kalman filter to estimate the state xk of a discrete-time controlled process that is governed by the linear stochastic difference equation:
KalmanFilter(ProcessModel, MeasurementModel) - Constructor for class org.apache.commons.math3.filter.KalmanFilter
Creates a new Kalman filter with the given process and measurement models.
KalmanTest - Class in jhplot.math.kalman
JKalman TestBench
KalmanTest() - Constructor for class jhplot.math.kalman.KalmanTest
Constructor
kelvin - Static variable in class cern.clhep.Units
 
KendallsCorrelation - Class in org.apache.commons.math3.stat.correlation
Implementation of Kendall's Tau-b rank correlation.
KendallsCorrelation() - Constructor for class org.apache.commons.math3.stat.correlation.KendallsCorrelation
Create a KendallsCorrelation instance without data.
KendallsCorrelation(double[][]) - Constructor for class org.apache.commons.math3.stat.correlation.KendallsCorrelation
Create a KendallsCorrelation from a rectangular array whose columns represent values of variables to be correlated.
KendallsCorrelation(RealMatrix) - Constructor for class org.apache.commons.math3.stat.correlation.KendallsCorrelation
Create a KendallsCorrelation from a RealMatrix whose columns represent variables to be correlated.
keV - Static variable in class cern.clhep.Units
 
KEY - Static variable in class jplot.GraphLabel
 
key() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap.Iterator
Get the key of current entry.
key() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap.Iterator
Get the key of current entry.
Key(int) - Constructor for class org.jfree.chart.ChartHints.Key
Creates a new key.
KEY_BEGIN_ELEMENT - Static variable in class org.jfree.chart.ChartHints
The key for a hint to signal the beginning of an element.
KEY_END_ELEMENT - Static variable in class org.jfree.chart.ChartHints
The key for a hint that ends an element.
KEY_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
KEY_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
KEY_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
KEY_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
KEY_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
KEY_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
KEY_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
KEY_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
KEY_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
KEY_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
KEY_SUPPRESS_SHADOW_GENERATION - Static variable in class org.jfree.chart.JFreeChart
The key for a rendering hint that can suppress the generation of a shadow effect when drawing the chart.
KEY_TAG - Static variable in interface org.jfree.data.xml.DatasetTags
The 'Key' element name.
keyDown(Event, int) - Method in class graph.Contour
Add extra events to the G2Dint event handler.
keyDown(Event, int) - Method in class graph.G2Dint
Handle the Key Down events.
keyDown(Event, int) - Method in class graph.Graph2D
Handle keyDown events.
KeyedObject - Class in org.jfree.data
A (key, object) pair.
KeyedObject(Comparable, Object) - Constructor for class org.jfree.data.KeyedObject
Creates a new (key, object) pair.
KeyedObjects - Class in org.jfree.data
A collection of (key, object) pairs.
KeyedObjects() - Constructor for class org.jfree.data.KeyedObjects
Creates a new collection (initially empty).
KeyedObjects2D - Class in org.jfree.data
A data structure that stores zero, one or many objects, where each object is associated with two keys (a 'row' key and a 'column' key).
KeyedObjects2D() - Constructor for class org.jfree.data.KeyedObjects2D
Creates a new instance (initially empty).
KeyedValue - Interface in org.jfree.data
A (key, value) pair.
KeyedValueComparator - Class in org.jfree.data
A utility class that can compare and order two KeyedValue instances and sort them into ascending or descending order by key or by value.
KeyedValueComparator(KeyedValueComparatorType, SortOrder) - Constructor for class org.jfree.data.KeyedValueComparator
Creates a new comparator.
KeyedValueComparatorType - Class in org.jfree.data
Used to indicate the type of a KeyedValueComparator : 'by key' or 'by value'.
KeyedValueDataset - Interface in org.jfree.data.general
A dataset containing a single value.
KeyedValues - Interface in org.jfree.data
An ordered list of (key, value) items where the keys are unique and non-null.
KeyedValues2D - Interface in org.jfree.data
An extension of the Values2D interface where a unique key is associated with the row and column indices.
KeyedValues2DDataset - Interface in org.jfree.data.general
A dataset containing (key, value) data items.
KeyedValuesDataset - Interface in org.jfree.data.general
A dataset containing (key, value) data items.
KeyHandler - Class in org.jfree.data.xml
A SAX handler for reading a key.
KeyHandler(RootHandler, ItemHandler) - Constructor for class org.jfree.data.xml.KeyHandler
Creates a new handler.
keyOf(int) - Method in class cern.colt.map.AbstractDoubleIntMap
Returns the first key the given value is associated with.
keyOf(double) - Method in class cern.colt.map.AbstractIntDoubleMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.AbstractIntIntMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.AbstractIntObjectMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.AbstractLongObjectMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.OpenDoubleIntHashMap
Returns the first key the given value is associated with.
keyOf(double) - Method in class cern.colt.map.OpenIntDoubleHashMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.OpenIntIntHashMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.OpenIntObjectHashMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.OpenLongObjectHashMap
Returns the first key the given value is associated with.
KeypointPNGEncoderAdapter - Class in org.jfree.chart.encoders
Adapter class for the Keypoint PNG Encoder.
KeypointPNGEncoderAdapter() - Constructor for class org.jfree.chart.encoders.KeypointPNGEncoderAdapter
 
keyPressed(KeyEvent) - Method in class org.jlab.groot.base.DatasetAttributes.DatasetAttributesPane
 
keyPressed(KeyEvent) - Method in class org.lsmp.djepExamples.Console
 
keyReleased(KeyEvent) - Method in class org.jlab.groot.base.DatasetAttributes.DatasetAttributesPane
 
keyReleased(KeyEvent) - Method in class org.lsmp.djepExamples.Console
Handles keyRelease events
keys() - Method in class cern.colt.map.AbstractDoubleIntMap
Returns a list filled with all keys contained in the receiver.
keys(DoubleArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.AbstractIntDoubleMap
Returns a list filled with all keys contained in the receiver.
keys(IntArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.AbstractIntIntMap
Returns a list filled with all keys contained in the receiver.
keys(IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.AbstractIntObjectMap
Returns a list filled with all keys contained in the receiver.
keys(IntArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.AbstractLongObjectMap
Returns a list filled with all keys contained in the receiver.
keys(LongArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all keys contained in the receiver into the specified list.
keys(DoubleArrayList) - Method in class cern.colt.map.OpenDoubleIntHashMap
Fills all keys contained in the receiver into the specified list.
keys(IntArrayList) - Method in class cern.colt.map.OpenIntDoubleHashMap
Fills all keys contained in the receiver into the specified list.
keys(IntArrayList) - Method in class cern.colt.map.OpenIntIntHashMap
Fills all keys contained in the receiver into the specified list.
keys(IntArrayList) - Method in class cern.colt.map.OpenIntObjectHashMap
Fills all keys contained in the receiver into the specified list.
keys(LongArrayList) - Method in class cern.colt.map.OpenLongObjectHashMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class hep.physics.event.BaseEvent
 
keys() - Method in interface hep.physics.event.HEPEvent
 
keysSortedByValue(DoubleArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(IntArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(IntArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(LongArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all keys sorted ascending by their associated value into the specified list.
KeyToGroupMap - Class in org.jfree.data
A class that maps keys (instances of Comparable) to groups.
KeyToGroupMap() - Constructor for class org.jfree.data.KeyToGroupMap
Creates a new map with a default group named 'Default Group'.
KeyToGroupMap(Comparable) - Constructor for class org.jfree.data.KeyToGroupMap
Creates a new map with the specified default group.
keyTyped(KeyEvent) - Method in class org.jlab.groot.base.DatasetAttributes.DatasetAttributesPane
 
keyTyped(KeyEvent) - Method in class org.lsmp.djepExamples.Console
 
kg - Static variable in class cern.clhep.Units
 
kGasThreshold - Static variable in class cern.clhep.PhysicalConstants
 
kiloelectronvolt - Static variable in class cern.clhep.Units
 
kilogauss - Static variable in class cern.clhep.Units
 
kilogram - Static variable in class cern.clhep.Units
 
kilohertz - Static variable in class cern.clhep.Units
 
kilometer - Static variable in class cern.clhep.Units
 
kilometer2 - Static variable in class cern.clhep.Units
 
kilometer3 - Static variable in class cern.clhep.Units
 
kilovolt - Static variable in class cern.clhep.Units
 
kind - Variable in class jplot3dp.MathParser.Token
An integer that describes the kind of this token.
kind - Variable in class org.nfunk.jep.Token
An integer that describes the kind of this token.
km - Static variable in class cern.clhep.Units
 
km2 - Static variable in class cern.clhep.Units
 
km3 - Static variable in class cern.clhep.Units
 
KMeansAlg - Class in jminhep.algorithms
The standard K-means algorithm.
KMeansAlg(DataHolder) - Constructor for class jminhep.algorithms.KMeansAlg
Initialize the standard K-means algorithm
KMeansExchangeAlg - Class in jminhep.algorithms
K-means partitioning using exchange method.
KMeansExchangeAlg(DataHolder) - Constructor for class jminhep.algorithms.KMeansExchangeAlg
 
KMeansPlusPlusClusterer<T extends Clusterable> - Class in org.apache.commons.math3.ml.clustering
Clustering algorithm based on David Arthur and Sergei Vassilvitski k-means++ algorithm.
KMeansPlusPlusClusterer(int) - Constructor for class org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer
Build a clusterer.
KMeansPlusPlusClusterer(int, int) - Constructor for class org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer
Build a clusterer.
KMeansPlusPlusClusterer(int, int, DistanceMeasure) - Constructor for class org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer
Build a clusterer.
KMeansPlusPlusClusterer(int, int, DistanceMeasure, RandomGenerator) - Constructor for class org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer
Build a clusterer.
KMeansPlusPlusClusterer(int, int, DistanceMeasure, RandomGenerator, KMeansPlusPlusClusterer.EmptyClusterStrategy) - Constructor for class org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer
Build a clusterer.
KMeansPlusPlusClusterer<T extends Clusterable<T>> - Class in org.apache.commons.math3.stat.clustering
Deprecated.
As of 3.2 (to be removed in 4.0), use KMeansPlusPlusClusterer instead
KMeansPlusPlusClusterer(Random) - Constructor for class org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer
Deprecated.
Build a clusterer.
KMeansPlusPlusClusterer(Random, KMeansPlusPlusClusterer.EmptyClusterStrategy) - Constructor for class org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer
Deprecated.
Build a clusterer.
KMeansPlusPlusClusterer.EmptyClusterStrategy - Enum in org.apache.commons.math3.ml.clustering
Strategies to use for replacing an empty cluster.
KMeansPlusPlusClusterer.EmptyClusterStrategy - Enum in org.apache.commons.math3.stat.clustering
Deprecated.
Strategies to use for replacing an empty cluster.
kn(int, double) - Static method in class cern.jet.math.Bessel
Returns the modified Bessel function of the third kind of order nn of the argument.
known_N_compute_B_and_K(long, double, double, int, double[]) - Static method in class cern.jet.stat.quantile.QuantileFinderFactory
Computes the number of buffers and number of values per buffer such that quantiles can be determined with an approximation error no more than epsilon with a certain probability.
KohonenTrainingTask - Class in org.apache.commons.math3.ml.neuralnet.sofm
Trainer for Kohonen's Self-Organizing Map.
KohonenTrainingTask(Network, Iterator<double[]>, KohonenUpdateAction) - Constructor for class org.apache.commons.math3.ml.neuralnet.sofm.KohonenTrainingTask
Creates a (sequential) trainer for the given network.
KohonenUpdateAction - Class in org.apache.commons.math3.ml.neuralnet.sofm
KohonenUpdateAction(DistanceMeasure, LearningFactorFunction, NeighbourhoodSizeFunction) - Constructor for class org.apache.commons.math3.ml.neuralnet.sofm.KohonenUpdateAction
 
KolmogorovSmirnovDist - Class in jhplot.math
This class computes both the cumulative probability P[D_n <= x] and the complementary cumulative probability P[D_n >= x] of the 2-sided 1-sample Kolmogorov-Smirnov distribution.
KolmogorovSmirnovDist() - Constructor for class jhplot.math.KolmogorovSmirnovDist
 
KolmogorovSmirnovDistribution - Class in org.apache.commons.math3.distribution
Deprecated.
to be removed in version 4.0 - use KolmogorovSmirnovTest
KolmogorovSmirnovDistribution(int) - Constructor for class org.apache.commons.math3.distribution.KolmogorovSmirnovDistribution
Deprecated.
 
kolmogorovSmirnovStatistic(RealDistribution, double[]) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Computes the one-sample Kolmogorov-Smirnov test statistic, \(D_n=\sup_x |F_n(x)-F(x)|\) where \(F\) is the distribution (cdf) function associated with distribution, \(n\) is the length of data and \(F_n\) is the empirical distribution that puts mass \(1/n\) at each of the values in data.
kolmogorovSmirnovStatistic(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Computes the two-sample Kolmogorov-Smirnov test statistic, \(D_{n,m}=\sup_x |F_n(x)-F_m(x)|\) where \(n\) is the length of x, \(m\) is the length of y, \(F_n\) is the empirical distribution that puts mass \(1/n\) at each of the values in x and \(F_m\) is the empirical distribution of the y values.
kolmogorovSmirnovStatistic(RealDistribution, double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
kolmogorovSmirnovStatistic(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
KolmogorovSmirnovTest - Class in org.apache.commons.math3.stat.inference
Implementation of the Kolmogorov-Smirnov (K-S) test for equality of continuous distributions.
KolmogorovSmirnovTest() - Constructor for class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Construct a KolmogorovSmirnovTest instance with a default random data generator.
KolmogorovSmirnovTest(RandomGenerator) - Constructor for class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Deprecated.
kolmogorovSmirnovTest(RealDistribution, double[], boolean) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Computes the p-value, or observed significance level, of a one-sample Kolmogorov-Smirnov test evaluating the null hypothesis that data conforms to distribution.
kolmogorovSmirnovTest(double[], double[], boolean) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Computes the p-value, or observed significance level, of a two-sample Kolmogorov-Smirnov test evaluating the null hypothesis that x and y are samples drawn from the same probability distribution.
kolmogorovSmirnovTest(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Computes the p-value, or observed significance level, of a two-sample Kolmogorov-Smirnov test evaluating the null hypothesis that x and y are samples drawn from the same probability distribution.
kolmogorovSmirnovTest(RealDistribution, double[]) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Computes the p-value, or observed significance level, of a one-sample Kolmogorov-Smirnov test evaluating the null hypothesis that data conforms to distribution.
kolmogorovSmirnovTest(RealDistribution, double[], double) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Performs a Kolmogorov-Smirnov test evaluating the null hypothesis that data conforms to distribution.
kolmogorovSmirnovTest(RealDistribution, double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
kolmogorovSmirnovTest(RealDistribution, double[], boolean) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
kolmogorovSmirnovTest(RealDistribution, double[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
kolmogorovSmirnovTest(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
kolmogorovSmirnovTest(double[], double[], boolean) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
ksSum(double, double, int) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Computes \( 1 + 2 \sum_{i=1}^\infty (-1)^i e^{-2 i^2 t^2} \) stopping when successive partial sums are within tolerance of one another, or when maxIterations partial sums have been computed.
KthSelector - Class in org.apache.commons.math3.util
A Simple Kth selector implementation to pick up the Kth ordered element from a work array containing the input numbers.
KthSelector() - Constructor for class org.apache.commons.math3.util.KthSelector
Constructor with default median of 3 pivoting strategy
KthSelector(PivotingStrategyInterface) - Constructor for class org.apache.commons.math3.util.KthSelector
Constructor with specified pivoting strategy
KTjet - Class in hephysics.jet
Longitudinally-invariant kT, anti-KT and Cambridge/Aachen clustering algorithms (light-weight implementation).
KTjet(double, int, int, double) - Constructor for class hephysics.jet.KTjet
Initialize calculations of the longitudinally invariant kT algorithm in inclusive mode.
KTjet(double, int, double) - Constructor for class hephysics.jet.KTjet
Initialize calculations of the KT algorithm.
KTjet(double, double) - Constructor for class hephysics.jet.KTjet
Initialize calculations of the KT algorithm.
kurtosis() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the kurtosis (aka excess), which is -3 + moment(4,mean()) / standardDeviation()4.
kurtosis(double, double) - Static method in class cern.jet.stat.Descriptive
Returns the kurtosis (aka excess) of a data sequence.
kurtosis(DoubleArrayList, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the kurtosis (aka excess) of a data sequence, which is -3 + moment(data,4,mean) / standardDeviation4.
kurtosis() - Method in class jhplot.P0D
Returns the kurtosis.
kurtosis() - Method in class jhplot.P0I
Returns the kurtosis.
Kurtosis - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the Kurtosis of the available values.
Kurtosis() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Construct a Kurtosis
Kurtosis(FourthMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Construct a Kurtosis from an external moment
Kurtosis(Kurtosis) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Copy constructor, creates a new Kurtosis identical to the original

L

L - Variable in class Jampack.Zludpp
The lower triangular matrix L
LabelBlock - Class in org.jfree.chart.block
A block containing a label.
LabelBlock(String) - Constructor for class org.jfree.chart.block.LabelBlock
Creates a new label block.
LabelBlock(String, Font) - Constructor for class org.jfree.chart.block.LabelBlock
Creates a new label block.
LabelBlock(String, Font, Paint) - Constructor for class org.jfree.chart.block.LabelBlock
Creates a new label block.
labeledComponent(String, JComponent, boolean) - Static method in class jplot3d.Utils
 
labelPanel - Variable in class jplot.JPlot
 
LabelProperties - Class in jplot
This class pops up a panel with settings used by the labels.
LabelProperties(JPlot) - Constructor for class jplot.LabelProperties
Principal constructor.
lag1(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the lag-1 autocorrelation of a dataset; Note that this method has semantics different from autoCorrelation(..., 1);
laguerre(double, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Deprecated.
This method should not be part of the public API: It will be made private in version 4.0.
LaguerreSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Laguerre's Method for root finding of real coefficient polynomials.
LaguerreSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Construct a solver with default accuracy (1e-6).
LaguerreSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Construct a solver.
LaguerreSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Construct a solver.
LaguerreSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Construct a solver.
lanczos(double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the Lanczos approximation used to compute the gamma function.
LANCZOS_G - Static variable in class org.apache.commons.math3.special.Gamma
The value of the g constant in the Lanczos approximation, see Gamma.lanczos(double).
Landau - Class in jhplot.fit
The function represents the Landau distribution.
Landau() - Constructor for class jhplot.fit.Landau
 
Landau(String) - Constructor for class jhplot.fit.Landau
 
Landau(String[], String[]) - Constructor for class jhplot.fit.Landau
 
landau(double, double, double) - Static method in class org.jlab.groot.math.FunctionFactory
 
LANGU - Static variable in class jminhep.gui.SetEnv
 
Laplace - Class in jhplot.math.num.pdf
The Laplace distribution.
Laplace() - Constructor for class jhplot.math.num.pdf.Laplace
Default constructor.
Laplace(double, double) - Constructor for class jhplot.math.num.pdf.Laplace
Create a distribution with the given mean and scale.
LaplaceDistribution - Class in org.apache.commons.math3.distribution
This class implements the Laplace distribution.
LaplaceDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.LaplaceDistribution
Build a new instance.
LaplaceDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.LaplaceDistribution
Build a new instance.
LaplaceRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Laplace distribution.
LaplaceRandomVariable() - Constructor for class jhplot.math.num.random.LaplaceRandomVariable
Default constructor.
LaplaceRandomVariable(double, double) - Constructor for class jhplot.math.num.random.LaplaceRandomVariable
Create a random variable with the given mean and scale.
LaplaceRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.LaplaceRandomVariable
Create a random variable with the given parameters.
LargeExpressionTest - Class in org.nfunk.jepexamples
This example tests how the evaluation time is influenced by the size of the expression and symbol table.
LargeExpressionTest() - Constructor for class org.nfunk.jepexamples.LargeExpressionTest
 
largestPrime - Static variable in class cern.colt.map.PrimeFinder
The largest prime this class can generate; currently equal to Integer.MAX_VALUE.
LAST_HOUR_IN_DAY - Static variable in class org.jfree.data.time.Hour
Useful constant for the last hour in the day.
LAST_MILLISECOND_IN_SECOND - Static variable in class org.jfree.data.time.Millisecond
A constant for the last millisecond in a second.
LAST_MINUTE_IN_HOUR - Static variable in class org.jfree.data.time.Minute
Useful constant for the last minute in a day.
LAST_MONTH_IN_QUARTER - Static variable in class org.jfree.data.time.Quarter
The last month in each quarter.
LAST_QUARTER - Static variable in class org.jfree.data.time.Quarter
Constant for quarter 4.
LAST_SECOND_IN_MINUTE - Static variable in class org.jfree.data.time.Second
Useful constant for the last second in a minute.
LAST_WEEK_IN_YEAR - Static variable in class org.jfree.data.time.Week
Constant for the last week in the year.
lastIncluded() - Method in enum org.apache.commons.math3.ode.sampling.StepNormalizerBounds
Returns a value indicating whether the last point should be passed to the underlying fixed step size step handler.
lastIndexOf(boolean) - Method in class cern.colt.list.AbstractBooleanList
Returns the index of the last occurrence of the specified element.
lastIndexOf(byte) - Method in class cern.colt.list.AbstractByteList
Returns the index of the last occurrence of the specified element.
lastIndexOf(char) - Method in class cern.colt.list.AbstractCharList
Returns the index of the last occurrence of the specified element.
lastIndexOf(double) - Method in class cern.colt.list.AbstractDoubleList
Returns the index of the last occurrence of the specified element.
lastIndexOf(float) - Method in class cern.colt.list.AbstractFloatList
Returns the index of the last occurrence of the specified element.
lastIndexOf(int) - Method in class cern.colt.list.AbstractIntList
Returns the index of the last occurrence of the specified element.
lastIndexOf(long) - Method in class cern.colt.list.AbstractLongList
Returns the index of the last occurrence of the specified element.
lastIndexOf(short) - Method in class cern.colt.list.AbstractShortList
Returns the index of the last occurrence of the specified element.
lastIndexOf(Object, boolean) - Method in class cern.colt.list.ObjectArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOf(int, int) - Method in class jhplot.P0D
Searches the list back to front for the last index of value, starting at offset.
lastIndexOf(int, int) - Method in class jhplot.P0I
Searches the list back to front for the last index of value, starting at offset.
lastIndexOf(double, double) - Method in class jhplot.P1D
Searches for the index of value, starting at offset, but backwards Here we search for (X,Y) pairs only.
lastIndexOfFromTo(boolean, int, int) - Method in class cern.colt.list.AbstractBooleanList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(byte, int, int) - Method in class cern.colt.list.AbstractByteList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(char, int, int) - Method in class cern.colt.list.AbstractCharList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(double, int, int) - Method in class cern.colt.list.AbstractDoubleList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(float, int, int) - Method in class cern.colt.list.AbstractFloatList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(int, int, int) - Method in class cern.colt.list.AbstractIntList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(long, int, int) - Method in class cern.colt.list.AbstractLongList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(short, int, int) - Method in class cern.colt.list.AbstractShortList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(boolean, int, int) - Method in class cern.colt.list.BooleanArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(byte, int, int) - Method in class cern.colt.list.ByteArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(char, int, int) - Method in class cern.colt.list.CharArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(double, int, int) - Method in class cern.colt.list.DoubleArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(float, int, int) - Method in class cern.colt.list.FloatArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(int, int, int) - Method in class cern.colt.list.IntArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(long, int, int) - Method in class cern.colt.list.LongArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(Object, int, int, boolean) - Method in class cern.colt.list.ObjectArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(short, int, int) - Method in class cern.colt.list.ShortArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfX(double) - Method in class jhplot.P1D
Searches for value in X backwards.
lastIndexOfY(double) - Method in class jhplot.P1D
Searches for a Y value backewards.
LastLocation - Static variable in interface hep.lcio.event.TrackState
 
LASTMODIFIED_COMPARATOR - Static variable in class org.apache.commons.io.comparator.LastModifiedFileComparator
Last modified comparator instance.
LASTMODIFIED_REVERSE - Static variable in class org.apache.commons.io.comparator.LastModifiedFileComparator
Reverse last modified comparator instance.
LastModifiedFileComparator - Class in org.apache.commons.io.comparator
Compare the last modified date/time of two files for order (see File.lastModified()).
LastModifiedFileComparator() - Constructor for class org.apache.commons.io.comparator.LastModifiedFileComparator
 
lastText - Variable in class graph.Graph2D
Text to be painted Last onto the Graph Canvas.
LatexText - Class in org.jlab.groot.ui
 
LatexText(String, double, double) - Constructor for class org.jlab.groot.ui.LatexText
 
LatexText(String) - Constructor for class org.jlab.groot.ui.LatexText
 
LatexTextTools - Class in org.jlab.groot.ui
 
LatexTextTools() - Constructor for class org.jlab.groot.ui.LatexTextTools
 
LayeredBarRenderer - Class in org.jfree.chart.renderer.category
A CategoryItemRenderer that represents data using bars which are superimposed.
LayeredBarRenderer() - Constructor for class org.jfree.chart.renderer.category.LayeredBarRenderer
Default constructor.
layoutContainer(Container) - Method in class jhplot.gui.VariableSizeGridLayout
 
lazyEvaluation(boolean) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure whether evaluation will be lazy or not.
LCCollection - Interface in hep.lcio.event
The generic collection used in LCIO.
LCCOLLECTION - Static variable in interface hep.lcio.event.LCIO
 
LCEvent - Interface in hep.lcio.event
The main event interface.
LCEVENT - Static variable in interface hep.lcio.event.LCIO
 
LCEventDiff - Class in hep.lcio.util
 
LCEventDiff() - Constructor for class hep.lcio.util.LCEventDiff
 
LCEventListener - Interface in hep.lcio.io
Listener for the occurence of LCEvents when reading a stream.
LCFactory - Class in hep.lcio.implementation.io
 
LCFactory() - Constructor for class hep.lcio.implementation.io.LCFactory
 
LCFlag - Interface in hep.lcio.event
Helper class to create and interpret the 32-bit flag word in LCCollections.
LCFloatVec - Interface in hep.lcio.data
Deprecated. 
LCFloatVec - Interface in hep.lcio.event
Float vector used for user extensions.
LCFLOATVEC - Static variable in interface hep.lcio.event.LCIO
 
LCGenericObject - Interface in hep.lcio.event
Simple interface to store generic user data.
LCGENERICOBJECT - Static variable in interface hep.lcio.event.LCIO
 
LCIntVec - Interface in hep.lcio.data
Deprecated. 
LCIntVec - Interface in hep.lcio.event
Int vector used for user extensions.
LCINTVEC - Static variable in interface hep.lcio.event.LCIO
 
LCIO - Interface in hep.lcio.event
Global constants used in LCIO.
LCIOConcat - Class in hep.lcio.util
 
LCIOConcat() - Constructor for class hep.lcio.util.LCIOConcat
 
LCIOSplitter - Class in hep.lcio.util
 
LCIOSplitter() - Constructor for class hep.lcio.util.LCIOSplitter
Creates a new instance of LCIOSplitter
lcm(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Returns the least common multiple of the absolute value of two numbers, using the formula lcm(a,b) = (a / gcd(a,b)) * b.
lcm(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Returns the least common multiple of the absolute value of two numbers, using the formula lcm(a,b) = (a / gcd(a,b)) * b.
LCObject - Interface in hep.lcio.event
The generic object that is held in an LCCollection.
LCParameters - Interface in hep.lcio.event
Simple interface to store generic named parameters of type int, float and string.
LCReader - Interface in hep.lcio.io
Interface for reading data from LCIO.
LCREL_WEIGHTED - Static variable in interface hep.lcio.event.LCIO
 
LCRELATION - Static variable in interface hep.lcio.event.LCIO
 
LCRelation - Interface in hep.lcio.event
A single weighted relationship between two LCObjects.
LCRUNHEADER - Static variable in interface hep.lcio.event.LCIO
 
LCRunHeader - Interface in hep.lcio.event
Interface for the run header.
LCRunListener - Interface in hep.lcio.io
Listener for the occurence of LCRunHeader when reading a stream.
LCSTRVEC - Static variable in interface hep.lcio.event.LCIO
 
LCStrVec - Interface in hep.lcio.event
String vector used for user extensions.
LCTools - Class in hep.lcio.example
 
LCTools() - Constructor for class hep.lcio.example.LCTools
 
LCWriter - Interface in hep.lcio.io
Interface for writing data with LCIO.
LE - Static variable in class org.lsmp.djep.rpe.RpEval
 
LE - Static variable in class org.nfunk.jep.function.Comparative
 
le(Object, Object) - Method in class org.nfunk.jep.function.Comparative
 
LE - Static variable in interface org.nfunk.jep.ParserConstants
 
leapFrog(double[], F1D, double) - Static method in class jhplot.math.Numeric
Uses the Leap-Frog method to solve an ODE.
LearningFactorFunction - Interface in org.apache.commons.math3.ml.neuralnet.sofm
Provides the learning rate as a function of the number of calls already performed during the learning task.
LearningFactorFunctionFactory - Class in org.apache.commons.math3.ml.neuralnet.sofm
Factory for creating instances of LearningFactorFunction.
leastSignificantBit(int) - Static method in class cern.colt.bitvector.QuickBitVector
Returns the index of the least significant bit in state "true".
LeastSquaresAdapter - Class in org.apache.commons.math3.fitting.leastsquares
An adapter that delegates to another implementation of LeastSquaresProblem.
LeastSquaresAdapter(LeastSquaresProblem) - Constructor for class org.apache.commons.math3.fitting.leastsquares.LeastSquaresAdapter
Delegate the LeastSquaresProblem interface to the given implementation.
LeastSquaresBuilder - Class in org.apache.commons.math3.fitting.leastsquares
A mutable builder for LeastSquaresProblems.
LeastSquaresBuilder() - Constructor for class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
 
LeastSquaresConverter - Class in org.apache.commons.math3.optim.nonlinear.scalar
This class converts vectorial objective functions to scalar objective functions when the goal is to minimize them.
LeastSquaresConverter(MultivariateVectorFunction, double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.LeastSquaresConverter
Builds a simple converter for uncorrelated residuals with identical weights.
LeastSquaresConverter(MultivariateVectorFunction, double[], double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.LeastSquaresConverter
Builds a simple converter for uncorrelated residuals with the specified weights.
LeastSquaresConverter(MultivariateVectorFunction, double[], RealMatrix) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.LeastSquaresConverter
Builds a simple converter for correlated residuals with the specified weights.
LeastSquaresConverter - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
LeastSquaresConverter(MultivariateVectorFunction, double[]) - Constructor for class org.apache.commons.math3.optimization.LeastSquaresConverter
Deprecated.
Build a simple converter for uncorrelated residuals with the same weight.
LeastSquaresConverter(MultivariateVectorFunction, double[], double[]) - Constructor for class org.apache.commons.math3.optimization.LeastSquaresConverter
Deprecated.
Build a simple converter for uncorrelated residuals with the specific weights.
LeastSquaresConverter(MultivariateVectorFunction, double[], RealMatrix) - Constructor for class org.apache.commons.math3.optimization.LeastSquaresConverter
Deprecated.
Build a simple converter for correlated residuals with the specific weights.
LeastSquaresFactory - Class in org.apache.commons.math3.fitting.leastsquares
A Factory for creating LeastSquaresProblems.
LeastSquaresOptimizer - Interface in org.apache.commons.math3.fitting.leastsquares
An algorithm that can be applied to a non-linear least squares problem.
LeastSquaresOptimizer.Optimum - Interface in org.apache.commons.math3.fitting.leastsquares
The optimum found by the optimizer.
LeastSquaresProblem - Interface in org.apache.commons.math3.fitting.leastsquares
The data necessary to define a non-linear least squares problem.
LeastSquaresProblem.Evaluation - Interface in org.apache.commons.math3.fitting.leastsquares
An evaluation of a LeastSquaresProblem at a particular point.
LEDataInputStream - Class in jhplot.math.io
This class was designed on the base of Roedy Green LEDataInputStream Thanks to Roedy Green, Canadian Mind Products mailto:[email protected] http://mindprod.com
LEDataInputStream(InputStream) - Constructor for class jhplot.math.io.LEDataInputStream
 
LEDataOutputStream - Class in jhplot.math.io
This class was designed on the base of Roedy Green LEDataInputStream Thanks to Roedy Green, Canadian Mind Products mailto:[email protected] http://mindprod.com
LEDataOutputStream(OutputStream) - Constructor for class jhplot.math.io.LEDataOutputStream
 
LEFT - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The alignment string aligning the cells of a column to the left.
LEFT - Static variable in class graph.Axis
Constant flagging Axis position on the graph.
LEFT - Static variable in class graph.TextLine
Position the Text to the Left of the point
LEFT - Static variable in class org.jfree.chart.plot.ThermometerPlot
A constant for the value label position (left of the thermometer).
LEFT - Static variable in class org.lsmp.djep.xjep.XOperator
Left binding like +: 1+2+3 -> (1+2)+3
legend(int, int, String) - Method in class graph.DataSet
Define a data legend in the graph window
legend(double, double, String) - Method in class graph.DataSet
Define a data legend in the graph window
legend() - Method in class graph.VectorSet
Draw a Vector legend in the graph window.
legend(String) - Method in class graph.VectorSet
Define a Vector legend in the graph window.
legend(int, int, String) - Method in class graph.VectorSet
Define a Vector legend in the graph window
legend(double, double, String) - Method in class graph.VectorSet
Define a Vector legend in the graph window
legendColor(Color) - Method in class graph.DataSet
Set the color for the legend text
legendFont(Font) - Method in class graph.DataSet
Set the font to be used in the legend
LegendGraphic - Class in org.jfree.chart.title
The graphical item within a legend item.
LegendGraphic(Shape, Paint) - Constructor for class org.jfree.chart.title.LegendGraphic
Creates a new legend graphic.
LegendItem - Class in org.jfree.chart
A temporary storage object for recording the properties of a legend item, without any consideration for layout issues.
LegendItem(String) - Constructor for class org.jfree.chart.LegendItem
Creates a legend item with the specified label.
LegendItem(String, Paint) - Constructor for class org.jfree.chart.LegendItem
Creates a legend item with the specified label and fill paint.
LegendItem(String, String, String, String, Shape, Paint) - Constructor for class org.jfree.chart.LegendItem
Creates a legend item with a filled shape.
LegendItem(String, String, String, String, Shape, Paint, Stroke, Paint) - Constructor for class org.jfree.chart.LegendItem
Creates a legend item with a filled and outlined shape.
LegendItem(String, String, String, String, Shape, Stroke, Paint) - Constructor for class org.jfree.chart.LegendItem
Creates a legend item using a line.
LegendItem(String, String, String, String, boolean, Shape, boolean, Paint, boolean, Paint, Stroke, boolean, Shape, Stroke, Paint) - Constructor for class org.jfree.chart.LegendItem
Creates a new legend item.
LegendItem(AttributedString, String, String, String, Shape, Paint) - Constructor for class org.jfree.chart.LegendItem
Creates a legend item with a filled shape.
LegendItem(AttributedString, String, String, String, Shape, Paint, Stroke, Paint) - Constructor for class org.jfree.chart.LegendItem
Creates a legend item with a filled and outlined shape.
LegendItem(AttributedString, String, String, String, Shape, Stroke, Paint) - Constructor for class org.jfree.chart.LegendItem
Creates a legend item using a line.
LegendItem(AttributedString, String, String, String, boolean, Shape, boolean, Paint, boolean, Paint, Stroke, boolean, Shape, Stroke, Paint) - Constructor for class org.jfree.chart.LegendItem
Creates a new legend item.
LegendItemBlockContainer - Class in org.jfree.chart.title
A container that holds all the pieces of a single legend item.
LegendItemBlockContainer(Arrangement, int, int) - Constructor for class org.jfree.chart.title.LegendItemBlockContainer
Deprecated.
As of 1.0.6, use the other constructor.
LegendItemBlockContainer(Arrangement, Dataset, Comparable) - Constructor for class org.jfree.chart.title.LegendItemBlockContainer
Creates a new legend item block.
LegendItemCollection - Class in org.jfree.chart
A collection of legend items.
LegendItemCollection() - Constructor for class org.jfree.chart.LegendItemCollection
Constructs a new legend item collection, initially empty.
LegendItemEntity - Class in org.jfree.chart.entity
An entity that represents an item within a legend.
LegendItemEntity(Shape) - Constructor for class org.jfree.chart.entity.LegendItemEntity
Creates a legend item entity.
LegendItemSource - Interface in org.jfree.chart
A source of legend items.
legendPanel - Variable in class jplot.JPlot
 
legendre(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegratorFactory
Creates a Gauss-Legendre integrator of the given order.
legendre(int, double, double) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegratorFactory
Creates a Gauss-Legendre integrator of the given order.
LegendreGaussIntegrator - Class in org.apache.commons.math3.analysis.integration
Deprecated.
As of 3.1 (to be removed in 4.0). Please use IterativeLegendreGaussIntegrator instead.
LegendreGaussIntegrator(int, double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.LegendreGaussIntegrator
Deprecated.
Build a Legendre-Gauss integrator with given accuracies and iterations counts.
LegendreGaussIntegrator(int, double, double) - Constructor for class org.apache.commons.math3.analysis.integration.LegendreGaussIntegrator
Deprecated.
Build a Legendre-Gauss integrator with given accuracies.
LegendreGaussIntegrator(int, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.LegendreGaussIntegrator
Deprecated.
Build a Legendre-Gauss integrator with given iteration counts.
legendreHighPrecision(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegratorFactory
Creates a Gauss-Legendre integrator of the given order.
legendreHighPrecision(int, double, double) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegratorFactory
Creates an integrator of the given order, and whose call to the integrate method will perform an integration on the given interval.
LegendreHighPrecisionRuleFactory - Class in org.apache.commons.math3.analysis.integration.gauss
Factory that creates Gauss-type quadrature rule using Legendre polynomials.
LegendreHighPrecisionRuleFactory() - Constructor for class org.apache.commons.math3.analysis.integration.gauss.LegendreHighPrecisionRuleFactory
Default precision is DECIMAL128.
LegendreHighPrecisionRuleFactory(MathContext) - Constructor for class org.apache.commons.math3.analysis.integration.gauss.LegendreHighPrecisionRuleFactory
 
LegendRenderingOrder - Class in org.jfree.chart
Represents the order for rendering legend items.
LegendreRuleFactory - Class in org.apache.commons.math3.analysis.integration.gauss
Factory that creates Gauss-type quadrature rule using Legendre polynomials.
LegendreRuleFactory() - Constructor for class org.apache.commons.math3.analysis.integration.gauss.LegendreRuleFactory
 
LegendTitle - Class in org.jfree.chart.title
A chart title that displays a legend for the data in the chart.
LegendTitle(LegendItemSource) - Constructor for class org.jfree.chart.title.LegendTitle
Constructs a new (empty) legend for the specified source.
LegendTitle(LegendItemSource, Arrangement, Arrangement) - Constructor for class org.jfree.chart.title.LegendTitle
Creates a new legend title with the specified arrangement.
length() - Method in class graph.LoadData
 
length() - Method in class jhplot.math.io.LERandomAccessFile
 
length(double[]) - Static method in class jplot.Geometry
Return the length of a vector.
length(double[], double[]) - Static method in class jplot.Geometry
Compute distance between two points.
length(int, int, int, int) - Static method in class jplot.Geometry
Compute the length of the line from (x0,y0) to (x1,y1)
length(double, double, double, double) - Static method in class jplot.Geometry
Compute the length of the line from (x0,y0) to (x1,y1)
length(int[], int[], boolean) - Static method in class jplot.Geometry
Compute the length of a polyline.
length() - Method in class org.apache.commons.io.ByteOrderMark
Return the length of the BOM's bytes.
length(byte[]) - Static method in class org.apache.commons.io.IOUtils
Returns the length of the given array in a null-safe manner.
length(char[]) - Static method in class org.apache.commons.io.IOUtils
Returns the length of the given array in a null-safe manner.
length(CharSequence) - Static method in class org.apache.commons.io.IOUtils
Returns the length of the given CharSequence in a null-safe manner.
length(Object[]) - Static method in class org.apache.commons.io.IOUtils
Returns the length of the given array in a null-safe manner.
length() - Method in class org.jlab.groot.math.Dimension1D
 
Length - Class in org.lsmp.djep.vectorJep.function
Returns the length of a vector.
Length() - Constructor for class org.lsmp.djep.vectorJep.function.Length
 
LengthConstraintType - Class in org.jfree.chart.block
Defines tokens used to indicate a length constraint type.
lengthToJava2D(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.ModuloAxis
Converts a length in data coordinates into the corresponding length in Java2D coordinates.
lengthToJava2D(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.ValueAxis
Converts a length in data coordinates into the corresponding length in Java2D coordinates.
LENGTHUNIT_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
LENGTHUNIT_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
LENGTHUNIT_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
LENGTHUNIT_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
LERandomAccessFile - Class in jhplot.math.io
This class was designed on the base of Roedy Green LEDataInputStream Thanks to Roedy Green, Canadian Mind Products mailto:[email protected] http://mindprod.com
LERandomAccessFile(String, String) - Constructor for class jhplot.math.io.LERandomAccessFile
constructors
LERandomAccessFile(File, String) - Constructor for class jhplot.math.io.LERandomAccessFile
 
less(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A[row,col] = A[row,col] < s ? 1 : 0.
less(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A[row,col] = A[row,col] < B[row,col] ? 1 : 0.
less - Static variable in class cern.jet.math.Functions
Function that returns a < b ? 1 : 0.
less(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a < b ? 1 : 0.
LESSER - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
LESSEREQ - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
lessThan(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is less than x.
LETTER1 - Static variable in interface org.nfunk.jep.ParserConstants
 
LETTER2 - Static variable in interface org.nfunk.jep.ParserConstants
 
level - Variable in class graph.BuildGraph
The current brace level.
LEVEL - Static variable in class org.jfree.chart.renderer.AreaRendererEndType
The area is levelled at the first or last value.
LevelRenderer - Class in org.jfree.chart.renderer.category
A CategoryItemRenderer that draws individual data items as horizontal lines, spaced in the same way as bars in a bar chart.
LevelRenderer() - Constructor for class org.jfree.chart.renderer.category.LevelRenderer
Creates a new renderer with default settings.
LevenbergMarquardtOptimizer - Class in org.apache.commons.math3.fitting.leastsquares
This class solves a least-squares problem using the Levenberg-Marquardt algorithm.
LevenbergMarquardtOptimizer() - Constructor for class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
Default constructor.
LevenbergMarquardtOptimizer(double, double, double, double, double) - Constructor for class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
Construct an instance with all parameters specified.
LevenbergMarquardtOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector.jacobian
Deprecated.
All classes and interfaces in this package are deprecated. The optimizers that were provided here were moved to the org.apache.commons.math3.fitting.leastsquares package (cf. MATH-1008).
LevenbergMarquardtOptimizer() - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.LevenbergMarquardtOptimizer
Deprecated.
Build an optimizer for least squares problems with default values for all the tuning parameters (see the other contructor.
LevenbergMarquardtOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.LevenbergMarquardtOptimizer
Deprecated.
Constructor that allows the specification of a custom convergence checker.
LevenbergMarquardtOptimizer(double, ConvergenceChecker<PointVectorValuePair>, double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.LevenbergMarquardtOptimizer
Deprecated.
Constructor that allows the specification of a custom convergence checker, in addition to the standard ones.
LevenbergMarquardtOptimizer(double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.LevenbergMarquardtOptimizer
Deprecated.
Build an optimizer for least squares problems with default values for some of the tuning parameters (see the other contructor.
LevenbergMarquardtOptimizer(double, double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.LevenbergMarquardtOptimizer
Deprecated.
The arguments control the behaviour of the default convergence checking procedure.
LevenbergMarquardtOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated.
As of 3.1 (to be removed in 4.0).
LevenbergMarquardtOptimizer() - Constructor for class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
Deprecated.
Build an optimizer for least squares problems with default values for all the tuning parameters (see the other contructor.
LevenbergMarquardtOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
Deprecated.
Constructor that allows the specification of a custom convergence checker.
LevenbergMarquardtOptimizer(double, ConvergenceChecker<PointVectorValuePair>, double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
Deprecated.
Constructor that allows the specification of a custom convergence checker, in addition to the standard ones.
LevenbergMarquardtOptimizer(double, double, double) - Constructor for class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
Deprecated.
Build an optimizer for least squares problems with default values for some of the tuning parameters (see the other contructor.
LevenbergMarquardtOptimizer(double, double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
Deprecated.
The arguments control the behaviour of the default convergence checking procedure.
LevyDistribution - Class in org.apache.commons.math3.distribution
This class implements the Lévy distribution.
LevyDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.LevyDistribution
Build a new instance.
LevyDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.LevyDistribution
Creates a LevyDistribution.
lexStateNames - Static variable in class jplot3dp.MathParser.MathParserTokenManager
 
lexStateNames - Static variable in class org.nfunk.jep.ParserTokenManager
 
lf - Static variable in class jplot.Utils
 
lg - Static variable in class cern.jet.math.Functions
Function that returns Math.log(a) / Math.log(b).
lg(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns Math.log(a) / Math.log(b).
License - Static variable in interface jminhep.gui.Constants
 
LIFETIME_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
LIFETIME_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
LIFETIME_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
LIFETIME_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
liftPen(int) - Method in class jplot.DataArray
 
liftPen() - Method in class jplot.PlotPoint
 
LIGHT_BLUE - Static variable in class org.jfree.chart.ChartColor
A light blue color.
LIGHT_CYAN - Static variable in class org.jfree.chart.ChartColor
A light cyan color.
LIGHT_GREEN - Static variable in class org.jfree.chart.ChartColor
A light green color.
LIGHT_MAGENTA - Static variable in class org.jfree.chart.ChartColor
A light magenta color.
LIGHT_RED - Static variable in class org.jfree.chart.ChartColor
A light red color.
LIGHT_YELLOW - Static variable in class org.jfree.chart.ChartColor
A light yellow color.
LIGHTSPEED - Static variable in class graph.SpecialFunction
Speed of Light in a Vacuum.
like() - Method in class cern.colt.matrix.DoubleMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same size.
like(int) - Method in class cern.colt.matrix.DoubleMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like() - Method in class cern.colt.matrix.DoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of rows and columns.
like(int, int) - Method in class cern.colt.matrix.DoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like() - Method in class cern.colt.matrix.DoubleMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of slices, rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int, int) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like() - Method in class cern.colt.matrix.ObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same size.
like(int) - Method in class cern.colt.matrix.ObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like() - Method in class cern.colt.matrix.ObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of rows and columns.
like(int, int) - Method in class cern.colt.matrix.ObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like() - Method in class cern.colt.matrix.ObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of slices, rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like1D(int) - Method in class cern.colt.matrix.DoubleMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.ObjectMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.DoubleMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.ObjectMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
LimitAngle - Class in org.apache.commons.math3.geometry.spherical.oned
This class represents a 1D oriented hyperplane on the circle.
LimitAngle(S1Point, boolean, double) - Constructor for class org.apache.commons.math3.geometry.spherical.oned.LimitAngle
Simple constructor.
LimitCalculator - Class in jhplot.stat.limit
Create a limit calculator.
LimitCalculator() - Constructor for class jhplot.stat.limit.LimitCalculator
 
LimitCalculatorGui - Class in jhplot.stat.limit
 
LimitCalculatorGui() - Constructor for class jhplot.stat.limit.LimitCalculatorGui
 
LimitCalculatorGui.ExperimentData - Class in jhplot.stat.limit
 
LimitCalculatorGui.myFrame - Class in jhplot.stat.limit
 
LINE - Static variable in class graph.DataSet
A constant value flag used to specify that a straight line segment is to join the data points.
LINE - Static variable in class jhplot.shapes.HShape
 
Line - Class in jhplot.shapes
Draw a line in the user or NDC coordinate system
Line(double, double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.Line
Main constructor fot a line
Line(double, double, double, double) - Constructor for class jhplot.shapes.Line
Make a line using black (default) color and default stroke
Line - Class in org.apache.commons.math3.geometry.euclidean.threed
The class represent lines in a three dimensional space.
Line(Vector3D, Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Line
Build a line from two points.
Line(Line) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Line
Copy constructor.
Line(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Line
Deprecated.
as of 3.3, replaced with Line.Line(Vector3D, Vector3D, double)
Line - Class in org.apache.commons.math3.geometry.euclidean.twod
This class represents an oriented line in the 2D plane.
Line(Vector2D, Vector2D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Line
Build a line from two points.
Line(Vector2D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Line
Build a line from a point and an angle.
Line(Vector2D, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Line
Deprecated.
as of 3.3, replaced with Line.Line(Vector2D, Vector2D, double)
Line(Vector2D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Line
Deprecated.
as of 3.3, replaced with Line.Line(Vector2D, double, double)
Line(Line) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Line
Copy constructor.
line_color - Variable in class jplot3d.JSurface
 
LINE_COMMENT - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
LINE_SEPARATOR - Static variable in class org.apache.commons.io.IOUtils
Deprecated.
LINE_SEPARATOR_UNIX - Static variable in class org.apache.commons.io.IOUtils
The Unix line separator string.
LINE_SEPARATOR_WINDOWS - Static variable in class org.apache.commons.io.IOUtils
The Windows line separator string.
LineAccumulator - Class in jplot3d
The class LineAccumulator accumulates line drawing information and then draws all accumulated lines together.
LineAndShapeRenderer - Class in org.jfree.chart.renderer.category
A renderer that draws shapes for each data item, and lines between data items (for use with the CategoryPlot class).
LineAndShapeRenderer() - Constructor for class org.jfree.chart.renderer.category.LineAndShapeRenderer
Creates a renderer with both lines and shapes visible by default.
LineAndShapeRenderer(boolean, boolean) - Constructor for class org.jfree.chart.renderer.category.LineAndShapeRenderer
Creates a new renderer with lines and/or shapes visible.
LINEAR_INTERPOLATION - Static variable in class cern.jet.random.Empirical
 
LinearAlgebra - Class in jhplot.math
A collection of static methods for performing math operations on matrices and arrays.
LinearAlgebra() - Constructor for class jhplot.math.LinearAlgebra
 
linearCombination(DerivativeStructure[], DerivativeStructure[]) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(double[], DerivativeStructure[]) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(double, DerivativeStructure, double, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(double, double[], int, double, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute linear combination.
linearCombination(double, double[], int, double, double[], int, double, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute linear combination.
linearCombination(double, double[], int, double, double[], int, double, double[], int, double, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute linear combination.
linearCombination(SparseGradient[], SparseGradient[]) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute a linear combination.
linearCombination(double[], SparseGradient[]) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute a linear combination.
linearCombination(SparseGradient, SparseGradient, SparseGradient, SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute a linear combination.
linearCombination(double, SparseGradient, double, SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute a linear combination.
linearCombination(SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute a linear combination.
linearCombination(double, SparseGradient, double, SparseGradient, double, SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute a linear combination.
linearCombination(SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute a linear combination.
linearCombination(double, SparseGradient, double, SparseGradient, double, SparseGradient, double, SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute a linear combination.
linearCombination(Dfp[], Dfp[]) - Method in class org.apache.commons.math3.dfp.Dfp
Compute a linear combination.
linearCombination(double[], Dfp[]) - Method in class org.apache.commons.math3.dfp.Dfp
Compute a linear combination.
linearCombination(Dfp, Dfp, Dfp, Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Compute a linear combination.
linearCombination(double, Dfp, double, Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Compute a linear combination.
linearCombination(Dfp, Dfp, Dfp, Dfp, Dfp, Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Compute a linear combination.
linearCombination(double, Dfp, double, Dfp, double, Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Compute a linear combination.
linearCombination(Dfp, Dfp, Dfp, Dfp, Dfp, Dfp, Dfp, Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Compute a linear combination.
linearCombination(double, Dfp, double, Dfp, double, Dfp, double, Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Compute a linear combination.
linearCombination(T[], T[]) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(double[], T[]) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(T, T, T, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(double, T, double, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(T, T, T, T, T, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(double, T, double, T, double, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(T, T, T, T, T, T, T, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(double, T, double, T, double, T, double, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(Decimal64[], Decimal64[]) - Method in class org.apache.commons.math3.util.Decimal64
Compute a linear combination.
linearCombination(double[], Decimal64[]) - Method in class org.apache.commons.math3.util.Decimal64
Compute a linear combination.
linearCombination(Decimal64, Decimal64, Decimal64, Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute a linear combination.
linearCombination(double, Decimal64, double, Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute a linear combination.
linearCombination(Decimal64, Decimal64, Decimal64, Decimal64, Decimal64, Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute a linear combination.
linearCombination(double, Decimal64, double, Decimal64, double, Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute a linear combination.
linearCombination(Decimal64, Decimal64, Decimal64, Decimal64, Decimal64, Decimal64, Decimal64, Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute a linear combination.
linearCombination(double, Decimal64, double, Decimal64, double, Decimal64, double, Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute a linear combination.
linearCombination(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Compute a linear combination accurately.
linearCombination(double, double, double, double) - Static method in class org.apache.commons.math3.util.MathArrays
Compute a linear combination accurately.
linearCombination(double, double, double, double, double, double) - Static method in class org.apache.commons.math3.util.MathArrays
Compute a linear combination accurately.
linearCombination(double, double, double, double, double, double, double, double) - Static method in class org.apache.commons.math3.util.MathArrays
Compute a linear combination accurately.
LinearCongruentialRNG - Class in jhplot.math.num.random
A general linear congruential generator.
LinearCongruentialRNG(long, long) - Constructor for class jhplot.math.num.random.LinearCongruentialRNG
Create a linear congruential generator with the given modulus and multiplier.
LinearCongruentialRNG(long, long, long) - Constructor for class jhplot.math.num.random.LinearCongruentialRNG
Create a linear congruential generator with the given parameters.
LinearCongruentialRNG(long, long, long, long) - Constructor for class jhplot.math.num.random.LinearCongruentialRNG
Create a linear congruential generator with the given parameters.
LinearConstraint - Class in org.apache.commons.math3.optim.linear
A linear constraint for a linear optimization problem.
LinearConstraint(double[], Relationship, double) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraint
Build a constraint involving a single linear equation.
LinearConstraint(RealVector, Relationship, double) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraint
Build a constraint involving a single linear equation.
LinearConstraint(double[], double, Relationship, double[], double) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraint
Build a constraint involving two linear equations.
LinearConstraint(RealVector, double, Relationship, RealVector, double) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraint
Build a constraint involving two linear equations.
LinearConstraint - Class in org.apache.commons.math3.optimization.linear
Deprecated.
As of 3.1 (to be removed in 4.0).
LinearConstraint(double[], Relationship, double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated.
Build a constraint involving a single linear equation.
LinearConstraint(RealVector, Relationship, double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated.
Build a constraint involving a single linear equation.
LinearConstraint(double[], double, Relationship, double[], double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated.
Build a constraint involving two linear equations.
LinearConstraint(RealVector, double, Relationship, RealVector, double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated.
Build a constraint involving two linear equations.
LinearConstraintSet - Class in org.apache.commons.math3.optim.linear
Class that represents a set of linear constraints.
LinearConstraintSet(LinearConstraint...) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraintSet
Creates a set containing the given constraints.
LinearConstraintSet(Collection<LinearConstraint>) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraintSet
Creates a set containing the given constraints.
LinearInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Implements a linear function for interpolation of real univariate functions.
LinearInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.LinearInterpolator
 
LinearObjectiveFunction - Class in org.apache.commons.math3.optim.linear
An objective function for a linear optimization problem.
LinearObjectiveFunction(double[], double) - Constructor for class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
 
LinearObjectiveFunction(RealVector, double) - Constructor for class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
 
LinearObjectiveFunction - Class in org.apache.commons.math3.optimization.linear
Deprecated.
As of 3.1 (to be removed in 4.0).
LinearObjectiveFunction(double[], double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.
 
LinearObjectiveFunction(RealVector, double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.
 
LinearOptimizer - Class in org.apache.commons.math3.optim.linear
Base class for implementing linear optimizers.
LinearOptimizer - Interface in org.apache.commons.math3.optimization.linear
Deprecated.
As of 3.1 (to be removed in 4.0).
LineBorder - Class in org.jfree.chart.block
A line border for any AbstractBlock.
LineBorder() - Constructor for class org.jfree.chart.block.LineBorder
Creates a default border.
LineBorder(Paint, Stroke, RectangleInsets) - Constructor for class org.jfree.chart.block.LineBorder
Creates a new border with the specified color.
linecolor - Variable in class graph.DataSet
The color of the straight line segments
LineFunction2D - Class in org.jfree.data.function
A function in the form y = a + bx.
LineFunction2D(double, double) - Constructor for class org.jfree.data.function.LineFunction2D
Constructs a new line function.
lineIterator(File) - Static method in class org.apache.commons.io.FileUtils
Returns an Iterator for the lines in a File using the default encoding for the VM.
lineIterator(File, String) - Static method in class org.apache.commons.io.FileUtils
Returns an Iterator for the lines in a File.
lineIterator(InputStream, Charset) - Static method in class org.apache.commons.io.IOUtils
Returns an Iterator for the lines in an InputStream, using the character encoding specified (or default encoding if null).
lineIterator(InputStream, String) - Static method in class org.apache.commons.io.IOUtils
Returns an Iterator for the lines in an InputStream, using the character encoding specified (or default encoding if null).
lineIterator(Reader) - Static method in class org.apache.commons.io.IOUtils
Returns an Iterator for the lines in a Reader.
LineIterator - Class in org.apache.commons.io
An Iterator over the lines in a Reader.
LineIterator(Reader) - Constructor for class org.apache.commons.io.LineIterator
Constructs an iterator of the lines for a Reader.
LineNeedle - Class in org.jfree.chart.needle
A needle that is represented by a line.
LineNeedle() - Constructor for class org.jfree.chart.needle.LineNeedle
 
lineno - Variable in class graph.BuildGraph
Current line being parsed
LinePars - Class in jplot
Contains all the data needed to plot a series of points, connected or not by a line and attributes such as color, dash length, point type and more.
LinePars(String) - Constructor for class jplot.LinePars
Constructor, builds the class from default values.
LinePars(String, int) - Constructor for class jplot.LinePars
Constructor, builds the class with a specific color
LinePars(Color, float, float, int, float) - Constructor for class jplot.LinePars
Constructor, builds the class from specified values.
LinePars() - Constructor for class jplot.LinePars
Constructor, builds the class from default values.
LinePars(LinePars) - Constructor for class jplot.LinePars
Constructor, builds the class from specified values.
LinePars(String, Color) - Constructor for class jplot.LinePars
Constructor, builds the class from default values, except for an initial color.
LineRenderer3D - Class in org.jfree.chart.renderer.category
A line renderer with a 3D effect.
LineRenderer3D() - Constructor for class org.jfree.chart.renderer.category.LineRenderer3D
Creates a new renderer.
LINES - Static variable in class jplot.LinePars
 
LINES - Static variable in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Constant for the type of rendering (lines only).
LINES - Static variable in class org.jfree.chart.renderer.xy.XYAreaRenderer
Useful constant for specifying the type of rendering (lines only).
LineSearch - Class in org.apache.commons.math3.optim.nonlinear.scalar
Class for finding the minimum of the objective function along a given direction.
LineSearch(MultivariateOptimizer, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.LineSearch
The BrentOptimizer default stopping criterion uses the tolerances to check the domain (point) values, not the function values.
linestyle - Variable in class graph.DataSet
The linestyle to employ when joining the data points with straight line segments.
LineStyle - Class in jplot
Linestyle is a class which shows the current drawing style.
LineStyle(LinePars) - Constructor for class jplot.LineStyle
 
LineStyleButton - Class in jplot
Linestyle is a class which shows the current drawing style.
LineStyleButton() - Constructor for class jplot.LineStyleButton
 
LineStyleButton(LinePars) - Constructor for class jplot.LineStyleButton
 
LineStyleButtonRenderer(LinePars) - Constructor for class jplot.panels.PanelPlot.LineStyleButtonRenderer
 
LineUtilities - Class in org.jfree.chart.util
Some utility methods for Line2D objects.
LineUtilities() - Constructor for class org.jfree.chart.util.LineUtilities
 
LinReg - Class in jhplot.stat
A linear regression analysis.
LinReg(double[], double[]) - Constructor for class jhplot.stat.LinReg
Constructor for regression calculations
LinReg(P1D) - Constructor for class jhplot.stat.LinReg
constructor for regression calculations.
LinRegWeighted - Class in jhplot.stat
Weighted Least Squares Regression
LinRegWeighted(double[], double[], double[]) - Constructor for class jhplot.stat.LinRegWeighted
Constructor for regression calculations
list(Number[]) - Method in class org.lsmp.djep.groupJep.groups.PermutationGroup
 
list(Number[]) - Method in interface org.lsmp.djep.groupJep.interfaces.HasListI
 
LIST - Static variable in class org.lsmp.djep.rpe.RpEval
 
List - Class in org.nfunk.jep.function
The list function.
List() - Constructor for class org.nfunk.jep.function.List
 
listAll() - Method in class jhplot.io.CFBook
List all objects inside CFBook
listEntries() - Method in class jhplot.io.PFile
List objects stored in the file.
ListExpression() - Method in class org.nfunk.jep.Parser
 
listFiles(File, IOFileFilter, IOFileFilter) - Static method in class org.apache.commons.io.FileUtils
Finds files within a given directory (and optionally its subdirectories).
listFiles(File, String[], boolean) - Static method in class org.apache.commons.io.FileUtils
Finds files within a given directory (and optionally its subdirectories) which match an array of extensions.
listFilesAndDirs(File, IOFileFilter, IOFileFilter) - Static method in class org.apache.commons.io.FileUtils
Finds files within a given directory (and optionally its subdirectories).
listH1D() - Method in class jhplot.io.CFBook
List all known H1D histograms.
listH2D() - Method in class jhplot.io.CFBook
List all known H1D histograms.
listObjectNames() - Method in class jhplot.io.FileAida
List name of the objects inside trees
listP1D() - Method in class jhplot.io.CFBook
List all known P1D objects.
ListPopulation - Class in org.apache.commons.math3.genetics
Population of chromosomes represented by a List.
ListPopulation(int) - Constructor for class org.apache.commons.math3.genetics.ListPopulation
Creates a new ListPopulation instance and initializes its inner chromosome list.
ListPopulation(List<Chromosome>, int) - Constructor for class org.apache.commons.math3.genetics.ListPopulation
Creates a new ListPopulation instance.
LITTLE_ENDIAN - Static variable in class jhplot.math.io.BinaryFile
 
LITTLE_ENDIAN - Static variable in class jhplot.math.io.BinaryInputStream
 
LITTLE_ENDIAN - Static variable in class jhplot.math.io.BinaryOutputStream
 
LN - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ln(Object) - Method in class org.nfunk.jep.function.NaturalLogarithm
 
lnGamma(double) - Static method in class jhplot.stat.Statistics
Returns natural logarithm of gamma function.
load(H1D, String) - Method in class jhplot.HFit
Load a histogram for a fit
load(P1D, String) - Method in class jhplot.HFit
Load data for a fit
load(String, boolean) - Method in class jhplot.io.FileAida
Load a AIDA file
load(File, boolean) - Method in class jhplot.io.FileAida
Load a AIDA file
Load(String) - Static method in class jminhep.gui.SetEnv
Load data from a file
Load() - Static method in class jminhep.gui.SetEnv
Load data or display.
load(double[]) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Computes the empirical distribution from the provided array of numbers.
load(URL) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Computes the empirical distribution using data read from a URL.
load(File) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Computes the empirical distribution from the input file.
loadArray(URL) - Method in class graph.LoadData
Start loading the data into an Array.
loadArray(URL, Object) - Method in class graph.LoadData
Start loading the data into an array.
loadColumnNames(Vector) - Method in class jplot.DataFile
Reads the datafile for data.
loadColumnNamesData(Vector) - Method in class jplot.DataFile
Reads the datafile for data.
LoadData - Class in graph
This class will load data (as a seperate thread) into a DataSet given a URL.
LoadData() - Constructor for class graph.LoadData
Instantiate the class
LoadData(DataSet) - Constructor for class graph.LoadData
Instantiate the class
loadDataSet(double[], int) - Method in class graph.Graph2D
Load and Attach a DataSet from an array.
loadDataSet(URL) - Method in class graph.LoadData
Start loading the data into a/the DataSet.
loadDataSet(URL, Object) - Method in class graph.LoadData
Start loading the data into a/the DataSet.
loaded - Variable in class jplot.JPlot
 
loadFile(URL) - Method in class graph.Graph2D
Load and Attach a DataSet from a File.
loadFile(String) - Static method in class hep.lcio.util.FileUtil
Reads the lines of file at path fileName into an ArrayList.
loadFile(String) - Method in class jhepsim.mainGUI
Loads a file's contents into the text area, or displays an error message if the file does not exist.
LoadFile(String) - Method in class jminhep.gui.MainFrame
Load a file
LoadFile() - Method in class jminhep.gui.MainFrame
Load external data
loadFromFile() - Method in class jplot3dp.MainComponent
 
loadFromFile(String) - Method in class jplot3dp.MainComponent
 
loadGrid(URL) - Method in class graph.Contour
Load the grid to contour from a URL.
loadIcon(String) - Static method in class jplot3d.Utils
 
loadingData - Variable in class graph.Graph2D
If this is greater than zero it means that data loading threads are active so the message "loading data" is flashed on the plot canvas.
LoadMarkers(URL) - Method in class graph.Markers
This method reads the marker file and loads the marker definitions.
loadmessage(String) - Method in class graph.Graph2D
Change the message to be flashed on the canvas
locale - Static variable in class jminhep.gui.SetEnv
 
Localizable - Interface in org.apache.commons.math3.exception.util
Interface for localizable strings.
LocalizedFormats - Enum in org.apache.commons.math3.exception.util
Enumeration for localized messages formats used in exceptions messages.
Location(int, int) - Constructor for class org.apache.commons.math3.ml.neuralnet.twod.util.LocationFinder.Location
 
LocationFinder - Class in org.apache.commons.math3.ml.neuralnet.twod.util
Helper class to find the grid coordinates of a neuron.
LocationFinder(NeuronSquareMesh2D) - Constructor for class org.apache.commons.math3.ml.neuralnet.twod.util.LocationFinder
Builds a finder to retrieve the locations of neurons that belong to the given map.
LocationFinder.Location - Class in org.apache.commons.math3.ml.neuralnet.twod.util
Container holding a (row, column) pair.
LockableFileWriter - Class in org.apache.commons.io.output
FileWriter that will create and honor lock files to allow simple cross thread file lock handling.
LockableFileWriter(String) - Constructor for class org.apache.commons.io.output.LockableFileWriter
Constructs a LockableFileWriter.
LockableFileWriter(String, boolean) - Constructor for class org.apache.commons.io.output.LockableFileWriter
Constructs a LockableFileWriter.
LockableFileWriter(String, boolean, String) - Constructor for class org.apache.commons.io.output.LockableFileWriter
Constructs a LockableFileWriter.
LockableFileWriter(File) - Constructor for class org.apache.commons.io.output.LockableFileWriter
Constructs a LockableFileWriter.
LockableFileWriter(File, boolean) - Constructor for class org.apache.commons.io.output.LockableFileWriter
Constructs a LockableFileWriter.
LockableFileWriter(File, boolean, String) - Constructor for class org.apache.commons.io.output.LockableFileWriter
LockableFileWriter(File, Charset) - Constructor for class org.apache.commons.io.output.LockableFileWriter
Constructs a LockableFileWriter with a file encoding.
LockableFileWriter(File, String) - Constructor for class org.apache.commons.io.output.LockableFileWriter
Constructs a LockableFileWriter with a file encoding.
LockableFileWriter(File, Charset, boolean, String) - Constructor for class org.apache.commons.io.output.LockableFileWriter
Constructs a LockableFileWriter with a file encoding.
LockableFileWriter(File, String, boolean, String) - Constructor for class org.apache.commons.io.output.LockableFileWriter
Constructs a LockableFileWriter with a file encoding.
LoessInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Implements the Local Regression Algorithm (also Loess, Lowess) for interpolation of real univariate functions.
LoessInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Constructs a new LoessInterpolator with a bandwidth of LoessInterpolator.DEFAULT_BANDWIDTH, LoessInterpolator.DEFAULT_ROBUSTNESS_ITERS robustness iterations and an accuracy of {#link #DEFAULT_ACCURACY}.
LoessInterpolator(double, int) - Constructor for class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Construct a new LoessInterpolator with given bandwidth and number of robustness iterations.
LoessInterpolator(double, int, double) - Constructor for class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Construct a new LoessInterpolator with given bandwidth, number of robustness iterations and accuracy.
log(double, double) - Static method in class cern.jet.math.Arithmetic
Returns logbasevalue.
log - Static variable in class cern.jet.math.Functions
Function that returns Math.log(a).
log() - Method in class jhplot.math.Complex
Principal branch of the Complex logarithm of this Complex number.
log(ValueErr) - Method in class jhplot.math.ValueErr
Take natural log
log(double) - Static method in class net.jafama.FastMath
 
log(double) - Static method in class net.jafama.StrictFastMath
 
log() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Natural logarithm.
log(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute natural logarithm of a derivative structure.
log() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Natural logarithm.
Log - Class in org.apache.commons.math3.analysis.function
Natural logarithm function.
Log() - Constructor for class org.apache.commons.math3.analysis.function.Log
 
log() - Method in class org.apache.commons.math3.complex.Complex
Compute the natural logarithm of this complex number.
log() - Method in class org.apache.commons.math3.dfp.Dfp
Natural logarithm.
log(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
Returns the natural logarithm of a.
log() - Method in interface org.apache.commons.math3.RealFieldElement
Natural logarithm.
log() - Method in class org.apache.commons.math3.util.Decimal64
Natural logarithm.
log(double) - Static method in class org.apache.commons.math3.util.FastMath
Natural logarithm.
log(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Computes the logarithm in a given base.
log(Object) - Method in class org.nfunk.jep.function.Logarithm
 
log() - Method in class org.nfunk.jep.type.Complex
Returns the logarithm of this complex number.
log10(double) - Static method in class cern.jet.math.Arithmetic
Returns log10value.
log10(double) - Static method in class graph.SpecialFunction
 
log10(ValueErr) - Method in class jhplot.math.ValueErr
log to base 10
log10(double) - Method in class jhplot.math.ValueErr
 
log10(double) - Static method in class jplot.Axis
 
log10(double) - Static method in class jplot.GraphGeneral
Returns the log10 of a double value.
LOG10 - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
log10(double) - Static method in class net.jafama.FastMath
 
log10(double) - Static method in class net.jafama.StrictFastMath
 
log10() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Base 10 logarithm.
log10(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Computes base 10 logarithm of a derivative structure.
log10() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Base 10 logarithm.
Log10 - Class in org.apache.commons.math3.analysis.function
Base 10 logarithm function.
Log10() - Constructor for class org.apache.commons.math3.analysis.function.Log10
 
log10() - Method in class org.apache.commons.math3.dfp.Dfp
Deprecated.
as of 3.2, replaced by Dfp.intLog10(), in 4.0 the return type will be changed to Dfp
log10() - Method in class org.apache.commons.math3.util.Decimal64
Base 10 logarithm.
log10(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the base 10 logarithm.
LOG10_VALUE - Static variable in class org.jfree.chart.axis.LogarithmicAxis
Useful constant for log(10).
log10K() - Method in class org.apache.commons.math3.dfp.Dfp
Get the exponent of the greatest power of 10000 that is less than or equal to the absolute value of this.
log1p(double) - Static method in class net.jafama.FastMath
Much more accurate than log(1+value), for arguments (and results) close to zero.
log1p(double) - Static method in class net.jafama.StrictFastMath
Much more accurate than log(1+value), for arguments (and results) close to zero.
log1p() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Shifted natural logarithm.
log1p(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Computes shifted logarithm of a derivative structure.
log1p() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Shifted natural logarithm.
Log1p - Class in org.apache.commons.math3.analysis.function
log(1 + p) function.
Log1p() - Constructor for class org.apache.commons.math3.analysis.function.Log1p
 
log1p() - Method in class org.apache.commons.math3.dfp.Dfp
Shifted natural logarithm.
log1p() - Method in interface org.apache.commons.math3.RealFieldElement
Shifted natural logarithm.
log1p() - Method in class org.apache.commons.math3.util.Decimal64
Shifted natural logarithm.
log1p(double) - Static method in class org.apache.commons.math3.util.FastMath
Computes log(1 + x).
log2(double) - Static method in class cern.jet.math.Arithmetic
Returns log2value.
log2 - Static variable in class cern.jet.math.Functions
Function that returns Math.log(a) / Math.log(2).
LOG2 - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
log2(int) - Static method in class net.jafama.NumbersUtils
 
log2(long) - Static method in class net.jafama.NumbersUtils
 
LOG_2_PI - Static variable in interface jhplot.math.num.Constants
log(2 π).
LOG_BASE - Static variable in class jhplot.stat.Entropy
 
Logarithm - Class in org.nfunk.jep.function
Log bass 10.
Logarithm() - Constructor for class org.nfunk.jep.function.Logarithm
 
Logarithmic - Class in cern.jet.random
Logarithmic distribution.
Logarithmic(double, RandomEngine) - Constructor for class cern.jet.random.Logarithmic
Constructs a Logarithmic distribution.
LogarithmicAxis - Class in org.jfree.chart.axis
A numerical axis that uses a logarithmic scale.
LogarithmicAxis(String) - Constructor for class org.jfree.chart.axis.LogarithmicAxis
Creates a new axis.
LogarithmTest - Class in org.nfunk.jeptesting
 
LogarithmTest(String) - Constructor for class org.nfunk.jeptesting.LogarithmTest
 
LogAxis - Class in org.jfree.chart.axis
A numerical axis that uses a logarithmic scale.
LogAxis() - Constructor for class org.jfree.chart.axis.LogAxis
Creates a new LogAxis with no label.
LogAxis(String) - Constructor for class org.jfree.chart.axis.LogAxis
Creates a new LogAxis with the given label.
logBeta(double, double) - Static method in class jhplot.math.num.special.Beta
Returns the natural logarithm of the beta function B(a, b) (1).
logBeta(double, double, double, int) - Static method in class org.apache.commons.math3.special.Beta
Deprecated.
as of version 3.1, this method is deprecated as the computation of the beta function is no longer iterative; it will be removed in version 4.0. Current implementation of this method internally calls Beta.logBeta(double, double).
logBeta(double, double) - Static method in class org.apache.commons.math3.special.Beta
Returns the value of log B(p, q) for 0 ≤ x ≤ 1 and p, q > 0.
logBinomialProbability(int, int, double, double) - Static method in class jhplot.math.num.pdf.SaddlePoint
Compute the PMF for a binomial distribution using the saddle point expansion.
logDensity(double) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logDensity(double) - Method in class org.apache.commons.math3.distribution.BetaDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logDensity(double) - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logDensity(double) - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logDensity(double) - Method in class org.apache.commons.math3.distribution.FDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logDensity(double) - Method in class org.apache.commons.math3.distribution.GammaDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logDensity(double) - Method in class org.apache.commons.math3.distribution.LevyDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logDensity(double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logDensity(double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logDensity(double) - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logDensity(double) - Method in class org.apache.commons.math3.distribution.TDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logDensity(double) - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point x.
logFactorial(int) - Static method in class cern.jet.math.Arithmetic
Returns log(k!).
LogFormat - Class in org.jfree.chart.util
A number formatter for logarithmic values.
LogFormat() - Constructor for class org.jfree.chart.util.LogFormat
Creates a new instance using base 10.
LogFormat(double, String, boolean) - Constructor for class org.jfree.chart.util.LogFormat
Creates a new instance.
LogFormat(double, String, String, boolean) - Constructor for class org.jfree.chart.util.LogFormat
Creates a new instance.
logGamma(double) - Static method in class cern.jet.random.PoissonSlow
Returns the value ln(Gamma(xx) for xx > 0.
logGamma(double) - Static method in class cern.jet.stat.Gamma
Returns the natural logarithm of the gamma function; formerly named lgamma.
logGamma(double) - Static method in class jhplot.math.num.special.Gamma
Returns the natural logarithm of the gamma function Γ(x) (1).
logGamma(double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the value of log Γ(x) for x > 0.
logGamma1p(double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the value of log Γ(1 + x) for -0.5 ≤ x ≤ 1.5.
Logical - Class in org.nfunk.jep.function
 
Logical(int) - Constructor for class org.nfunk.jep.function.Logical
 
Logistic - Class in jhplot.math.num.pdf
The Logistic distribution.
Logistic() - Constructor for class jhplot.math.num.pdf.Logistic
Default constructor.
Logistic(double, double) - Constructor for class jhplot.math.num.pdf.Logistic
Create a distribution with the given mean and scale parameters.
Logistic - Class in org.apache.commons.math3.analysis.function
Logistic(double, double, double, double, double, double) - Constructor for class org.apache.commons.math3.analysis.function.Logistic
 
Logistic.Parametric - Class in org.apache.commons.math3.analysis.function
Parametric function where the input array contains the parameters of the logistic function, ordered as follows: k m b q a n
LogisticDistribution - Class in org.apache.commons.math3.distribution
This class implements the Logistic distribution.
LogisticDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.LogisticDistribution
Build a new instance.
LogisticDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.LogisticDistribution
Build a new instance.
LogisticRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Logistic distribution.
LogisticRandomVariable() - Constructor for class jhplot.math.num.random.LogisticRandomVariable
Default constructor.
LogisticRandomVariable(double, double) - Constructor for class jhplot.math.num.random.LogisticRandomVariable
Create a random variable with the given mean and scale.
LogisticRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.LogisticRandomVariable
Create a random variable with the given parameters.
Logit - Class in org.apache.commons.math3.analysis.function
Logit function.
Logit() - Constructor for class org.apache.commons.math3.analysis.function.Logit
Usual logit function, where the lower bound is 0 and the higher bound is 1.
Logit(double, double) - Constructor for class org.apache.commons.math3.analysis.function.Logit
Logit function.
Logit.Parametric - Class in org.apache.commons.math3.analysis.function
Parametric function where the input array contains the parameters of the logit function, ordered as follows: Lower bound Higher bound
LogNormal - Class in jhplot.math.num.pdf
The Log Normal distribution.
LogNormal() - Constructor for class jhplot.math.num.pdf.LogNormal
Default constructor.
LogNormal(double, double) - Constructor for class jhplot.math.num.pdf.LogNormal
Create a distribution with the given mean and standard deviation.
logNormal(double, double) - Static method in class jhplot.math.Random
Generate a random number from a LogNormal random variable.
LogNormalDistribution - Class in org.apache.commons.math3.distribution
Implementation of the log-normal (gaussian) distribution.
LogNormalDistribution() - Constructor for class org.apache.commons.math3.distribution.LogNormalDistribution
Create a log-normal distribution, where the mean and standard deviation of the normally distributed natural logarithm of the log-normal distribution are equal to zero and one respectively.
LogNormalDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.LogNormalDistribution
Create a log-normal distribution using the specified scale and shape.
LogNormalDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.LogNormalDistribution
Create a log-normal distribution using the specified scale, shape and inverse cumulative distribution accuracy.
LogNormalDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.LogNormalDistribution
Creates a log-normal distribution.
LogNormalDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.LogNormalDistribution
Creates a log-normal distribution.
LogNormalRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Log Normal distribution.
LogNormalRandomVariable() - Constructor for class jhplot.math.num.random.LogNormalRandomVariable
Default constructor.
LogNormalRandomVariable(double, double) - Constructor for class jhplot.math.num.random.LogNormalRandomVariable
Create a random variable with the given mean and standard deviation.
LogNormalRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.LogNormalRandomVariable
Create a random variable with the given parameters.
logProbability(int) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns log(P(X = x)), where log is the natural logarithm.
logProbability(int) - Method in class org.apache.commons.math3.distribution.BinomialDistribution
For a random variable X whose values are distributed according to this distribution, this method returns log(P(X = x)), where log is the natural logarithm.
logProbability(int) - Method in class org.apache.commons.math3.distribution.GeometricDistribution
For a random variable X whose values are distributed according to this distribution, this method returns log(P(X = x)), where log is the natural logarithm.
logProbability(int) - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
For a random variable X whose values are distributed according to this distribution, this method returns log(P(X = x)), where log is the natural logarithm.
logProbability(int) - Method in class org.apache.commons.math3.distribution.PascalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns log(P(X = x)), where log is the natural logarithm.
logProbability(int) - Method in class org.apache.commons.math3.distribution.PoissonDistribution
For a random variable X whose values are distributed according to this distribution, this method returns log(P(X = x)), where log is the natural logarithm.
logProbability(int) - Method in class org.apache.commons.math3.distribution.ZipfDistribution
For a random variable X whose values are distributed according to this distribution, this method returns log(P(X = x)), where log is the natural logarithm.
logQuick(double) - Static method in class net.jafama.FastMath
Quick log, with a max relative error of about 1.9e-3 for values in ]Double.MIN_NORMAL,+Infinity[, and worse accuracy outside this range.
logQuick(double) - Static method in class net.jafama.StrictFastMath
Quick log, with a max relative error of about 1.9e-3 for values in ]Double.MIN_NORMAL,+Infinity[, and worse accuracy outside this range.
LogTick - Class in org.jfree.chart.axis
A tick from a LogAxis.
LogTick(TickType, double, AttributedString, TextAnchor) - Constructor for class org.jfree.chart.axis.LogTick
Creates a new instance.
LongArrayList - Class in cern.colt.list
Resizable list holding long elements; implemented with arrays.
LongArrayList() - Constructor for class cern.colt.list.LongArrayList
Constructs an empty list.
LongArrayList(long[]) - Constructor for class cern.colt.list.LongArrayList
Constructs a list containing the specified elements.
LongArrayList(int) - Constructor for class cern.colt.list.LongArrayList
Constructs an empty list with the specified initial capacity.
LongComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
longCounter() - Static method in class org.apache.commons.io.file.Counters
Returns a new long Counter.
longFactorial(int) - Static method in class cern.jet.math.Arithmetic
Instantly returns the factorial k!.
LongListAdapter - Class in cern.colt.list.adapter
Adapter that permits an AbstractLongList to be viewed and treated as a JDK 1.2 AbstractList.
LongListAdapter(AbstractLongList) - Constructor for class cern.colt.list.adapter.LongListAdapter
Constructs a list backed by the specified content list.
longMaskLSBits0(int) - Static method in class net.jafama.NumbersUtils
 
longMaskLSBits1(int) - Static method in class net.jafama.NumbersUtils
 
longMaskMSBits0(int) - Static method in class net.jafama.NumbersUtils
 
longMaskMSBits1(int) - Static method in class net.jafama.NumbersUtils
 
LongNeedle - Class in org.jfree.chart.needle
A needle that is represented by a long line.
LongNeedle() - Constructor for class org.jfree.chart.needle.LongNeedle
Default constructor.
LongObjectProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
longPathCounters() - Static method in class org.apache.commons.io.file.Counters
Returns a new BigInteger PathCounters.
LongProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
longValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a long.
longValue() - Method in class org.apache.commons.math3.fraction.Fraction
Gets the fraction as a long.
longValue() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation performs casting to a long.
longValue() - Method in class org.lsmp.djep.groupJep.groups.Quaternions.Quaternion
 
longValue() - Method in class org.lsmp.djep.groupJep.values.Permutation
 
longValue() - Method in class org.lsmp.djep.groupJep.values.Polynomial
value of constant coeff.
longValue() - Method in class org.lsmp.djep.groupJep.values.Rational
 
longValue() - Method in class org.lsmp.djep.vectorJep.values.Scaler
value of constant coeff.
longValue(Node) - Method in class org.lsmp.djep.xjep.TreeUtils
Returns the long value represented by node
longValue() - Method in class org.nfunk.jep.type.Complex
Returns real part.
lookingAhead - Variable in class jplot3dp.MathParser.MathParser
 
lookingAhead - Variable in class org.nfunk.jep.Parser
 
lookupLegendShape(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Performs a lookup for the legend shape.
lookupLegendTextFont(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Performs a lookup for the legend text font.
lookupLegendTextPaint(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Performs a lookup for the legend text paint.
LookupPaintScale - Class in org.jfree.chart.renderer
A paint scale that uses a lookup table to associate paint instances with data value ranges.
LookupPaintScale() - Constructor for class org.jfree.chart.renderer.LookupPaintScale
Creates a new paint scale.
LookupPaintScale(double, double, Paint) - Constructor for class org.jfree.chart.renderer.LookupPaintScale
Creates a new paint scale with the specified default paint.
lookupSeriesFillPaint(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the paint used to fill an item drawn by the renderer.
lookupSeriesOutlinePaint(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the paint used to outline an item drawn by the renderer.
lookupSeriesOutlineStroke(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the stroke used to outline the items in a series.
lookupSeriesPaint(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the paint used to color an item drawn by the renderer.
lookupSeriesShape(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns a shape used to represent the items in a series.
lookupSeriesStroke(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Returns the stroke used to draw the items in a series.
LorentzVector - Class in j4np.physics
 
LorentzVector() - Constructor for class j4np.physics.LorentzVector
 
LorentzVector(LorentzVector) - Constructor for class j4np.physics.LorentzVector
 
LorentzVector(double, double, double, double) - Constructor for class j4np.physics.LorentzVector
 
loval(int) - Method in class org.freehep.math.minuit.MnMinos
 
loval(int, double) - Method in class org.freehep.math.minuit.MnMinos
 
loval(int, double, int) - Method in class org.freehep.math.minuit.MnMinos
 
LOW_END - Static variable in class org.jfree.chart.axis.AxisLabelLocation
Axis label at the bottom.
lower() - Method in class org.freehep.math.minuit.MinosError
 
lower(int) - Method in class org.freehep.math.minuit.MnMinos
 
lower(int, double) - Method in class org.freehep.math.minuit.MnMinos
 
lower(int, double, int) - Method in class org.freehep.math.minuit.MnMinos
calculate one side (negative or positive error) of the parameter
lowerBandwidth(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
The lower bandwidth of a square matrix A is the maximum i-j for which A[i,j] is nonzero and i > j.
lowerCoordinates - Variable in class org.jfree.chart.renderer.xy.DeviationRenderer.State
A list of coordinates for the lower y-values in the current series (after translation into Java2D space).
lowerEdge() - Method in class cern.hep.aida.ref.FixedAxis
 
lowerEdge() - Method in class cern.hep.aida.ref.VariableAxis
 
lowerEdge() - Method in interface colt.hep.aida.IAxis
Lower axis edge.
lowerNewMin() - Method in class org.freehep.math.minuit.MinosError
 
lowerState() - Method in class org.freehep.math.minuit.MinosError
 
lowerValid() - Method in class org.freehep.math.minuit.MinosError
 
LParticle - Class in hephysics.particle
A class representing a Lorentz particle.
LParticle() - Constructor for class hephysics.particle.LParticle
Define a dummy particle.
LParticle(String) - Constructor for class hephysics.particle.LParticle
Define a particle with a name.
LParticle(String, double) - Constructor for class hephysics.particle.LParticle
Define a particle with a name and mass.
LParticle(double, double, double) - Constructor for class hephysics.particle.LParticle
Define a 3-momentum or X,Y,Z position.
LParticle(double, double, double, double, double) - Constructor for class hephysics.particle.LParticle
Define a particle in momentum or coordinate space.
LParticle(double, double, double, double) - Constructor for class hephysics.particle.LParticle
Define a particle in momentum or 4-space time.
LParticle(String, double, double, double, double, double) - Constructor for class hephysics.particle.LParticle
Define a Lorentz particle in momentum or coordinate space.
LRND - Static variable in interface org.nfunk.jep.ParserConstants
 
ls() - Method in class org.jlab.groot.data.Directory
list the content of current directory
LSQ - Static variable in interface org.nfunk.jep.ParserConstants
 
LT - Static variable in class org.lsmp.djep.rpe.RpEval
 
LT - Static variable in class org.nfunk.jep.function.Comparative
 
lt(Object, Object) - Method in class org.nfunk.jep.function.Comparative
 
LT - Static variable in interface org.nfunk.jep.ParserConstants
 
lu() - Method in class Jama.Matrix
LU Decomposition
LU(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
LUDecomposition - Class in cern.colt.matrix.linalg
For an m x n matrix A with m >= n, the LU decomposition is an m x n unit lower triangular matrix L, an n x n upper triangular matrix U, and a permutation vector piv of length m so that A(piv,:) = L*U; If m < n, then L is m x m and U is m x n.
LUDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.linalg.LUDecomposition
Constructs and returns a new LU Decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
LUDecomposition - Class in Jama
LU Decomposition.
LUDecomposition(Matrix) - Constructor for class Jama.LUDecomposition
LU Decomposition Structure to access L, U and piv.
LUDecomposition - Class in jhplot.math.kalman.jama
LU Decomposition.
LUDecomposition(Matrix) - Constructor for class jhplot.math.kalman.jama.LUDecomposition
LU Decomposition
LUDecomposition - Class in jhplot.math
LU Decomposition.
LUDecomposition(double[][]) - Constructor for class jhplot.math.LUDecomposition
LU Decomposition
LUDecomposition - Class in org.apache.commons.math3.linear
Calculates the LUP-decomposition of a square matrix.
LUDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.LUDecomposition
Calculates the LU-decomposition of the given matrix.
LUDecomposition(RealMatrix, double) - Constructor for class org.apache.commons.math3.linear.LUDecomposition
Calculates the LU-decomposition of the given matrix.
LUDecompositionQuick - Class in cern.colt.matrix.linalg
A low level version of LUDecomposition, avoiding unnecessary memory allocation and copying.
LUDecompositionQuick() - Constructor for class cern.colt.matrix.linalg.LUDecompositionQuick
Constructs and returns a new LU Decomposition object with default tolerance 1.0E-9 for singularity detection.
LUDecompositionQuick(double) - Constructor for class cern.colt.matrix.linalg.LUDecompositionQuick
Constructs and returns a new LU Decomposition object which uses the given tolerance for singularity detection;
lumen - Static variable in class cern.clhep.Units
 
LUMINOSITY_ACCUMULATED_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
LUMINOSITY_ACCUMULATED_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat
 
LUMINOSITY_ACCUMULATED_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat
 
LUMINOSITY_ACCUMULATED_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat
 
LutherFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements the Luther sixth order Runge-Kutta integrator for Ordinary Differential Equations.
LutherFieldIntegrator(Field<T>, T) - Constructor for class org.apache.commons.math3.ode.nonstiff.LutherFieldIntegrator
Simple constructor.
LutherIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the Luther sixth order Runge-Kutta integrator for Ordinary Differential Equations.
LutherIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.LutherIntegrator
Simple constructor.
lux - Static variable in class cern.clhep.Units
 
LValue() - Method in class org.nfunk.jep.Parser
 
LValueI - Interface in org.nfunk.jep.function
 

M

m - Static variable in class cern.clhep.Units
 
m() - Method in class hephysics.jet.ParticleD
Compute mass.
m() - Method in class hephysics.vec.HepLorentzVector
Invariant mass.
m2 - Static variable in class cern.clhep.Units
 
m2() - Method in class hephysics.vec.HepLorentzVector
Invariant mass squared
m3 - Static variable in class cern.clhep.Units
 
m_default - Variable in class jplot.GraphGeneral
 
m_edit - Variable in class jplot.GraphGeneral
 
m_refresh - Variable in class jplot.GraphGeneral
 
m_SummaryPad - Variable in class jminhep.clcontrol.ClControl
 
m_tree - Variable in class jminhep.gui.CSelector
 
MacroDiffRules - Class in org.lsmp.djep.djep.diffRules
Rules are specfied by a set of strings or trees of nodes.
MacroDiffRules(DJep, String, Node) - Constructor for class org.lsmp.djep.djep.diffRules.MacroDiffRules
Create a differention rule for function with 1 argument
MacroDiffRules(DJep, String, String) - Constructor for class org.lsmp.djep.djep.diffRules.MacroDiffRules
Create a differention rule for function with 1 argument
MacroDiffRules(DJep, String, PostfixMathCommandI, String) - Constructor for class org.lsmp.djep.djep.diffRules.MacroDiffRules
Create a differention rule for function with 1 argument
MacroDiffRules(DJep, String, PostfixMathCommandI, String, String) - Constructor for class org.lsmp.djep.djep.diffRules.MacroDiffRules
Create a differention rule for function with 2 arguments.
MacroDiffRules(DJep, String, String, String) - Constructor for class org.lsmp.djep.djep.diffRules.MacroDiffRules
Create a differention rule for function with 2 arguments.
MacroDiffRules(DJep, String, PostfixMathCommandI, String[]) - Constructor for class org.lsmp.djep.djep.diffRules.MacroDiffRules
Create a differentation rule for function with n arguments.
MacroDiffRules(DJep, String, String[]) - Constructor for class org.lsmp.djep.djep.diffRules.MacroDiffRules
Create a differentation rule for function with n arguments.
MacroFunction - Class in org.lsmp.djep.xjep
A function specified by a string.
MacroFunction(String, int, String, XJep) - Constructor for class org.lsmp.djep.xjep.MacroFunction
Create a function specified by a string.
MacroFunctionDiffRules - Class in org.lsmp.djep.djep.diffRules
If your really lazy, you don't even need to workout the derivatives of a function defined by a macro yourself.
MacroFunctionDiffRules(DJep, MacroFunction) - Constructor for class org.lsmp.djep.djep.diffRules.MacroFunctionDiffRules
Calculates the rules for the given function.
MAdd - Class in org.lsmp.djep.vectorJep.function
An extension of the Add command to allow it to add MVector's and Matrix's.
MAdd() - Constructor for class org.lsmp.djep.vectorJep.function.MAdd
 
mag() - Method in class hephysics.jet.ParticleD
Compute magnitude sqrt(px**2+py**2+pz**2)
mag() - Method in class hephysics.vec.Hep3Vector
 
mag() - Method in class hephysics.vec.HepLorentzVector
Magnitude sqrt(x**2+y**2+z**2)
mag() - Method in class j4np.physics.Vector3
 
mag2() - Method in class hephysics.vec.Hep3Vector
 
mag2() - Method in class hephysics.vec.HepLorentzVector
Magnitude squared: t()*t() - v.mag2() or e()*e() - v.mag2().
mag2() - Method in class j4np.physics.Vector3
 
magic(int) - Static method in class Jama.examples.MagicSquareExample
Generate magic square test matrix.
magicNumberFileFilter(String) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that accepts files that begin with the provided magic number.
magicNumberFileFilter(String, long) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that accepts files that contains the provided magic number at a specified offset within the file.
magicNumberFileFilter(byte[]) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that accepts files that begin with the provided magic number.
magicNumberFileFilter(byte[], long) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that accepts files that contains the provided magic number at a specified offset within the file.
MagicNumberFileFilter - Class in org.apache.commons.io.filefilter
File filter for matching files containing a "magic number".
MagicNumberFileFilter(byte[]) - Constructor for class org.apache.commons.io.filefilter.MagicNumberFileFilter
Constructs a new MagicNumberFileFilter and associates it with the magic number to test for in files.
MagicNumberFileFilter(String) - Constructor for class org.apache.commons.io.filefilter.MagicNumberFileFilter
Constructs a new MagicNumberFileFilter and associates it with the magic number to test for in files.
MagicNumberFileFilter(String, long) - Constructor for class org.apache.commons.io.filefilter.MagicNumberFileFilter
Constructs a new MagicNumberFileFilter and associates it with the magic number to test for in files and the byte offset location in the file to to look for that magic number.
MagicNumberFileFilter(byte[], long) - Constructor for class org.apache.commons.io.filefilter.MagicNumberFileFilter
Constructs a new MagicNumberFileFilter and associates it with the magic number to test for in files and the byte offset location in the file to to look for that magic number.
MagicSquareExample - Class in Jama.examples
Example of use of Matrix Class, featuring magic squares.
MagicSquareExample() - Constructor for class Jama.examples.MagicSquareExample
 
magnitude() - Method in class hep.physics.vec.BasicHep3Vector
 
magnitude() - Method in class hep.physics.vec.BasicHepLorentzVector
 
magnitude() - Method in interface hep.physics.vec.Hep3Vector
The length of the 3-vector.
magnitude() - Method in interface hep.physics.vec.HepLorentzVector
The magnitude of the Lorentz vector.
magnitude() - Method in class hep.physics.vec.SpacePoint
 
magnitude() - Method in class hephysics.vec.SpacePoint
 
magnitudeSquared() - Method in class hep.physics.vec.BasicHep3Vector
 
magnitudeSquared() - Method in class hep.physics.vec.BasicHepLorentzVector
 
magnitudeSquared() - Method in interface hep.physics.vec.Hep3Vector
The square of the length
magnitudeSquared() - Method in interface hep.physics.vec.HepLorentzVector
The square of the magnitude of the vector
magnitudeSquared() - Method in class hep.physics.vec.SpacePoint
 
magnitudeSquared() - Method in class hephysics.vec.Hep3Vector
 
magnitudeSquared() - Method in class hephysics.vec.SpacePoint
 
main(String[]) - Static method in class cern.colt.map.Benchmark
Tests various methods of this class.
main(String[]) - Static method in class cern.colt.matrix.bench.BenchmarkMatrix
Runs the matrix benchmark operations defined in args or in the file specified by args0.
main(String[]) - Static method in class cern.colt.matrix.doublealgo.Statistic
Benchmarks covariance computation.
main(String[]) - Static method in class cern.colt.Version
Prints asString on System.out.
main(String[]) - Static method in class cern.hep.aida.ref.Test
 
main(String[]) - Static method in class cern.hep.aida.ref.Test2
 
main(String[]) - Static method in class cern.jet.random.Benchmark
Benchmarks all subclasses
main(String[]) - Static method in class cern.jet.random.engine.Benchmark
Tests various methods of this class.
main(String[]) - Static method in class cern.jet.random.engine.RandomSeedGenerator
Prints the generated seeds for the given input parameters.
main(String[]) - Static method in class cern.jet.random.sampling.RandomSampler
Tests this class.
main(String[]) - Static method in class cern.jet.random.sampling.RandomSamplingAssistant
Tests random sampling.
main(String[]) - Static method in class cern.jet.stat.quantile.Quantile1Test
 
main(String[]) - Static method in class corejava.Format
a test stub for the format class
main(String[]) - Static method in class fitter.Fitter
 
main(String[]) - Static method in class hep.lcio.example.AnalysisJob
 
main(String[]) - Static method in class hep.lcio.example.MiniJob
 
main(String[]) - Static method in class hep.lcio.example.RecJob
 
main(String[]) - Static method in class hep.lcio.example.SimJob
 
main(String[]) - Static method in class hep.lcio.example.SIODump
 
main(String[]) - Static method in class hep.lcio.test.CompareEvents
 
main(String[]) - Static method in class hep.lcio.test.CreateRandomEvent
 
main(String[]) - Static method in class hep.lcio.test.RandomEventTest
 
main(String[]) - Static method in class hep.lcio.util.CommandLineTool
The default main method for the CommandLineTool.
main(String[]) - Static method in class hep.lcio.util.LCEventDiff
 
main(String[]) - Static method in class hep.lcio.util.LCIOConcat
 
Main(String[]) - Method in class hep.lcio.util.LCIOConcat
 
main(String[]) - Static method in class hep.lcio.util.LCIOSplitter
 
main(String[]) - Static method in class hep.lcio.util.MergeTestEvents
 
main(String[]) - Static method in class hep.lcio.util.SIODump
 
main(String[]) - Static method in class hephysics.jet.JetN2
Main class for testing.
main(String[]) - Static method in class hephysics.jet.KTjet
Main class for testing.
Main - Class in hephysics.jet
 
Main() - Constructor for class hephysics.jet.Main
 
main(String[]) - Static method in class hephysics.jet.Main
 
main(String[]) - Static method in class hephysics.jet.SCJet
Main class for testing.
main(String[]) - Static method in class Jama.examples.MagicSquareExample
 
main(String[]) - Static method in class Jama.test.TestMatrix
 
Main - Class in jhepsim
Main Application.
Main() - Constructor for class jhepsim.Main
 
main(String[]) - Static method in class jhepsim.Main
 
main(String[]) - Static method in class jhplot.HPlotJas
 
main(String[]) - Static method in class jhplot.io.ArrayReaderWriter
 
main(String[]) - Static method in class jhplot.math.DoubleArray
 
main(String[]) - Static method in class jhplot.math.io.ASCIIFile
 
main(String[]) - Static method in class jhplot.math.io.BinaryFile
 
main(String[]) - Static method in class jhplot.math.kalman.KalmanTest
Main method
main(String[]) - Static method in class jhplot.math.KolmogorovSmirnovDist
 
main(String[]) - Static method in class jhplot.math.pca.SampleRun
 
main(String[]) - Static method in class jhplot.math.Poisson
 
main(String[]) - Static method in class jhplot.math.Slicing
 
main(String[]) - Static method in class jhplot.math.Sorting
 
main(String[]) - Static method in class jhplot.math.SortUtils
Test method
main(String[]) - Static method in class jhplot.PND
Test
main(String[]) - Static method in class jhplot.PNI
Test
main(String[]) - Static method in class jhplot.stat.Anova
 
main(String[]) - Static method in class jhplot.stat.limit.LimitCalculatorGui
 
main(String[]) - Static method in class jhplot.stat.PCA
 
main(String[]) - Static method in class jhplot.utils.BrowserHTML
 
main(String[]) - Static method in class jhplot.utils.FileList
Sole entry point to the class and application.
main(String[]) - Static method in class jhplot.utils.GHFontChooser
 
main(String[]) - Static method in class jhplot.utils.ShowColors
 
main(String[]) - Static method in class jhplot.utils.ShowFonts
Simple main program to start it running
main(String[]) - Static method in class jminhep.clcontrol.SummaryPad
 
main(String[]) - Static method in class jminhep.clcontrol.TableOptions
 
main(String[]) - Static method in class jminhep.clcontrol.TableSettings
 
main(String[]) - Static method in class jminhep.cluster.DataHolder
Main method -- to test the DataPoint class
main(String[]) - Static method in class jminhep.cluster.DataPoint
Main method -- to test the DataPoint class
Main - Class in jminhep.gui
Title: Main project file
Main() - Constructor for class jminhep.gui.Main
Construct and show the application.
Main(DataHolder) - Constructor for class jminhep.gui.Main
Show GUI and append data to it
main(String[]) - Static method in class jminhep.gui.Main
Application entry point.
main(String[]) - Static method in class jplot.Axis
simple example program for Axis class.
main(String[]) - Static method in class jplot3dp.UVModeller
 
main(String[]) - Static method in class org.apache.commons.math3.util.FastMath
Print out contents of arrays, and check the length.
main(String[]) - Static method in class org.jfree.chart.demo.BarChartDemo1
Starting point for the demonstration application.
main(String[]) - Static method in class org.jfree.chart.demo.PieChartDemo1
Starting point for the demonstration application.
main(String[]) - Static method in class org.jfree.chart.demo.TimeSeriesChartDemo1
Starting point for the demonstration application.
main(String[]) - Static method in class org.jfree.chart.fx.demo.BarChartFXDemo1
Entry point.
main(String[]) - Static method in class org.jfree.chart.fx.demo.PieChartFXDemo1
 
main(String[]) - Static method in class org.jfree.chart.fx.demo.TimeSeriesChartFXDemo1
 
main(String[]) - Static method in class org.jfree.chart.JFreeChart
Prints information about JFreeChart to standard output.
main(String[]) - Static method in class org.jlab.groot.base.AxisAttributes
 
main(String[]) - Static method in class org.jlab.groot.base.DatasetAttributes
 
main(String[]) - Static method in class org.jlab.groot.base.GraphicsTests
 
main(String[]) - Static method in class org.jlab.groot.data.Directory
 
main(String[]) - Static method in class org.jlab.groot.data.TDirectory
 
main(String[]) - Static method in class org.jlab.groot.demo.BasicDemo
 
main(String[]) - Static method in class org.jlab.groot.demo.BasicDemo2
 
main(String[]) - Static method in class org.jlab.groot.demo.BasicDemo3
 
main(String[]) - Static method in class org.jlab.groot.demo.CustomFunctionDemo
 
main(String[]) - Static method in class org.jlab.groot.demo.Gaus2D
 
main(String[]) - Static method in class org.jlab.groot.demo.GROOTDemo
 
main(String[]) - Static method in class org.jlab.groot.demo.MultiGaus
 
main(String[]) - Static method in class org.jlab.groot.demo.TDirectoryDemo
 
main(String[]) - Static method in class org.jlab.groot.demo.Xeon_Amdahl
 
main(String[]) - Static method in class org.jlab.groot.fitter.DataFitter
 
main(String[]) - Static method in class org.jlab.groot.fitter.ParallelSliceFitter
 
main(String[]) - Static method in class org.jlab.groot.graphics.EmbeddedCanvas
 
main(String[]) - Static method in class org.jlab.groot.graphics.EmbeddedCanvasGroup
 
main(String[]) - Static method in class org.jlab.groot.graphics.EmbeddedCanvasTabbed
 
main(String[]) - Static method in class org.jlab.groot.graphics.GraphicsAxis
main program for testing the axis
main(String[]) - Static method in class org.jlab.groot.graphics.GraphicsAxisTests
 
main(String[]) - Static method in class org.jlab.groot.io.TextFileReader
 
main(String[]) - Static method in class org.jlab.groot.math.Dimension1D
 
main(String[]) - Static method in class org.jlab.groot.math.Dimension2D
 
main(String[]) - Static method in class org.jlab.groot.math.ErrorFunction
Test client
main(String[]) - Static method in class org.jlab.groot.math.F1D
 
main(String[]) - Static method in class org.jlab.groot.math.FunctionFactory
 
main(String[]) - Static method in class org.jlab.groot.matrix.GridStudio
 
main(String[]) - Static method in class org.jlab.groot.matrix.SparseGridIO
 
main(String[]) - Static method in class org.jlab.groot.matrix.SparseIndexPane
 
main(String[]) - Static method in class org.jlab.groot.matrix.SparseVectorGrid
 
main(String[]) - Static method in class org.jlab.groot.studio.StudioDesktop
 
main(String[]) - Static method in class org.jlab.groot.studio.StudioUI
 
main(String[]) - Static method in class org.jlab.groot.tree.DynamicTree
 
main(String[]) - Static method in class org.jlab.groot.tree.RandomTree
 
main(String[]) - Static method in class org.jlab.groot.tree.TreeTextFile
 
main(String[]) - Static method in class org.jlab.groot.ui.GraphicsAxis
main program for testing the axis
main(String[]) - Static method in class org.jlab.groot.ui.GraphicsAxisFrame
 
main(String[]) - Static method in class org.jlab.groot.ui.LatexText
 
main(String[]) - Static method in class org.jlab.groot.ui.LatexTextTools
 
main(String[]) - Static method in class org.jlab.groot.ui.TBrowser
 
main(String[]) - Static method in class org.jlab.groot.ui.TCanvas
 
main(String[]) - Static method in class org.jlab.groot.ui.TreeEditor
 
main(String[]) - Static method in class org.lsmp.djepExamples.AssignmentExample
 
main(String[]) - Static method in class org.lsmp.djepExamples.Console
Creates a new Console object and calls run()
main(String[]) - Static method in class org.lsmp.djepExamples.DiffExample
 
main(String[]) - Static method in class org.lsmp.djepExamples.DJepApplet
Creates a new Console object and calls run()
main(String[]) - Static method in class org.lsmp.djepExamples.DJepConsole
Creates a new Console object and calls run()
main(String[]) - Static method in class org.lsmp.djepExamples.GroupConsole
 
main(String[]) - Static method in class org.lsmp.djepExamples.JamaConsole
 
main(String[]) - Static method in class org.lsmp.djepExamples.MatrixConsole
 
main(String[]) - Static method in class org.lsmp.djepExamples.MatrixExample
 
main(String[]) - Static method in class org.lsmp.djepExamples.MatrixSpeed
 
main(String[]) - Static method in class org.lsmp.djepExamples.MRpDiffExample
 
main(String[]) - Static method in class org.lsmp.djepExamples.MRpExample
 
main(String[]) - Static method in class org.lsmp.djepExamples.MRpSpeed
 
main(String[]) - Static method in class org.lsmp.djepExamples.MRpSurfExample
 
main(String[]) - Static method in class org.lsmp.djepExamples.ObserverConsole
 
main(String[]) - Static method in class org.lsmp.djepExamples.PrintExample
 
main(String[]) - Static method in class org.lsmp.djepExamples.RpExample
 
main(String[]) - Static method in class org.lsmp.djepExamples.RpSpeed
 
main(String[]) - Static method in class org.lsmp.djepExamples.SJepConsole
 
main(String[]) - Static method in class org.lsmp.djepExamples.VectorConsole
 
main(String[]) - Static method in class org.lsmp.djepExamples.VectorExample
 
main(String[]) - Static method in class org.lsmp.djepExamples.VectorPrint
 
main(String[]) - Static method in class org.lsmp.djepExamples.XJepConsole
 
main(String[]) - Static method in class org.lsmp.djepExamples.XJepExample
 
main(String[]) - Static method in class org.lsmp.djepJUnit.AllTests
 
main(String[]) - Static method in class org.lsmp.djepJUnit.DJepTest
 
main(String[]) - Static method in class org.lsmp.djepJUnit.GroupJepTest
 
main(String[]) - Static method in class org.lsmp.djepJUnit.JepTest
Main entry point.
main(String[]) - Static method in class org.lsmp.djepJUnit.MatrixJepTest
Main entry point.
main(String[]) - Static method in class org.lsmp.djepJUnit.MRpTest
 
main(String[]) - Static method in class org.lsmp.djepJUnit.RewriteTest
 
main(String[]) - Static method in class org.lsmp.djepJUnit.RpTest
 
main(String[]) - Static method in class org.lsmp.djepJUnit.SJepTest
 
main(String[]) - Static method in class org.lsmp.djepJUnit.VectorJepTest
Main entry point.
main(String[]) - Static method in class org.lsmp.djepJUnit.XJepTest
 
main(String[]) - Static method in class org.nfunk.jepexamples.Evaluator
This method is called if the applet is run as an standalone program.
main(String[]) - Static method in class org.nfunk.jepexamples.LargeExpressionTest
 
main(String[]) - Static method in class org.nfunk.jepexamples.SimpleTest
 
main(String[]) - Static method in class org.nfunk.jepexamples.ThreadTest
Main method.
main(String[]) - Static method in class org.nfunk.jeptesting.AllTests
 
main(String[]) - Static method in class org.nfunk.jeptesting.JEPTest
The main method checks the arguments and creates an instance and calls it's run method.
Main - Class in test
An example of how to embed a JAIDA IPlotter into your own application.
Main() - Constructor for class test.Main
 
main(String[]) - Static method in class test.Main
 
main2(String[]) - Static method in class cern.hep.aida.ref.Test2
 
MainComponent - Class in jplot3dp
 
MainComponent(Frame) - Constructor for class jplot3dp.MainComponent
 
MainFrame - Class in jminhep.gui
Title: Main frame
MainFrame(String) - Constructor for class jminhep.gui.MainFrame
 
MainFrame(DataHolder) - Constructor for class jminhep.gui.MainFrame
 
mainGUI - Class in jhepsim
This is editor
mainGUI() - Constructor for class jhepsim.mainGUI
 
MainStateJacobianProvider - Interface in org.apache.commons.math3.ode
Interface expanding first order differential equations in order to compute exactly the main state jacobian matrix for partial derivatives equations.
MAJOR - Static variable in class org.jfree.chart.axis.TickType
Major tick.
major_tic_size - Variable in class graph.Axis
Size in pixels of the major tick marks
majorAxis() - Method in class hep.physics.jet.EventShape
 
MAJORVERSION - Static variable in interface hep.lcio.event.LCIO
 
make(double[]) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with the given cell values.
make(DoubleMatrix1D[]) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix which is the concatenation of all given parts.
make(int) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, double) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(AbstractDoubleList) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix from the values of the given list.
make(double[][]) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with the given cell values.
make(double[], int) - Method in class cern.colt.matrix.DoubleFactory2D
Construct a matrix from a one-dimensional column-major packed array, ala Fortran.
make(int, int) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, double) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(double[][][]) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with the given cell values.
make(int, int, int) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int, double) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(ObjectMatrix1D[]) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a matrix which is the concatenation of all given parts.
make(Object[]) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a matrix with the given cell values.
make(int) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, Object) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(ObjectArrayList) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a matrix from the values of the given list.
make(Object[][]) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a matrix with the given cell values.
make(Object[], int) - Method in class cern.colt.matrix.ObjectFactory2D
Construct a matrix from a one-dimensional column-major packed array, ala Fortran.
make(int, int) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, Object) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(Object[][][]) - Method in class cern.colt.matrix.ObjectFactory3D
Constructs a matrix with the given cell values.
make(int, int, int) - Method in class cern.colt.matrix.ObjectFactory3D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int, Object) - Method in class cern.colt.matrix.ObjectFactory3D
Constructs a matrix with the given shape, each cell initialized with the given value.
makeBitVector(int, int) - Static method in class cern.colt.bitvector.QuickBitVector
Constructs a low level bitvector that holds size elements, with each element taking bitsPerElement bits.
makeCVSAware(IOFileFilter) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Decorates a filter to make it ignore CVS directories.
makeDefault() - Static method in class cern.jet.random.engine.RandomEngine
Constructs and returns a new uniform random number engine seeded with the current time.
makeDefaultGenerator() - Static method in class cern.jet.random.AbstractDistribution
Constructs and returns a new uniform random number generation engine seeded with the current time.
makeDerivString(String, String[]) - Static method in class org.lsmp.djep.djep.DVariable
Produces a string to represent the derivative.
makeDirectoryOnly(IOFileFilter) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Decorates a filter so that it only applies to directories and not to files.
makeFileOnly(IOFileFilter) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Decorates a filter so that it only applies to files and not to directories.
makeHot(JComponent) - Static method in class jplot3d.Utils
 
makeLabel(String) - Static method in class jplot.Utils
Make a label specifically used by the tic-panel.
makeSVNAware(IOFileFilter) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Decorates a filter to make it ignore SVN directories.
makeVarIfNeeded(String, Object) - Method in class org.nfunk.jep.SymbolTable
Create a variable with the given name and value.
makeVarIfNeeded(String) - Method in class org.nfunk.jep.SymbolTable
If necessary create a variable with the given name.
MANHATTAN - Static variable in class cern.colt.matrix.doublealgo.Statistic
Manhattan distance function; Sum( abs(x[i]-y[i]) ).
ManhattanDistance - Class in org.apache.commons.math3.ml.distance
Calculates the L1 (sum of abs) distance between two points.
ManhattanDistance() - Constructor for class org.apache.commons.math3.ml.distance.ManhattanDistance
 
mannWhitneyU(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.MannWhitneyUTest
Computes the Mann-Whitney U statistic comparing mean for two independent samples possibly of different length.
MannWhitneyUTest - Class in org.apache.commons.math3.stat.inference
An implementation of the Mann-Whitney U test (also called Wilcoxon rank-sum test).
MannWhitneyUTest() - Constructor for class org.apache.commons.math3.stat.inference.MannWhitneyUTest
Create a test instance using where NaN's are left in place and ties get the average of applicable ranks.
MannWhitneyUTest(NaNStrategy, TiesStrategy) - Constructor for class org.apache.commons.math3.stat.inference.MannWhitneyUTest
Create a test instance using the given strategies for NaN's and ties.
mannWhitneyUTest(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.MannWhitneyUTest
Returns the asymptotic observed significance level, or p-value, associated with a Mann-Whitney U statistic comparing mean for two independent samples.
map(UnivariateFunction) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Acts as if implemented as:
map(UnivariateFunction) - Method in class org.apache.commons.math3.linear.RealVector
Acts as if implemented as:
mapAdd(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map an addition operation to each entry.
mapAdd(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map an addition operation to each entry.
mapAdd(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Add a value to each entry.
mapAdd(double) - Method in class org.apache.commons.math3.linear.RealVector
Add a value to each entry.
mapAdd(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Map an addition operation to each entry.
mapAddToSelf(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map an addition operation to each entry.
mapAddToSelf(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Add a value to each entry.
mapAddToSelf(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map an addition operation to each entry.
mapAddToSelf(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Add a value to each entry.
mapAddToSelf(double) - Method in class org.apache.commons.math3.linear.RealVector
Add a value to each entry.
mapAddToSelf(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Map an addition operation to each entry.
mapBinNumber(int, IAxis) - Method in class jhplot.HProf2D
Utility method to map the bin number from the external representation (from -2 to nBins-1 where -2 is the overflow and -1 is the underflow) to the internal one (from 0 to nBins+1 where 0 is the underflow and nBins+1 if the overflow bin)
mapDatasetToAxes(int, List) - Method in class org.jfree.chart.plot.PolarPlot
Maps the specified dataset to the axes in the list.
mapDatasetToAxis(int, int) - Method in class org.jfree.chart.plot.PolarPlot
Maps a dataset to a particular axis.
mapDatasetToDomainAxes(int, List) - Method in class org.jfree.chart.plot.CategoryPlot
Maps the specified dataset to the axes in the list.
mapDatasetToDomainAxes(int, List) - Method in class org.jfree.chart.plot.XYPlot
Maps the specified dataset to the axes in the list.
mapDatasetToDomainAxis(int, int) - Method in class org.jfree.chart.plot.CategoryPlot
Maps a dataset to a particular domain axis.
mapDatasetToDomainAxis(int, int) - Method in class org.jfree.chart.plot.XYPlot
Maps a dataset to a particular domain axis.
mapDatasetToRangeAxes(int, List) - Method in class org.jfree.chart.plot.CategoryPlot
Maps the specified dataset to the axes in the list.
mapDatasetToRangeAxes(int, List) - Method in class org.jfree.chart.plot.XYPlot
Maps the specified dataset to the axes in the list.
mapDatasetToRangeAxis(int, int) - Method in class org.jfree.chart.plot.CategoryPlot
Maps a dataset to a particular range axis.
mapDatasetToRangeAxis(int, int) - Method in class org.jfree.chart.plot.XYPlot
Maps a dataset to a particular range axis.
mapDatasetToScale(int, int) - Method in class org.jfree.chart.plot.dial.DialPlot
Maps a dataset to a particular scale.
MapDataVisualization - Interface in org.apache.commons.math3.ml.neuralnet.twod.util
Interface for algorithms that compute some metrics of the projection of data on a 2D-map.
mapDerivative(FieldODEStateAndDerivative<T>) - Method in class org.apache.commons.math3.ode.FieldEquationsMapper
Map a state derivative to a complete flat array.
mapDivide(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a division operation to each entry.
mapDivide(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a division operation to each entry.
mapDivide(double) - Method in class org.apache.commons.math3.linear.RealVector
Divide each entry by the argument.
mapDivide(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Map a division operation to each entry.
mapDivideToSelf(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a division operation to each entry.
mapDivideToSelf(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Divide each entry by the argument.
mapDivideToSelf(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a division operation to each entry.
mapDivideToSelf(double) - Method in class org.apache.commons.math3.linear.RealVector
Divide each entry by the argument.
mapDivideToSelf(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Map a division operation to each entry.
mapInv() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map the 1/x function to each entry.
mapInv() - Method in interface org.apache.commons.math3.linear.FieldVector
Map the 1/x function to each entry.
mapInv() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Map the 1/x function to each entry.
mapInvToSelf() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map the 1/x function to each entry.
mapInvToSelf() - Method in interface org.apache.commons.math3.linear.FieldVector
Map the 1/x function to each entry.
mapInvToSelf() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Map the 1/x function to each entry.
mapKeyToGroup(Comparable, Comparable) - Method in class org.jfree.data.KeyToGroupMap
Maps a key to a group.
mapMultiply(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a multiplication operation to each entry.
mapMultiply(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a multiplication operation to each entry.
mapMultiply(double) - Method in class org.apache.commons.math3.linear.RealVector
Multiply each entry by the argument.
mapMultiply(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Map a multiplication operation to each entry.
mapMultiplyToSelf(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a multiplication operation to each entry.
mapMultiplyToSelf(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Multiply each entry.
mapMultiplyToSelf(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a multiplication operation to each entry.
mapMultiplyToSelf(double) - Method in class org.apache.commons.math3.linear.RealVector
Multiply each entry.
mapMultiplyToSelf(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Map a multiplication operation to each entry.
mapNames() - Method in class jhplot.io.PFile
Generate an association between record number and object name.
mapState(FieldODEState<T>) - Method in class org.apache.commons.math3.ode.FieldEquationsMapper
Map a state to a complete flat array.
mapStateAndDerivative(T, T[], T[]) - Method in class org.apache.commons.math3.ode.FieldEquationsMapper
Map flat arrays to a state and derivative.
mapSubtract(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a subtraction operation to each entry.
mapSubtract(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a subtraction operation to each entry.
mapSubtract(double) - Method in class org.apache.commons.math3.linear.RealVector
Subtract a value from each entry.
mapSubtract(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Map a subtraction operation to each entry.
mapSubtractToSelf(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a subtraction operation to each entry.
mapSubtractToSelf(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Subtract a value from each entry.
mapSubtractToSelf(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a subtraction operation to each entry.
mapSubtractToSelf(double) - Method in class org.apache.commons.math3.linear.RealVector
Subtract a value from each entry.
mapSubtractToSelf(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Map a subtraction operation to each entry.
mapToSelf(UnivariateFunction) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Acts as if it is implemented as:
mapToSelf(UnivariateFunction) - Method in class org.apache.commons.math3.linear.RealVector
Acts as if it is implemented as:
MapUtils - Class in org.apache.commons.math3.ml.neuralnet
Utilities for network maps.
MapVisualization - Interface in org.apache.commons.math3.ml.neuralnet.twod.util
Interface for algorithms that compute some property of a 2D-map.
marginFit(PadMargins) - Method in class org.jlab.groot.base.PadMargins
 
mark(int) - Method in class org.apache.commons.io.input.BOMInputStream
Invokes the delegate's mark(int) method.
mark(int) - Method in class org.apache.commons.io.input.BoundedInputStream
Invokes the delegate's mark(int) method.
mark(int) - Method in class org.apache.commons.io.input.BoundedReader
marks the target stream
mark(int) - Method in class org.apache.commons.io.input.BrokenReader
Throws the configured exception.
mark(int) - Method in class org.apache.commons.io.input.CharSequenceInputStream
mark(int) - Method in class org.apache.commons.io.input.CharSequenceReader
Mark the current position.
mark(int) - Method in class org.apache.commons.io.input.MarkShieldInputStream
 
mark(int) - Method in class org.apache.commons.io.input.NullInputStream
Mark the current position.
mark(int) - Method in class org.apache.commons.io.input.NullReader
Marks the current position.
mark(int) - Method in class org.apache.commons.io.input.ProxyInputStream
Invokes the delegate's mark(int) method.
mark(int) - Method in class org.apache.commons.io.input.ProxyReader
Invokes the delegate's mark(int) method.
mark(int) - Method in class org.apache.commons.io.input.UnixLineEndingInputStream
mark(int) - Method in class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
 
mark(int) - Method in class org.apache.commons.io.input.WindowsLineEndingInputStream
MarkColor - Variable in class jminhep.gui.Plotter
 
marker - Variable in class graph.DataSet
The index of the marker to use at the data points.
Marker - Class in org.jfree.chart.plot
The base class for markers that can be added to plots to highlight a value or range of values.
MarkerAxisBand - Class in org.jfree.chart.axis
A band that can be added to a number axis to display regions.
MarkerAxisBand(NumberAxis, double, double, double, double, Font) - Constructor for class org.jfree.chart.axis.MarkerAxisBand
Constructs a new axis band.
markerChanged(MarkerChangeEvent) - Method in interface org.jfree.chart.event.MarkerChangeListener
Receives notification of a marker change event.
markerChanged(MarkerChangeEvent) - Method in class org.jfree.chart.plot.Plot
Receives notification of a change to a marker that is assigned to the plot.
MarkerChangeEvent - Class in org.jfree.chart.event
An event that can be forwarded to any MarkerChangeListener to signal a change to a Marker.
MarkerChangeEvent(Marker) - Constructor for class org.jfree.chart.event.MarkerChangeEvent
Creates a new MarkerChangeEvent instance.
MarkerChangeListener - Interface in org.jfree.chart.event
The interface that must be supported by classes that wish to receive notification of changes to a Marker.
markercolor - Variable in class graph.DataSet
The marker color
MARKERNAME - Static variable in class org.jlab.groot.data.GraphErrors
 
Markers - Class in graph
This class installs, manipulates and draws markers.
Markers() - Constructor for class graph.Markers
The class contructor
Markers(URL) - Constructor for class graph.Markers
Instantiate the Marker class and load marker definitions from the parsed URL.
markerscale - Variable in class graph.DataSet
The scaling factor for the marker.
MarkSelect - Variable in class jminhep.gui.Plotter
 
MarkSelectColor - Variable in class jminhep.gui.Plotter
 
MarkShieldInputStream - Class in org.apache.commons.io.input
This is an alternative to ByteArrayInputStream which removes the synchronization overhead for non-concurrent access; as such this class is not thread-safe.
MarkShieldInputStream(InputStream) - Constructor for class org.apache.commons.io.input.MarkShieldInputStream
Creates a proxy that shields the given input stream from being marked or rest.
MarkSize - Variable in class jminhep.gui.Plotter
 
markSupported() - Method in class org.apache.commons.io.input.BoundedInputStream
Invokes the delegate's markSupported() method.
markSupported() - Method in class org.apache.commons.io.input.CharSequenceInputStream
 
markSupported() - Method in class org.apache.commons.io.input.CharSequenceReader
Mark is supported (returns true).
markSupported() - Method in class org.apache.commons.io.input.MarkShieldInputStream
 
markSupported() - Method in class org.apache.commons.io.input.NullInputStream
Indicates whether mark is supported.
markSupported() - Method in class org.apache.commons.io.input.NullReader
Indicates whether mark is supported.
markSupported() - Method in class org.apache.commons.io.input.ProxyInputStream
Invokes the delegate's markSupported() method.
markSupported() - Method in class org.apache.commons.io.input.ProxyReader
Invokes the delegate's markSupported() method.
markSupported() - Method in class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
 
MArrayAccess - Class in org.lsmp.djep.matrixJep.function
 
MArrayAccess() - Constructor for class org.lsmp.djep.matrixJep.function.MArrayAccess
 
mass() - Method in class hephysics.jet.ParticleD
Compute mass.
mass() - Method in class hephysics.particle.LParticle
Get a mass
mass() - Method in class j4np.physics.LorentzVector
 
mass() - Method in class j4np.physics.PDGParticle
 
mass(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the sum of the elements of the array.
mass(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the sum of the elements of the array.
mass2() - Method in class j4np.physics.LorentzVector
 
MASS_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
MASS_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
MASS_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
MASS_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
MASS_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
MASS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.BLJets
 
MASS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.GenJets
 
MASS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Jets
 
MASS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
MASS_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
MAssign - Class in org.lsmp.djep.matrixJep.function
A matrix enabled assignment function.
MAssign() - Constructor for class org.lsmp.djep.matrixJep.function.MAssign
 
matches(String) - Method in interface org.apache.commons.io.serialization.ClassNameMatcher
Returns true if the supplied class name matches this object's condition.
MathArithmeticException - Exception in org.apache.commons.math3.exception
Base class for arithmetic exceptions.
MathArithmeticException() - Constructor for exception org.apache.commons.math3.exception.MathArithmeticException
Default constructor.
MathArithmeticException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathArithmeticException
Constructor with a specific message.
MathArrays - Class in org.apache.commons.math3.util
Arrays utilities.
MathArrays.Function - Interface in org.apache.commons.math3.util
Real-valued function that operate on an array or a part of it.
MathArrays.OrderDirection - Enum in org.apache.commons.math3.util
Specification of ordering direction.
MathArrays.Position - Enum in org.apache.commons.math3.util
Specification for indicating that some operation applies before or after a given index.
Mathfun - Class in jhplot.math
 
Mathfun() - Constructor for class jhplot.math.Mathfun
 
MathIllegalArgumentException - Exception in org.apache.commons.math3.exception
Base class for all preconditions violation exceptions.
MathIllegalArgumentException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathIllegalArgumentException
 
MathIllegalNumberException - Exception in org.apache.commons.math3.exception
Base class for exceptions raised by a wrong number.
MathIllegalStateException - Exception in org.apache.commons.math3.exception
Base class for all exceptions that signal that the process throwing the exception is in a state that does not comply with the set of states that it is designed to be in.
MathIllegalStateException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathIllegalStateException
Simple constructor.
MathIllegalStateException(Throwable, Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathIllegalStateException
Simple constructor.
MathIllegalStateException() - Constructor for exception org.apache.commons.math3.exception.MathIllegalStateException
Default constructor.
MathInternalError - Exception in org.apache.commons.math3.exception
Exception triggered when something that shouldn't happen does happen.
MathInternalError() - Constructor for exception org.apache.commons.math3.exception.MathInternalError
Simple constructor.
MathInternalError(Throwable) - Constructor for exception org.apache.commons.math3.exception.MathInternalError
Simple constructor.
MathInternalError(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathInternalError
Constructor accepting a localized message.
MathParseException - Exception in org.apache.commons.math3.exception
Class to signal parse failures.
MathParseException(String, int, Class<?>) - Constructor for exception org.apache.commons.math3.exception.MathParseException
 
MathParseException(String, int) - Constructor for exception org.apache.commons.math3.exception.MathParseException
 
MathParser - Class in jplot3dp.MathParser
 
MathParser() - Constructor for class jplot3dp.MathParser.MathParser
 
MathParser(InputStream) - Constructor for class jplot3dp.MathParser.MathParser
 
MathParser(Reader) - Constructor for class jplot3dp.MathParser.MathParser
 
MathParser(MathParserTokenManager) - Constructor for class jplot3dp.MathParser.MathParser
 
MathParserConstants - Interface in jplot3dp.MathParser
 
MathParserTokenManager - Class in jplot3dp.MathParser
 
MathParserTokenManager(SimpleCharStream) - Constructor for class jplot3dp.MathParser.MathParserTokenManager
 
MathParserTokenManager(SimpleCharStream, int) - Constructor for class jplot3dp.MathParser.MathParserTokenManager
 
MathRNG - Class in jhplot.math.num.random
A random number generator that delegates random number generation to the Math.random() method.
MathRNG() - Constructor for class jhplot.math.num.random.MathRNG
 
MathRuntimeException - Exception in org.apache.commons.math3.exception
As of release 4.0, all exceptions thrown by the Commons Math code (except NullArgumentException) inherit from this class.
MathRuntimeException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathRuntimeException
 
Maths - Class in Jama.util
 
Maths() - Constructor for class Jama.util.Maths
 
Maths - Class in jhplot.math.kalman.jama
 
Maths() - Constructor for class jhplot.math.kalman.jama.Maths
 
MathUnsupportedOperationException - Exception in org.apache.commons.math3.exception
Base class for all unsupported features.
MathUnsupportedOperationException() - Constructor for exception org.apache.commons.math3.exception.MathUnsupportedOperationException
Default constructor.
MathUnsupportedOperationException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathUnsupportedOperationException
 
MathUtils - Class in org.apache.commons.math3.util
Miscellaneous utility functions.
Matrix - Interface in hep.physics.matrix
A very simple matrix interface
Matrix - Interface in hephysics.matrix
A very simple matrix interface
Matrix - Class in Jama
Jama = Java Matrix class.
Matrix(int, int) - Constructor for class Jama.Matrix
Construct an m-by-n matrix of zeros.
Matrix(int, int, double) - Constructor for class Jama.Matrix
Construct an m-by-n constant matrix.
Matrix(double[][]) - Constructor for class Jama.Matrix
Construct a matrix from a 2-D array.
Matrix(double[][], int, int) - Constructor for class Jama.Matrix
Construct a matrix quickly without checking arguments.
Matrix(double[], int) - Constructor for class Jama.Matrix
Construct a matrix from a one-dimensional packed array
Matrix - Class in jhplot.math.kalman.jama
Jama = Java Matrix class.
Matrix(int, int) - Constructor for class jhplot.math.kalman.jama.Matrix
Construct an m-by-n matrix of zeros.
Matrix(int, int, double) - Constructor for class jhplot.math.kalman.jama.Matrix
Construct an m-by-n constant matrix.
Matrix(double[][]) - Constructor for class jhplot.math.kalman.jama.Matrix
Construct a matrix from a 2-D array.
Matrix(double[][], int, int) - Constructor for class jhplot.math.kalman.jama.Matrix
Construct a matrix quickly without checking arguments.
Matrix(double[], int) - Constructor for class jhplot.math.kalman.jama.Matrix
Construct a matrix from a one-dimensional packed array
Matrix - Class in org.lsmp.djep.vectorJep.values
Represents a matrix.
Matrix2DMatrix2DFunction - Interface in cern.colt.matrix.linalg
Interface that represents a function object: a function that takes two arguments and returns a single value.
MatrixConsole - Class in org.lsmp.djepExamples
 
MatrixConsole() - Constructor for class org.lsmp.djepExamples.MatrixConsole
 
MatrixDimensionMismatchException - Exception in org.apache.commons.math3.linear
Exception to be thrown when either the number of rows or the number of columns of a matrix do not match the expected values.
MatrixDimensionMismatchException(int, int, int, int) - Constructor for exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
Construct an exception from the mismatched dimensions.
MatrixEvaluator - Class in org.lsmp.djep.matrixJep
This visitor evaluates a the tree representing the equation.
MatrixEvaluator() - Constructor for class org.lsmp.djep.matrixJep.MatrixEvaluator
 
MatrixExample - Class in org.lsmp.djepExamples
Examples using vectors and matricies
MatrixExample() - Constructor for class org.lsmp.djepExamples.MatrixExample
 
MatrixJep - Class in org.lsmp.djep.matrixJep
An extension of JEP which allows advanced vector and matrix handling and differentation.
MatrixJep() - Constructor for class org.lsmp.djep.matrixJep.MatrixJep
 
MatrixJepTest - Class in org.lsmp.djepJUnit
 
MatrixJepTest(String) - Constructor for class org.lsmp.djepJUnit.MatrixJepTest
 
MatrixNodeFactory - Class in org.lsmp.djep.matrixJep
This class is used to create nodes of specified types.
MatrixNodeFactory(XJep) - Constructor for class org.lsmp.djep.matrixJep.MatrixNodeFactory
 
MatrixNodeI - Interface in org.lsmp.djep.matrixJep.nodeTypes
 
MatrixOp - Class in hep.physics.matrix
Simple operations on matrices
MatrixOp - Class in hephysics.matrix
Simple operations on matrices
MatrixOp.IndeterminateMatrixException - Exception in hep.physics.matrix
 
MatrixOp.IndeterminateMatrixException - Exception in hephysics.matrix
 
MatrixOp.InvalidMatrixException - Exception in hep.physics.matrix
 
MatrixOp.InvalidMatrixException - Exception in hephysics.matrix
 
MatrixOperatorSet - Class in org.lsmp.djep.matrixJep
The set of operators used in matricies.
MatrixOperatorSet() - Constructor for class org.lsmp.djep.matrixJep.MatrixOperatorSet
 
MatrixPartialDerivative - Class in org.lsmp.djep.matrixJep
Contains information about a PartialDerivative of a variable.
MatrixPreprocessor - Class in org.lsmp.djep.matrixJep
This visitor does the majority of preprocessing work.
MatrixPreprocessor() - Constructor for class org.lsmp.djep.matrixJep.MatrixPreprocessor
 
MatrixSeries - Class in org.jfree.data.xy
Represents a dense matrix M[i,j] where each Mij item of the matrix has a value (default is 0).
MatrixSeries(String, int, int) - Constructor for class org.jfree.data.xy.MatrixSeries
Constructs a new matrix series.
MatrixSeriesCollection - Class in org.jfree.data.xy
Represents a collection of MatrixSeries that can be used as a dataset.
MatrixSeriesCollection() - Constructor for class org.jfree.data.xy.MatrixSeriesCollection
Constructs an empty dataset.
MatrixSeriesCollection(MatrixSeries) - Constructor for class org.jfree.data.xy.MatrixSeriesCollection
Constructs a dataset and populates it with a single matrix series.
MatrixSpecialEvaluationI - Interface in org.lsmp.djep.matrixJep
If a function requires a special form of evaluation it should implement this interface.
MatrixSpeed - Class in org.lsmp.djepExamples
Compares the speed of matrix operations using both VectorJep or MatrixJep.
MatrixSpeed() - Constructor for class org.lsmp.djepExamples.MatrixSpeed
 
MatrixUtils - Class in org.apache.commons.math3.linear
A collection of static methods that operate on or return matrices.
MatrixValueI - Interface in org.lsmp.djep.vectorJep.values
Interface defining methods needed to work with vectors and matricies.
MatrixVariable - Class in org.lsmp.djep.matrixJep
Holds all info about a variable.
MatrixVariableFactory - Class in org.lsmp.djep.matrixJep
Allows creation of matrix aware variables.
MatrixVariableFactory() - Constructor for class org.lsmp.djep.matrixJep.MatrixVariableFactory
 
MatrixVariableI - Interface in org.lsmp.djep.matrixJep
Matrix aware variables should implement this interface.
max() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the maximum.
max - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.max().
max() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the maximum.
max() - Method in class cern.hep.aida.bin.StaticBin1D
Returns the maximum.
max - Static variable in class cern.jet.math.Functions
Function that returns Math.max(a,b).
max(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns Math.max(a,b).
max - Static variable in class cern.jet.math.IntFunctions
Function that returns Math.max(a,b).
max(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns Math.max(a,b).
max(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the largest member of a data sequence.
max(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the maximum of an array.
max(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns the maximum of an array.
max(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the maximum of an array.
max(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns the maximum of an array.
max(double[][]) - Static method in class jhplot.math.DoubleArray
Finds the maximum value in each column of a matrix.
max(double...) - Static method in class jhplot.math.DoubleArray
Finds maximum value in either a list of numbers or a single array.
max(int[][]) - Static method in class jhplot.math.IntegerArray
 
max(int...) - Static method in class jhplot.math.IntegerArray
 
Max - Static variable in class jminhep.gui.SetEnv
 
max - Variable in class jplot3dp.ModelView.AxesDefinition
 
max(float, float) - Static method in class net.jafama.FastMath
 
max(double, double) - Static method in class net.jafama.FastMath
 
max(float, float) - Static method in class net.jafama.StrictFastMath
 
max(double, double) - Static method in class net.jafama.StrictFastMath
 
Max - Class in org.apache.commons.math3.analysis.function
Maximum function.
Max() - Constructor for class org.apache.commons.math3.analysis.function.Max
 
Max - Class in org.apache.commons.math3.stat.descriptive.rank
Returns the maximum of the available values.
Max() - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Max
Create a Max instance
Max(Max) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Max
Copy constructor, creates a new Max identical to the original
max(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the maximum of the entries in the input array, or Double.NaN if the array is empty.
max(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the maximum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
max(int, int) - Static method in class org.apache.commons.math3.util.FastMath
Compute the maximum of two values
max(long, long) - Static method in class org.apache.commons.math3.util.FastMath
Compute the maximum of two values
max(float, float) - Static method in class org.apache.commons.math3.util.FastMath
Compute the maximum of two values
max(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the maximum of two values
max(T, T) - Static method in class org.apache.commons.math3.util.MathUtils
Find the maximum of two field elements.
max() - Method in class org.jlab.groot.math.Axis
A getter for the maximum value of the axis
max() - Method in class org.jlab.groot.math.UserParameter
 
Max - Class in org.lsmp.djep.xjep.function
A max function Max(x^2,x,1,10) finds the max of x^2 with x running from 1 to 10.
Max() - Constructor for class org.lsmp.djep.xjep.function.Max
 
MAX_EXP - Static variable in class org.apache.commons.math3.dfp.Dfp
The maximum exponent before overflow is signaled and results flushed to infinity
MAX_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.F1D
 
MAX_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
MAX_INTERIOR_GAP - Static variable in class org.jfree.chart.plot.PiePlot
The maximum interior gap (currently 40%).
MAX_INTERIOR_GAP - Static variable in class org.jfree.chart.plot.SpiderWebPlot
The maximum interior gap (currently 40%).
MaxArg - Class in org.lsmp.djep.xjep.function
 
MaxArg() - Constructor for class org.lsmp.djep.xjep.function.MaxArg
 
maxBinHeight() - Method in class jhplot.H1D
Max value of all bins
maxBinHeight() - Method in class jhplot.HProf1D
Max value of all bins
MaxCountExceededException - Exception in org.apache.commons.math3.exception
Exception to be thrown when some counter maximum value is exceeded.
MaxCountExceededException(Number) - Constructor for exception org.apache.commons.math3.exception.MaxCountExceededException
Construct the exception.
MaxCountExceededException(Localizable, Number, Object...) - Constructor for exception org.apache.commons.math3.exception.MaxCountExceededException
Construct the exception with a specific context.
MaxData - Static variable in class jminhep.clcontrol.Global
 
MaxEval - Class in org.apache.commons.math3.optim
Maximum number of evaluations of the function to be optimized.
MaxEval(int) - Constructor for class org.apache.commons.math3.optim.MaxEval
 
maxEvaluations(int) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the max evaluations.
MAXIMUM - Static variable in class cern.colt.matrix.doublealgo.Statistic
Maximum distance function; Max( abs(x[i]-y[i]) ).
maximum - Variable in class graph.Axis
Maximum data value of the axis.
MAXIMUM - Static variable in class graph.VectorSet
A constant value flag used to specify if the max magnitude of the vectors is going to be used as the scaling variable
MAXIMUM_TICK_COUNT - Static variable in class org.jfree.chart.axis.ValueAxis
The maximum tick count.
MAXIMUM_YEAR - Static variable in class org.jfree.data.time.Year
The maximum year value.
maxIndex(double[]) - Static method in class jhplot.math.ArrayMathUtils
returns the index of the greatest element from the given array
maxIndex(double[][]) - Static method in class jhplot.math.DoubleArray
Finds the indices of the minimum values in each column of a matrix.
maxIndex(double...) - Static method in class jhplot.math.DoubleArray
Finds the index of the maximum value in a list of values or an array.
maxIndex(int[][]) - Static method in class jhplot.math.IntegerArray
 
maxIndex(int...) - Static method in class jhplot.math.IntegerArray
 
MAXITER - Static variable in class Jampack.Schur
Limits the number of interations in the QR algorithm
MAXITER - Static variable in class Jampack.Zsvd
Limits the number of iterations in the SVD algorithm
MaxIter - Class in org.apache.commons.math3.optim
Maximum number of iterations performed by an (iterative) algorithm.
MaxIter(int) - Constructor for class org.apache.commons.math3.optim.MaxIter
 
maxIterations(int) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the max iterations.
maxSignedIntForBitSize(int) - Static method in class net.jafama.NumbersUtils
 
maxSignedLongForBitSize(int) - Static method in class net.jafama.NumbersUtils
 
maxState - Variable in class jhplot.stat.ProbabilityState
 
maxUnsignedIntForBitSize(int) - Static method in class net.jafama.NumbersUtils
 
maxUnsignedLongForBitSize(int) - Static method in class net.jafama.NumbersUtils
 
MAXVAL - Static variable in class jminhep.algorithms.HierarchicalAlg
 
MAXVAL - Variable in class jminhep.algorithms.KMeansExchangeAlg
 
MAXX_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.F2D
 
MAXY_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.F2D
 
MC_PARTICLES - Static variable in interface hep.physics.event.generator.MCEvent
 
MCEvent - Interface in hep.physics.event.generator
A simulated event consisting of a set of MC particles.
MCPARTICLE - Static variable in interface hep.lcio.event.LCIO
 
MCParticle - Interface in hep.lcio.event
The LCIO Monte Carlo particle.
MD5 - Class in jhplot.security
Get MD5 hash for any object or a file with data
MD5(Object) - Constructor for class jhplot.security.MD5
Initialize MD5 calculations
MD5(File) - Constructor for class jhplot.security.MD5
Initialize MD5 calculations for a file
MD5(String) - Static method in class jhplot.security.SimpleMD5
 
mdfft(Object, TransformType) - Method in class org.apache.commons.math3.transform.FastFourierTransformer
Deprecated.
see MATH-736
MDiff - Class in org.lsmp.djep.matrixJep.function
 
MDiff() - Constructor for class org.lsmp.djep.matrixJep.function.MDiff
 
MDivide - Class in org.lsmp.djep.vectorJep.function
An extension of the Divide class with vectors and matricies.
MDivide() - Constructor for class org.lsmp.djep.vectorJep.function.MDivide
 
MDot - Class in org.lsmp.djep.vectorJep.function
The MDot operator.
MDot() - Constructor for class org.lsmp.djep.vectorJep.function.MDot
 
mean() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the arithmetic mean, which is Sum( x[i] ) / size().
mean - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.mean().
mean() - Method in class cern.hep.aida.ref.Histogram1D
 
mean(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the arithmetic mean of a data sequence; That is Sum( data[i] ) / data.size().
mean() - Method in interface colt.hep.aida.IHistogram1D
Returns the mean of the whole histogram as calculated on filling-time.
MEAN - Static variable in class graph.VectorSet
A constant value flag used to specify if the mean magnitude of the vectors is going to be used as the scaling variable
mean() - Method in class jhplot.H1D
Get mean of the histogram
mean() - Method in class jhplot.HProf1D
Get mean of the histogram
mean(double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the mean.
mean(int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the mean.
mean(double[]) - Static method in class jhplot.math.StatisticSample
Get mean value
mean(double[][]) - Static method in class jhplot.math.StatisticSample
Get mean
mean() - Method in class jhplot.P0D
Returns the mean value.
mean() - Method in class jhplot.P0I
Returns the mean value.
mean(int) - Method in class jhplot.P2D
Returns the mean value for any axis
mean(double[]) - Static method in class jhplot.stat.Statistics
Get mean value
mean(double[][]) - Static method in class jhplot.stat.Statistics
Get mean
mean() - Method in class jplot.DataArray
 
Mean - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the arithmetic mean of a set of values.
Mean() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Mean
Constructs a Mean.
Mean(FirstMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Mean
Constructs a Mean with an External Moment.
Mean(Mean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Mean
Copy constructor, creates a new Mean identical to the original
mean(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the arithmetic mean of the entries in the input array, or Double.NaN if the array is empty.
mean(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the arithmetic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
MEAN_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
MeanAndStandardDeviation - Class in org.jfree.data.statistics
A simple data structure that holds a mean value and a standard deviation value.
MeanAndStandardDeviation(double, double) - Constructor for class org.jfree.data.statistics.MeanAndStandardDeviation
Creates a new mean and standard deviation record.
MeanAndStandardDeviation(Number, Number) - Constructor for class org.jfree.data.statistics.MeanAndStandardDeviation
Creates a new mean and standard deviation record.
meanDeviation(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the mean deviation of a dataset.
meanDifference(double[], double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the mean of the (signed) differences between corresponding elements of the input arrays -- i.e., sum(sample1[i] - sample2[i]) / sample1.length.
meanLow(int, int) - Static method in class net.jafama.NumbersUtils
 
meanLow(long, long) - Static method in class net.jafama.NumbersUtils
 
MEANS_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
meanSml(int, int) - Static method in class net.jafama.NumbersUtils
 
meanSml(long, long) - Static method in class net.jafama.NumbersUtils
 
MEANSX_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
MEANSY_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
meanX() - Method in class cern.hep.aida.ref.Histogram2D
 
meanX() - Method in class cern.hep.aida.ref.Histogram3D
 
meanX() - Method in interface colt.hep.aida.IHistogram2D
Returns the mean of the histogram, as calculated on filling-time projected on the X axis.
meanX() - Method in interface colt.hep.aida.IHistogram3D
Returns the mean of the histogram, as calculated on filling-time projected on the X axis.
meanX() - Method in class jhplot.P1D
Returns the mean value in X.
meanX() - Method in class jhplot.P2D
Returns the mean value in X.
meanX() - Method in class jhplot.P3D
Returns the mean value in X.
meanX() - Method in class jplot.DataArray2D
 
meanX() - Method in class jplot.DataArray3D
 
meanXerror() - Method in class jhplot.P1D
Returns the standard error of the mean values for X.
meanY() - Method in class cern.hep.aida.ref.Histogram2D
 
meanY() - Method in class cern.hep.aida.ref.Histogram3D
 
meanY() - Method in interface colt.hep.aida.IHistogram2D
Returns the mean of the histogram, as calculated on filling-time projected on the Y axis.
meanY() - Method in interface colt.hep.aida.IHistogram3D
Returns the mean of the histogram, as calculated on filling-time projected on the Y axis.
meanY() - Method in class jhplot.P1D
Returns the mean value in Y.
meanY() - Method in class jhplot.P2D
Returns the mean value in Y.
meanY() - Method in class jhplot.P3D
Returns the mean value in Y.
meanY() - Method in class jplot.DataArray2D
 
meanY() - Method in class jplot.DataArray3D
 
meanYerror() - Method in class jhplot.P1D
Returns the standard error of the mean values for Y.
meanZ() - Method in class cern.hep.aida.ref.Histogram3D
 
meanZ() - Method in interface colt.hep.aida.IHistogram3D
Returns the mean of the histogram, as calculated on filling-time projected on the Z axis.
meanZ() - Method in class jhplot.P2D
Returns the mean value in Z.
meanZ() - Method in class jhplot.P3D
Returns the mean value in Z.
meanZ() - Method in class jplot.DataArray2D
 
meanZ() - Method in class jplot.DataArray3D
 
MeasurementModel - Interface in org.apache.commons.math3.filter
Defines the measurement model for the use with a KalmanFilter.
median - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.median().
median() - Method in class cern.hep.aida.bin.QuantileBin1D
Returns the median.
median(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the median of a sorted data sequence.
median(double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the median of an array.
median(int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the median of an array.
median() - Method in class jhplot.P0D
Returns the median.
median() - Method in class jhplot.P0I
Returns the median.
Median - Class in org.apache.commons.math3.stat.descriptive.rank
Returns the median of the available values.
Median() - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Median
Default constructor.
Median(Median) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Median
Copy constructor, creates a new Median identical to the original
MedianOf3PivotingStrategy - Class in org.apache.commons.math3.util
Classic median of 3 strategy given begin and end indices.
MedianOf3PivotingStrategy() - Constructor for class org.apache.commons.math3.util.MedianOf3PivotingStrategy
 
mEditArea - Variable in class jminhep.clcontrol.SummaryPad
 
megaelectronvolt - Static variable in class cern.clhep.Units
 
megahertz - Static variable in class cern.clhep.Units
 
megavolt - Static variable in class cern.clhep.Units
 
mem - Static variable in class jminhep.clcontrol.Global
 
memory() - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Returns the number of elements currently needed to store all contained elements.
MemoryMonitor - Class in jhepsim
Simple memory monitor.
MemoryMonitor() - Constructor for class jhepsim.MemoryMonitor
 
MemoryMonitor - Class in jhplot.utils
Simple memory monitor.
MemoryMonitor() - Constructor for class jhplot.utils.MemoryMonitor
 
MemoryMonitor - Class in jminhep.utils
Simple memory monitor.
MemoryMonitor() - Constructor for class jminhep.utils.MemoryMonitor
 
Merge - Class in Jampack
Merge is a class containing programs to merge matrices into one big matrix.
Merge() - Constructor for class Jampack.Merge
 
merge(double[]...) - Static method in class jhplot.math.DoubleArray
Concatenates arrays.
merge(int[]...) - Static method in class jhplot.math.IntegerArray
 
merge(P0D) - Method in class jhplot.P0D
Merge two P0D containers
merge(P0I) - Method in class jhplot.P0I
Merge two P0I containers
merge(P1D) - Method in class jhplot.P1D
Merge two P1D containers.
merge(P2D) - Method in class jhplot.P2D
Merge two P2D containers
merge(P3D) - Method in class jhplot.P3D
Merge two P3D containers
merge(BSPTree<S>, BSPTree<S>, BSPTree<S>, boolean, boolean) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTree.LeafMerger
Merge a leaf node and a tree node.
merge(BSPTree<S>, BSPTree.LeafMerger<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Merge a BSP tree with the instance.
merge(Frequency) - Method in class org.apache.commons.math3.stat.Frequency
Merge another Frequency object's counts into this instance.
merge(Collection<Frequency>) - Method in class org.apache.commons.math3.stat.Frequency
Merge a Collection of Frequency objects into this instance.
mergeArrays(double[], double[], double[]) - Static method in class jhplot.stat.ProbabilityState
Takes in two arrays and writes the joint state of those arrays to the output vector, returning the maximum joint state.
mergeBjets(ProMC.ProMCEvent.BLJets) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.BLJets bjets = 5;
mergeCollection(LCCollection, LCCollection, float) - Static method in class hep.lcio.util.MergeUtil
overlayCollection overlays the overlayColl onto the targetColl applying the delta time, dt.
mergeColumns(double[]...) - Static method in class jhplot.math.DoubleArray
Combine a set of arrays into a matrix.
mergeColumns(int[]...) - Static method in class jhplot.math.IntegerArray
 
MergeCommandHandler - Class in hep.lcio.util
This is the CommandHandler for the merge utility.
mergeDefaultCollection(LCCollection, LCCollection) - Static method in class hep.lcio.util.MergeUtil
Merge overlayColl into targetColl without applying a delta time.
mergeElectrons(ProMC.ProMCEvent.Electrons) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Electrons electrons = 6;
mergeEvent(ProMC.ProMCEvent.Event) - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
mergeEvent(ProMC.ProMCEvent.Event) - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
mergeEvent(ProMC.ProMCEvent.Event) - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
mergeEvent(ProMC.ProMCEvent.Event) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
mergeEvents(LCEvent, LCReader, int, boolean, float, float) - Static method in class hep.lcio.util.MergeUtil
Merge ntoread events from a reader into a single target event, applying time delta dt with starting time of startt.
mergeF1D(PBufFile.Record.F1D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F1D f1D = 9;
mergeF2D(PBufFile.Record.F2D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F2D f2D = 10;
MergeFileParameters - Class in hep.lcio.util
Encapsulates parameters for events to be merged.
mergeFiles(File, List, int) - Static method in class hep.lcio.util.MergeUtil
Merge events from mergeFiles into a single event in outfile, until all the files in mergeFiles are exhausted, or maxevents are created.
mergeFiles(File, List) - Static method in class hep.lcio.util.MergeUtil
Merge nEventsToRead events from each File in mergeFiles into a single event in outfile, until records in mergeFiles are exhausted.
mergeFND(PBufFile.Record.FND) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FND fND = 11;
mergeFPR(PBufFile.Record.FPR) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FPR fPR = 12;
mergeFrom(Message) - Method in class proeic.io.ProMC.ProMCEvent.Builder
 
mergeFrom(ProMC.ProMCEvent) - Method in class proeic.io.ProMC.ProMCEvent.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMC.ProMCEvent.Builder
 
mergeFrom(Message) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(ProMC.ProMCEvent.Event) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(Message) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(ProMC.ProMCEvent.Particles) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(Message) - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(ProMCDescriptionFile.ProMCDescription) - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(Message) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(Message) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(Message) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(Message) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(Message) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(ProMCStatFile.ProMCStat) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(Message) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
 
mergeFrom(ProMCStatFile.ProMCStat.MetaFloat) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
 
mergeFrom(Message) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
 
mergeFrom(ProMCStatFile.ProMCStat.MetaInt) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
 
mergeFrom(Message) - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeFrom(ProMCStatFile.ProMCStat.ProcessData) - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.Builder
 
mergeFrom(PBufFile.Record) - Method in class promc.io.PBufFile.Record.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.F1D.Builder
 
mergeFrom(PBufFile.Record.F1D) - Method in class promc.io.PBufFile.Record.F1D.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.F1D.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.F2D.Builder
 
mergeFrom(PBufFile.Record.F2D) - Method in class promc.io.PBufFile.Record.F2D.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.F2D.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.FND.Builder
 
mergeFrom(PBufFile.Record.FND) - Method in class promc.io.PBufFile.Record.FND.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.FND.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.FPR.Builder
 
mergeFrom(PBufFile.Record.FPR) - Method in class promc.io.PBufFile.Record.FPR.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.FPR.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.H1D.Builder
 
mergeFrom(PBufFile.Record.H1D) - Method in class promc.io.PBufFile.Record.H1D.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.H1D.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.H2D.Builder
 
mergeFrom(PBufFile.Record.H2D) - Method in class promc.io.PBufFile.Record.H2D.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.H2D.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.P0D.Builder
 
mergeFrom(PBufFile.Record.P0D) - Method in class promc.io.PBufFile.Record.P0D.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.P0D.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.P0I.Builder
 
mergeFrom(PBufFile.Record.P0I) - Method in class promc.io.PBufFile.Record.P0I.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.P0I.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.P1D.Builder
 
mergeFrom(PBufFile.Record.P1D) - Method in class promc.io.PBufFile.Record.P1D.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.P1D.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.PND.Builder
 
mergeFrom(PBufFile.Record.PND) - Method in class promc.io.PBufFile.Record.PND.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.PND.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.PNI.Builder
 
mergeFrom(PBufFile.Record.PNI) - Method in class promc.io.PBufFile.Record.PNI.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.PNI.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.PXY.Builder
 
mergeFrom(PBufFile.Record.PXY) - Method in class promc.io.PBufFile.Record.PXY.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.PXY.Builder
 
mergeFrom(Message) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
 
mergeFrom(PBufFile.Record.PXYZ) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
 
mergeFrom(Message) - Method in class promc.io.PEventFile.HEvent.Builder
 
mergeFrom(PEventFile.HEvent) - Method in class promc.io.PEventFile.HEvent.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PEventFile.HEvent.Builder
 
mergeFrom(Message) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
 
mergeFrom(PEventFile.HEvent.Entry) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
 
mergeFrom(Message) - Method in class promc.io.PEventFile.HEvent.Group.Builder
 
mergeFrom(PEventFile.HEvent.Group) - Method in class promc.io.PEventFile.HEvent.Group.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.PEventFile.HEvent.Group.Builder
 
mergeFrom(Message) - Method in class promc.io.ProMC.ProMCEvent.Builder
 
mergeFrom(ProMC.ProMCEvent) - Method in class promc.io.ProMC.ProMCEvent.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.ProMC.ProMCEvent.Builder
 
mergeFrom(Message) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(ProMC.ProMCEvent.Event) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(Message) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(ProMC.ProMCEvent.Particles) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(Message) - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(ProMCDescriptionFile.ProMCDescription) - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(Message) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(Message) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(Message) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(Message) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(Message) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(ProMCStatFile.ProMCStat) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(Message) - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeFrom(ProMCStatFile.ProMCStat.ProcessData) - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeFrom(Message) - Method in class pronlo.io.ProMC.ProMCEvent.Builder
 
mergeFrom(ProMC.ProMCEvent) - Method in class pronlo.io.ProMC.ProMCEvent.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class pronlo.io.ProMC.ProMCEvent.Builder
 
mergeFrom(Message) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(ProMC.ProMCEvent.Event) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(Message) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(ProMC.ProMCEvent.Particles) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(Message) - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(ProMCDescriptionFile.ProMCDescription) - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(Message) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(Message) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(Message) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(Message) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(Message) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(ProMCStatFile.ProMCStat) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(Message) - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeFrom(ProMCStatFile.ProMCStat.ProcessData) - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
 
mergeFrom(ProMC.ProMCEvent.BLJets) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMC.ProMCEvent.Builder
 
mergeFrom(ProMC.ProMCEvent) - Method in class proreco.io.ProMC.ProMCEvent.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMC.ProMCEvent.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
 
mergeFrom(ProMC.ProMCEvent.Electrons) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(ProMC.ProMCEvent.Event) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
 
mergeFrom(ProMC.ProMCEvent.GenJets) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
 
mergeFrom(ProMC.ProMCEvent.Jets) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
 
mergeFrom(ProMC.ProMCEvent.MissingET) - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
 
mergeFrom(ProMC.ProMCEvent.Muons) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(ProMC.ProMCEvent.Particles) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
 
mergeFrom(ProMC.ProMCEvent.Photons) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
 
mergeFrom(ProMC.ProMCEvent.Tracks) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(ProMCDescriptionFile.ProMCDescription) - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(ProMCStatFile.ProMCStat) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
 
mergeFrom(Message) - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeFrom(ProMCStatFile.ProMCStat.ProcessData) - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeFrom(CodedInputStream, ExtensionRegistryLite) - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
 
mergeGenjets(ProMC.ProMCEvent.GenJets) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.GenJets genjets = 4;
mergeH1D(PBufFile.Record.H1D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H1D h1D = 7;
mergeH2D(PBufFile.Record.H2D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H2D h2D = 8;
mergeJets(ProMC.ProMCEvent.Jets) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Jets jets = 3;
mergeMCParticleCollection(LCCollection, LCCollection, float) - Static method in class hep.lcio.util.MergeUtil
Merge MCParticle collection overlayColl into targetColl.
mergeMissingET(ProMC.ProMCEvent.MissingET) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.MissingET missingET = 10;
mergeMuons(ProMC.ProMCEvent.Muons) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Muons muons = 7;
mergeP0D(PBufFile.Record.P0D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0D p0D = 3;
mergeP0I(PBufFile.Record.P0I) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0I p0I = 2;
mergeP1D(PBufFile.Record.P1D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P1D p1D = 6;
mergeParticles(ProMC.ProMCEvent.Particles) - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
mergeParticles(ProMC.ProMCEvent.Particles) - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
mergeParticles(ProMC.ProMCEvent.Particles) - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
mergeParticles(ProMC.ProMCEvent.Particles) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
mergePhotons(ProMC.ProMCEvent.Photons) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Photons photons = 9;
mergePND(PBufFile.Record.PND) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PND pND = 13;
mergePNI(PBufFile.Record.PNI) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PNI pNI = 14;
mergePXY(PBufFile.Record.PXY) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXY pXY = 4;
mergePXYZ(PBufFile.Record.PXYZ) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXYZ pXYZ = 5;
mergeRows(double[]...) - Static method in class jhplot.math.DoubleArray
Combine a set of arrays into a matrix.
mergeRows(int[]...) - Static method in class jhplot.math.IntegerArray
 
mergeSimCalorimeterHitCollection(LCCollection, LCCollection, float) - Static method in class hep.lcio.util.MergeUtil
Merge SimCalorimeterHit collection overlayColl into targetColl.
mergeSimTrackerHitCollection(LCCollection, LCCollection, float) - Static method in class hep.lcio.util.MergeUtil
Merge SimTrackerHit collection overlayColl into targetColl.
mergeSingleEvent(ILCEvent, LCEvent, float) - Static method in class hep.lcio.util.MergeUtil
Overlay the overlay event onto target event, applying time delta.
mergeSort(int, int, IntComparator, Swapper) - Static method in class cern.colt.GenericSorting
Sorts the specified range of elements according to the order induced by the specified comparator.
mergeSort() - Method in class cern.colt.list.AbstractList
Sorts the receiver into ascending order.
mergeSort - Static variable in class cern.colt.matrix.doublealgo.Sorting
A prefabricated mergesort.
mergeSort - Static variable in class cern.colt.matrix.objectalgo.Sorting
A prefabricated mergesort.
mergeSort(byte[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(byte[], int, int, ByteComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(char[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(char[], int, int, CharComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(double[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(double[], int, int, DoubleComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(float[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(float[], int, int, FloatComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(int[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(int[], int, int, IntComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(long[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(long[], int, int, LongComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(short[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(short[], int, int, ShortComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractByteList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, ByteComparator) - Method in class cern.colt.list.AbstractByteList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractCharList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, CharComparator) - Method in class cern.colt.list.AbstractCharList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractDoubleList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, DoubleComparator) - Method in class cern.colt.list.AbstractDoubleList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractFloatList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, FloatComparator) - Method in class cern.colt.list.AbstractFloatList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractIntList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, IntComparator) - Method in class cern.colt.list.AbstractIntList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractList
Sorts the receiver into ascending order.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractLongList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, LongComparator) - Method in class cern.colt.list.AbstractLongList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractShortList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, ShortComparator) - Method in class cern.colt.list.AbstractShortList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Sorts the specified range of the receiver into ascending order (false < true).
mergeSortFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Sorts the specified range of the receiver into ascending order, according to the natural ordering of its elements.
mergeSortFromTo(int, int, Comparator) - Method in class cern.colt.list.ObjectArrayList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortInPlace(int[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
MergeTestEvents - Class in hep.lcio.util
Create some very simple test events for the Merge utility.
MergeTestEvents() - Constructor for class hep.lcio.util.MergeTestEvents
 
mergeTracks(ProMC.ProMCEvent.Tracks) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Tracks tracks = 8;
MergeUtil - Class in hep.lcio.util
Utility methods for merging together LCIO files, events, and collections, with optional application of a delta time.
MergeUtil() - Constructor for class hep.lcio.util.MergeUtil
 
MersenneTwister - Class in cern.jet.random.engine
MersenneTwister (MT19937) is one of the strongest uniform pseudo-random number generators known so far; at the same time it is quick.
MersenneTwister() - Constructor for class cern.jet.random.engine.MersenneTwister
Constructs and returns a random number generator with a default seed, which is a constant.
MersenneTwister(int) - Constructor for class cern.jet.random.engine.MersenneTwister
Constructs and returns a random number generator with the given seed.
MersenneTwister(Date) - Constructor for class cern.jet.random.engine.MersenneTwister
Constructs and returns a random number generator seeded with the given date.
MersenneTwister - Class in org.apache.commons.math3.random
This class implements a powerful pseudo-random number generator developed by Makoto Matsumoto and Takuji Nishimura during 1996-1997.
MersenneTwister() - Constructor for class org.apache.commons.math3.random.MersenneTwister
Creates a new random number generator.
MersenneTwister(int) - Constructor for class org.apache.commons.math3.random.MersenneTwister
Creates a new random number generator using a single int seed.
MersenneTwister(int[]) - Constructor for class org.apache.commons.math3.random.MersenneTwister
Creates a new random number generator using an int array seed.
MersenneTwister(long) - Constructor for class org.apache.commons.math3.random.MersenneTwister
Creates a new random number generator using a single long seed.
MersenneTwister64 - Class in cern.jet.random.engine
Same as MersenneTwister except that method raw() returns 64 bit random numbers instead of 32 bit random numbers.
MersenneTwister64() - Constructor for class cern.jet.random.engine.MersenneTwister64
Constructs and returns a random number generator with a default seed, which is a constant.
MersenneTwister64(int) - Constructor for class cern.jet.random.engine.MersenneTwister64
Constructs and returns a random number generator with the given seed.
MersenneTwister64(Date) - Constructor for class cern.jet.random.engine.MersenneTwister64
Constructs and returns a random number generator seeded with the given date.
MESH_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
MessageDigestCalculatingInputStream - Class in org.apache.commons.io.input
This class is an example for using an ObservableInputStream.
MessageDigestCalculatingInputStream(InputStream, MessageDigest) - Constructor for class org.apache.commons.io.input.MessageDigestCalculatingInputStream
Creates a new instance, which calculates a signature on the given stream, using the given MessageDigest.
MessageDigestCalculatingInputStream(InputStream, String) - Constructor for class org.apache.commons.io.input.MessageDigestCalculatingInputStream
Creates a new instance, which calculates a signature on the given stream, using a MessageDigest with the given algorithm.
MessageDigestCalculatingInputStream(InputStream) - Constructor for class org.apache.commons.io.input.MessageDigestCalculatingInputStream
Creates a new instance, which calculates a signature on the given stream, using a MessageDigest with the "MD5" algorithm.
MessageDigestCalculatingInputStream.MessageDigestMaintainingObserver - Class in org.apache.commons.io.input
Maintains the message digest.
MessageDigestMaintainingObserver(MessageDigest) - Constructor for class org.apache.commons.io.input.MessageDigestCalculatingInputStream.MessageDigestMaintainingObserver
Creates an MessageDigestMaintainingObserver for the given MessageDigest.
MET_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.MissingET
 
METAFLOAT_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
METAFLOAT_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
METAFLOAT_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
METAFLOAT_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
METAFLOAT_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
METAINT_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
METAINT_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
METAINT_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
METAINT_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
METAINT_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
meter - Static variable in class cern.clhep.Units
 
meter2 - Static variable in class cern.clhep.Units
 
meter3 - Static variable in class cern.clhep.Units
 
MeterInterval - Class in org.jfree.chart.plot
An interval to be highlighted on a MeterPlot.
MeterInterval(String, Range) - Constructor for class org.jfree.chart.plot.MeterInterval
Creates a new interval.
MeterInterval(String, Range, Paint, Stroke, Paint) - Constructor for class org.jfree.chart.plot.MeterInterval
Creates a new interval.
MeterNeedle - Class in org.jfree.chart.needle
The base class used to represent the needle on a CompassPlot.
MeterNeedle() - Constructor for class org.jfree.chart.needle.MeterNeedle
Creates a new needle.
MeterNeedle(Paint, Paint, Paint) - Constructor for class org.jfree.chart.needle.MeterNeedle
Creates a new needle.
MeterPlot - Class in org.jfree.chart.plot
A plot that displays a single value in the form of a needle on a dial.
MeterPlot() - Constructor for class org.jfree.chart.plot.MeterPlot
Creates a new plot with a default range of 0 to 100 and no value to display.
MeterPlot(ValueDataset) - Constructor for class org.jfree.chart.plot.MeterPlot
Creates a new plot that displays the value from the supplied dataset.
metropolis(double[], F1D, double) - Static method in class jhplot.math.Numeric
The Metropolis algorithm.
MeV - Static variable in class cern.clhep.Units
 
mg - Static variable in class cern.clhep.Units
 
microampere - Static variable in class cern.clhep.Units
 
microbarn - Static variable in class cern.clhep.Units
 
microfarad - Static variable in class cern.clhep.Units
 
micrometer - Static variable in class cern.clhep.Units
 
microsecond - Static variable in class cern.clhep.Units
 
MicrosphereInterpolatingFunction - Class in org.apache.commons.math3.analysis.interpolation
Deprecated.
Code will be removed in 4.0. Use InterpolatingMicrosphere and MicrosphereProjectionInterpolator instead.
MicrosphereInterpolatingFunction(double[][], double[], int, int, UnitSphereRandomVectorGenerator) - Constructor for class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolatingFunction
Deprecated.
 
MicrosphereInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Deprecated.
Code will be removed in 4.0. Use InterpolatingMicrosphere and MicrosphereProjectionInterpolator instead.
MicrosphereInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
Deprecated.
Create a microsphere interpolator with default settings.
MicrosphereInterpolator(int, int) - Constructor for class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
Deprecated.
Create a microsphere interpolator.
MicrosphereProjectionInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Interpolator that implements the algorithm described in William Dudziak's MS thesis.
MicrosphereProjectionInterpolator(int, int, double, double, double, double, boolean, double) - Constructor for class org.apache.commons.math3.analysis.interpolation.MicrosphereProjectionInterpolator
Create a microsphere interpolator.
MicrosphereProjectionInterpolator(InterpolatingMicrosphere, double, boolean, double) - Constructor for class org.apache.commons.math3.analysis.interpolation.MicrosphereProjectionInterpolator
Create a microsphere interpolator.
MIDDLE - Static variable in class org.jfree.chart.axis.AxisLabelLocation
Axis label at the middle.
MIDDLE - Static variable in class org.jfree.chart.axis.CategoryAnchor
Middle of period.
MIDDLE - Static variable in class org.jfree.chart.axis.DateTickMarkPosition
Middle of period.
MIDDLE - Static variable in class org.jfree.data.time.DynamicTimeSeriesCollection
Useful constant for controlling the x-value returned for a time period.
MIDDLE - Static variable in class org.jfree.data.time.TimePeriodAnchor
Middle of period.
MiddlePinNeedle - Class in org.jfree.chart.needle
A needle that is drawn as a pin shape.
MiddlePinNeedle() - Constructor for class org.jfree.chart.needle.MiddlePinNeedle
 
midpoint(double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Compute the midpoint of two values.
MIDPOINT_MAX_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.MidPointIntegrator
Maximum number of iterations for midpoint.
MidpointFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements a second order Runge-Kutta integrator for Ordinary Differential Equations.
MidpointFieldIntegrator(Field<T>, T) - Constructor for class org.apache.commons.math3.ode.nonstiff.MidpointFieldIntegrator
Simple constructor.
MidPointIntegrator - Class in org.apache.commons.math3.analysis.integration
Implements the Midpoint Rule for integration of real univariate functions.
MidPointIntegrator(double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.MidPointIntegrator
Build a midpoint integrator with given accuracies and iterations counts.
MidPointIntegrator(int, int) - Constructor for class org.apache.commons.math3.analysis.integration.MidPointIntegrator
Build a midpoint integrator with given iteration counts.
MidPointIntegrator() - Constructor for class org.apache.commons.math3.analysis.integration.MidPointIntegrator
Construct a midpoint integrator with default settings.
MidpointIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements a second order Runge-Kutta integrator for Ordinary Differential Equations.
MidpointIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.MidpointIntegrator
Simple constructor.
MIf - Class in org.lsmp.djep.matrixJep.function
The if(condExpr,posExpr,negExpr) function.
MIf() - Constructor for class org.lsmp.djep.matrixJep.function.MIf
 
MightyStaticBin1D - Class in cern.hep.aida.bin
Static and the same as its superclass, except that it can do more: Additionally computes moments of arbitrary integer order, harmonic mean, geometric mean, etc.
MightyStaticBin1D() - Constructor for class cern.hep.aida.bin.MightyStaticBin1D
Constructs and returns an empty bin with limited functionality but good performance; equivalent to MightyStaticBin1D(false,false,4).
MightyStaticBin1D(boolean, boolean, int) - Constructor for class cern.hep.aida.bin.MightyStaticBin1D
Constructs and returns an empty bin with the given capabilities.
MillerUpdatingRegression - Class in org.apache.commons.math3.stat.regression
This class is a concrete implementation of the UpdatingMultipleLinearRegression interface.
MillerUpdatingRegression(int, boolean, double) - Constructor for class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
This is the augmented constructor for the MillerUpdatingRegression class.
MillerUpdatingRegression(int, boolean) - Constructor for class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Primary constructor for the MillerUpdatingRegression.
milliampere - Static variable in class cern.clhep.Units
 
millibarn - Static variable in class cern.clhep.Units
 
millifarad - Static variable in class cern.clhep.Units
 
milligram - Static variable in class cern.clhep.Units
 
millimeter - Static variable in class cern.clhep.Units
 
millimeter2 - Static variable in class cern.clhep.Units
 
millimeter3 - Static variable in class cern.clhep.Units
 
milliradian - Static variable in class cern.clhep.Units
 
millis() - Method in class cern.colt.Timer
Returns the elapsed time in milli seconds; does not stop the timer, if started.
millisecond - Static variable in class cern.clhep.Units
 
MILLISECOND - Static variable in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of version 1.0.13, use DateTickUnitType instead.
MILLISECOND - Static variable in class org.jfree.chart.axis.DateTickUnitType
Millisecond.
Millisecond - Class in org.jfree.data.time
Represents a millisecond.
Millisecond() - Constructor for class org.jfree.data.time.Millisecond
Constructs a millisecond based on the current system time.
Millisecond(int, Second) - Constructor for class org.jfree.data.time.Millisecond
Constructs a millisecond.
Millisecond(int, int, int, int, int, int, int) - Constructor for class org.jfree.data.time.Millisecond
Creates a new millisecond.
Millisecond(Date) - Constructor for class org.jfree.data.time.Millisecond
Constructs a new millisecond using the default time zone.
Millisecond(Date, TimeZone) - Constructor for class org.jfree.data.time.Millisecond
Deprecated.
As of 1.0.13, use the constructor that specifies the locale also.
Millisecond(Date, TimeZone, Locale) - Constructor for class org.jfree.data.time.Millisecond
Creates a millisecond.
min() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the minimum.
min - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.min().
min() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the minimum.
min() - Method in class cern.hep.aida.bin.StaticBin1D
Returns the minimum.
min - Static variable in class cern.jet.math.Functions
Function that returns Math.min(a,b).
min(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns Math.min(a,b).
min - Static variable in class cern.jet.math.IntFunctions
Function that returns Math.min(a,b).
min(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns Math.min(a,b).
min(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the smallest member of a data sequence.
min(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the minimum of an array.
min(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns the minimum of an array.
min(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the minimum of an array.
min(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns the minimum of an array.
min(double[][]) - Static method in class jhplot.math.DoubleArray
Finds the minimum value in each column of a matrix.
min(double...) - Static method in class jhplot.math.DoubleArray
Finds minimum value in either a list of numbers or a single array.
min(int[][]) - Static method in class jhplot.math.IntegerArray
 
min(int...) - Static method in class jhplot.math.IntegerArray
 
Min - Static variable in class jminhep.gui.SetEnv
 
min - Variable in class jplot3dp.ModelView.AxesDefinition
 
min(float, float) - Static method in class net.jafama.FastMath
 
min(double, double) - Static method in class net.jafama.FastMath
 
min(float, float) - Static method in class net.jafama.StrictFastMath
 
min(double, double) - Static method in class net.jafama.StrictFastMath
 
Min - Class in org.apache.commons.math3.analysis.function
Minimum function.
Min() - Constructor for class org.apache.commons.math3.analysis.function.Min
 
Min - Class in org.apache.commons.math3.stat.descriptive.rank
Returns the minimum of the available values.
Min() - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Min
Create a Min instance
Min(Min) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Min
Copy constructor, creates a new Min identical to the original
min(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the minimum of the entries in the input array, or Double.NaN if the array is empty.
min(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the minimum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
min(int, int) - Static method in class org.apache.commons.math3.util.FastMath
Compute the minimum of two values
min(long, long) - Static method in class org.apache.commons.math3.util.FastMath
Compute the minimum of two values
min(float, float) - Static method in class org.apache.commons.math3.util.FastMath
Compute the minimum of two values
min(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the minimum of two values
min(T, T) - Static method in class org.apache.commons.math3.util.MathUtils
Find the minimum of two field elements.
min() - Method in class org.freehep.math.minuit.MinosError
 
min() - Method in class org.jlab.groot.math.Axis
A getter for the minimum value of the axis
min() - Method in class org.jlab.groot.math.UserParameter
 
Min - Class in org.lsmp.djep.xjep.function
A min function Min(x^2,x,1,10) finds the min of x^2 with x running from 1 to 10.
Min() - Constructor for class org.lsmp.djep.xjep.function.Min
 
MIN_EXP - Static variable in class org.apache.commons.math3.dfp.Dfp
The minimum exponent before underflow is signaled.
MIN_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.F1D
 
MIN_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
MinArg - Class in org.lsmp.djep.xjep.function
 
MinArg() - Constructor for class org.lsmp.djep.xjep.function.MinArg
 
minBinHeight() - Method in class jhplot.H1D
Min value of all bins
minBinHeight() - Method in class jhplot.HProf1D
Min value of all bins
MinData - Static variable in class jminhep.clcontrol.Global
 
MiniJob - Class in hep.lcio.example
 
MiniJob() - Constructor for class hep.lcio.example.MiniJob
 
minimize() - Method in class org.freehep.math.minuit.MnApplication
 
minimize(int) - Method in class org.freehep.math.minuit.MnApplication
 
minimize(int, double) - Method in class org.freehep.math.minuit.MnApplication
Causes minimization of the FCN and returns the result in form of a FunctionMinimum.
minimizer() - Method in class org.freehep.math.minuit.MnSimplex
 
minimum - Variable in class graph.Axis
Minimum data value of the axis.
MINIMUM - Static variable in class graph.VectorSet
A constant value flag used to specify if the minimum magnitude of the vectors is going to be used as the scaling variable
MINIMUM_HEIGHT_TO_DRAW - Static variable in class org.jfree.chart.plot.Plot
The minimum height at which the plot should be drawn.
MINIMUM_PROBLEM_DIMENSION - Static variable in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
Minimum dimension of the problem: 2
MINIMUM_PROBLEM_DIMENSION - Static variable in class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
Deprecated.
Minimum dimension of the problem: 2
MINIMUM_WIDTH_TO_DRAW - Static variable in class org.jfree.chart.plot.Plot
The minimum width at which the plot should be drawn.
MINIMUM_YEAR - Static variable in class org.jfree.data.time.Year
The minimum year value.
minimumLayoutSize(Container) - Method in class jhplot.gui.VariableSizeGridLayout
 
minIndex(double[]) - Static method in class jhplot.math.ArrayMathUtils
returns the index of the smallest element from the given array
minIndex(double[][]) - Static method in class jhplot.math.DoubleArray
Finds the indices of the minimum values in each column of a matrix.
minIndex(double...) - Static method in class jhplot.math.DoubleArray
Finds the index of the minumum value in a list of values or an array.
minIndex(int[][]) - Static method in class jhplot.math.IntegerArray
 
minIndex(int...) - Static method in class jhplot.math.IntegerArray
 
minMaxBins() - Method in interface colt.hep.aida.IHistogram1D
Indexes of the in-range bins containing the smallest and largest binHeight(), respectively.
minMaxBins() - Method in interface colt.hep.aida.IHistogram2D
Indexes of the in-range bins containing the smallest and largest binHeight(), respectively.
minMaxBins() - Method in interface colt.hep.aida.IHistogram3D
Indexes of the in-range bins containing the smallest and largest binHeight(), respectively.
MinMaxCategoryRenderer - Class in org.jfree.chart.renderer.category
Renderer for drawing min max plot.
MinMaxCategoryRenderer() - Constructor for class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Default constructor.
MinMaxNumberList - Class in cern.colt.list
Resizable compressed list holding numbers; based on the fact that a value in a given interval need not take more than log(max-min+1) bits; implemented with a cern.colt.bitvector.BitVector.
MinMaxNumberList(long, long, int) - Constructor for class cern.colt.list.MinMaxNumberList
Constructs an empty list with the specified initial capacity and the specified range of values allowed to be hold in this list.
MINOR - Static variable in class org.jfree.chart.axis.TickType
Minor tick.
minor_tic_count - Variable in class graph.Axis
Number of minor tick marks between major tick marks
minor_tic_size - Variable in class graph.Axis
Size in pixels of the minor tick marks
minorAxis() - Method in class hep.physics.jet.EventShape
 
MINORVERSION - Static variable in interface hep.lcio.event.LCIO
 
minos(int) - Method in class org.freehep.math.minuit.MnMinos
 
minos(int, double) - Method in class org.freehep.math.minuit.MnMinos
 
minos(int, double, int) - Method in class org.freehep.math.minuit.MnMinos
Causes a MINOS error analysis to be performed on the parameter whose number is specified.
MinosError - Class in org.freehep.math.minuit
 
minSignedIntForBitSize(int) - Static method in class net.jafama.NumbersUtils
 
minSignedLongForBitSize(int) - Static method in class net.jafama.NumbersUtils
 
minus(DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A - s <=> A[i] = A[i] - s.
minus(DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A - B <=> A[i] = A[i] - B[i].
minus(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A - s <=> A[row,col] = A[row,col] - s.
minus(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A - B <=> A[row,col] = A[row,col] - B[row,col].
minus(Timer) - Method in class cern.colt.Timer
T = this - other; Constructs and returns a new timer which is the difference of the receiver and the other timer.
minus - Static variable in class cern.jet.math.Functions
Function that returns a - b.
minus(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a - b.
minus - Static variable in class cern.jet.math.IntFunctions
Function that returns a - b.
minus(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a - b.
minus(Matrix) - Method in class Jama.Matrix
C = A - B
Minus - Class in Jampack
Minus negates a matrix or computes the difference of two matrices.
Minus() - Constructor for class Jampack.Minus
 
Minus(Z) - Method in class Jampack.Z
Computes unary minus of a Z.
Minus(Z, Z) - Method in class Jampack.Z
Computes the difference of two Z's.
minus(Complex) - Method in class jhplot.math.Complex
Subtraction of Complex numbers (doesn't change this Complex number).
minus(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
C = A - B
minus(double[], double[]) - Static method in class jhplot.math.LinearAlgebra
Element-wise subtraction of two arrays.
minus(double[], double) - Static method in class jhplot.math.LinearAlgebra
Subtracts a scalar value from each element of an array
minus(double, double[]) - Static method in class jhplot.math.LinearAlgebra
Subtracts each element of an array from a scalar value.
minus(double[][], double[][]) - Static method in class jhplot.math.LinearAlgebra
Element-wise subtraction of two matrices.
minus(double[][], double) - Static method in class jhplot.math.LinearAlgebra
Subtract a scalar from each element of a matrix.
minus(double, double[][]) - Static method in class jhplot.math.LinearAlgebra
Subtract each element of a matrix from a scalar.
minus(ValueErr, double) - Method in class jhplot.math.ValueErr
Subtract an ValueErr number from this ValueErr number with correlation
minus(ValueErr, ValueErr, double) - Method in class jhplot.math.ValueErr
Subtract ValueErr number b from ValueErr number a with correlation
minus(ValueErr) - Method in class jhplot.math.ValueErr
Subtract a ValueErr number from this ValueErr number without correlation
minus(ValueErr, ValueErr) - Method in class jhplot.math.ValueErr
Subtract ValueErr number b from ValueErr number without correlation
minus(double) - Method in class jhplot.math.ValueErr
Subtract an error free double number from this ValueErr number.
minus(double, ValueErr) - Method in class jhplot.math.ValueErr
Subtract a ValueErr number b from an error free double
minus(double, double) - Method in class jhplot.math.ValueErr
Subtract an error free double number b from an error free double a and return sum as ValueErr
MINUS - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
Minus - Class in org.apache.commons.math3.analysis.function
Minus function.
Minus() - Constructor for class org.apache.commons.math3.analysis.function.Minus
 
MINUS - Static variable in interface org.nfunk.jep.ParserConstants
 
minus2PI(double) - Static method in class net.jafama.NumbersUtils
 
minus2PI_strict(double) - Static method in class net.jafama.NumbersUtils
Strict version.
MINUS_I - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Opposite of the first canonical vector (coordinates: -1, 0, 0).
MINUS_I - Static variable in class org.apache.commons.math3.geometry.spherical.twod.S2Point
-I (coordinates: \( \theta = \pi, \varphi = \pi/2 \)).
MINUS_J - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Opposite of the second canonical vector (coordinates: 0, -1, 0).
MINUS_J - Static variable in class org.apache.commons.math3.geometry.spherical.twod.S2Point
-J (coordinates: \( \theta = 3\pi/2, \varphi = \pi/2 \)).
MINUS_K - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Opposite of the third canonical vector (coordinates: 0, 0, -1).
MINUS_K - Static variable in class org.apache.commons.math3.geometry.spherical.twod.S2Point
-K (coordinates: \( \theta = any angle, \varphi = \pi \)).
MINUS_ONE - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "-1 / 1".
MINUS_ONE - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "-1 / 1".
minusBounded(int, int) - Static method in class net.jafama.NumbersUtils
 
minusBounded(long, long) - Static method in class net.jafama.NumbersUtils
 
minusDiv(double) - Static method in class cern.jet.math.PlusMult
a - b/constant.
minusEquals(Matrix) - Method in class Jama.Matrix
A = A - B
minusEquals(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
A = A - B
minusEquals(ValueErr, double) - Method in class jhplot.math.ValueErr
Subtract a ValueErr number to this ValueErr number and replace this with the sum with correlation
minusEquals(ValueErr) - Method in class jhplot.math.ValueErr
Subtract a ValueErr number from this ValueErr number and replace this with the sum with no correlation
minusEquals(double) - Method in class jhplot.math.ValueErr
Subtract a double number from this ValueErr number and replace this with the sum
minusExact(int, int) - Static method in class net.jafama.NumbersUtils
 
minusExact(long, long) - Static method in class net.jafama.NumbersUtils
 
minusMult(DoubleMatrix1D, DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A - B*s <=> A[i] = A[i] - B[i]*s.
minusMult(DoubleMatrix2D, DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A - B*s <=> A[row,col] = A[row,col] - B[row,col]*s.
minusMult(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a - b*constant.
minusMult(double) - Static method in class cern.jet.math.PlusMult
a - b*constant.
MINUSONE - Static variable in class org.nfunk.jep.type.DoubleNumberFactory
 
minusPI(double) - Static method in class net.jafama.NumbersUtils
 
minusPI_strict(double) - Static method in class net.jafama.NumbersUtils
Strict version.
minusPIO2(double) - Static method in class net.jafama.NumbersUtils
 
minusPIO2_strict(double) - Static method in class net.jafama.NumbersUtils
Strict version.
minusReal(double) - Method in class jhplot.math.Complex
Subtraction from real part
MINUTE - Static variable in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of version 1.0.13, use DateTickUnitType instead.
MINUTE - Static variable in class org.jfree.chart.axis.DateTickUnitType
Minute.
Minute - Class in org.jfree.data.time
Represents a minute.
Minute() - Constructor for class org.jfree.data.time.Minute
Constructs a new Minute, based on the system date/time.
Minute(int, Hour) - Constructor for class org.jfree.data.time.Minute
Constructs a new Minute.
Minute(Date) - Constructor for class org.jfree.data.time.Minute
Constructs a new instance, based on the supplied date/time and the default time zone.
Minute(Date, TimeZone) - Constructor for class org.jfree.data.time.Minute
Deprecated.
As of 1.0.13, use the constructor that specifies the locale also.
Minute(Date, TimeZone, Locale) - Constructor for class org.jfree.data.time.Minute
Constructs a new Minute, based on the supplied date/time and timezone.
Minute(int, int, int, int, int) - Constructor for class org.jfree.data.time.Minute
Creates a new minute.
MINUTE_SEGMENT_SIZE - Static variable in class org.jfree.chart.axis.SegmentedTimeline
Defines a one-minute segment size in ms.
minutes() - Method in class cern.colt.Timer
Returns the elapsed time in minutes; does not stop the timer, if started.
MINX_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.F2D
 
MINY_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.F2D
 
MismatchedEquations() - Constructor for exception org.apache.commons.math3.ode.JacobianMatrices.MismatchedEquations
Simple constructor.
MISSINGET_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent
 
MixtureMultivariateNormalDistribution - Class in org.apache.commons.math3.distribution
Multivariate normal mixture distribution.
MixtureMultivariateNormalDistribution(double[], double[][], double[][][]) - Constructor for class org.apache.commons.math3.distribution.MixtureMultivariateNormalDistribution
Creates a multivariate normal mixture distribution.
MixtureMultivariateNormalDistribution(List<Pair<Double, MultivariateNormalDistribution>>) - Constructor for class org.apache.commons.math3.distribution.MixtureMultivariateNormalDistribution
Creates a mixture model from a list of distributions and their associated weights.
MixtureMultivariateNormalDistribution(RandomGenerator, List<Pair<Double, MultivariateNormalDistribution>>) - Constructor for class org.apache.commons.math3.distribution.MixtureMultivariateNormalDistribution
Creates a mixture model from a list of distributions and their associated weights.
MixtureMultivariateRealDistribution<T extends MultivariateRealDistribution> - Class in org.apache.commons.math3.distribution
Class for representing mixture model distributions.
MixtureMultivariateRealDistribution(List<Pair<Double, T>>) - Constructor for class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Creates a mixture model from a list of distributions and their associated weights.
MixtureMultivariateRealDistribution(RandomGenerator, List<Pair<Double, T>>) - Constructor for class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Creates a mixture model from a list of distributions and their associated weights.
mkdir(String) - Method in class org.jlab.groot.data.Directory
create a directory in current directory.
MList - Class in org.lsmp.djep.matrixJep.function
A enhanced version of list, allows matrices and tensors.
MList() - Constructor for class org.lsmp.djep.matrixJep.function.MList
 
MLIST - Static variable in class org.lsmp.djep.rpe.RpEval
 
mm - Static variable in class cern.clhep.Units
 
mm2 - Static variable in class cern.clhep.Units
 
mm3 - Static variable in class cern.clhep.Units
 
MMap - Class in org.lsmp.djep.matrixJep.function
 
MMap() - Constructor for class org.lsmp.djep.matrixJep.function.MMap
 
MMultiply - Class in org.lsmp.djep.vectorJep.function
An extension of the Multiply to with vectors and matricies.
MMultiply() - Constructor for class org.lsmp.djep.vectorJep.function.MMultiply
 
MnApplication - Class in org.freehep.math.minuit
Base class for minimizers.
MnContours - Class in org.freehep.math.minuit
API class for Contours error analysis (2-dim errors).
MnContours(FCNBase, FunctionMinimum) - Constructor for class org.freehep.math.minuit.MnContours
construct from FCN + minimum
MnContours(FCNBase, FunctionMinimum, int) - Constructor for class org.freehep.math.minuit.MnContours
construct from FCN + minimum + strategy
MnContours(FCNBase, FunctionMinimum, MnStrategy) - Constructor for class org.freehep.math.minuit.MnContours
construct from FCN + minimum + strategy
MnEigen - Class in org.freehep.math.minuit
Calculates and the eigenvalues of the user covariance matrix MnUserCovariance.
MnEigen() - Constructor for class org.freehep.math.minuit.MnEigen
 
MnGlobalCorrelationCoeff - Class in org.freehep.math.minuit
 
MnHesse - Class in org.freehep.math.minuit
With MnHesse the user can instructs MINUIT to calculate, by finite differences, the Hessian or error matrix.
MnHesse() - Constructor for class org.freehep.math.minuit.MnHesse
default constructor with default strategy
MnHesse(int) - Constructor for class org.freehep.math.minuit.MnHesse
constructor with user-defined strategy level
MnHesse(MnStrategy) - Constructor for class org.freehep.math.minuit.MnHesse
conctructor with specific strategy
MnMachinePrecision - Class in org.freehep.math.minuit
Determines the relative floating point arithmetic precision.
MnMigrad - Class in org.freehep.math.minuit
MnMigrad provides minimization of the function by the method of MIGRAD, the most efficient and complete single method, recommended for general functions, and the functionality for parameters interaction.
MnMigrad(FCNBase, double[], double[]) - Constructor for class org.freehep.math.minuit.MnMigrad
construct from FCNBase + double[] for parameters and errors with default strategy
MnMigrad(FCNBase, double[], double[], int) - Constructor for class org.freehep.math.minuit.MnMigrad
construct from FCNBase + double[] for parameters and errors
MnMigrad(FCNBase, double[], MnUserCovariance) - Constructor for class org.freehep.math.minuit.MnMigrad
construct from FCNBase + double[] for parameters and MnUserCovariance with default strategy
MnMigrad(FCNBase, double[], MnUserCovariance, int) - Constructor for class org.freehep.math.minuit.MnMigrad
construct from FCNBase + double[] for parameters and MnUserCovariance
MnMigrad(FCNBase, MnUserParameters) - Constructor for class org.freehep.math.minuit.MnMigrad
construct from FCNBase + MnUserParameters with default strategy
MnMigrad(FCNBase, MnUserParameters, int) - Constructor for class org.freehep.math.minuit.MnMigrad
construct from FCNBase + MnUserParameters
MnMigrad(FCNBase, MnUserParameters, MnUserCovariance) - Constructor for class org.freehep.math.minuit.MnMigrad
construct from FCNBase + MnUserParameters + MnUserCovariance with default strategy
MnMigrad(FCNBase, MnUserParameters, MnUserCovariance, int) - Constructor for class org.freehep.math.minuit.MnMigrad
construct from FCNBase + MnUserParameters + MnUserCovariance
MnMigrad(FCNBase, MnUserParameterState, MnStrategy) - Constructor for class org.freehep.math.minuit.MnMigrad
construct from FCNBase + MnUserParameterState + MnStrategy
MnMinimize - Class in org.freehep.math.minuit
Causes minimization of the function by the method of MIGRAD, as does the MnMigrad class, but switches to the SIMPLEX method if MIGRAD fails to converge.
MnMinimize(FCNBase, double[], double[]) - Constructor for class org.freehep.math.minuit.MnMinimize
construct from FCNBase + double[] for parameters and errors with default strategy
MnMinimize(FCNBase, double[], double[], int) - Constructor for class org.freehep.math.minuit.MnMinimize
construct from FCNBase + double[] for parameters and errors
MnMinimize(FCNBase, double[], MnUserCovariance) - Constructor for class org.freehep.math.minuit.MnMinimize
construct from FCNBase + double[] for parameters and MnUserCovariance with default strategy
MnMinimize(FCNBase, double[], MnUserCovariance, int) - Constructor for class org.freehep.math.minuit.MnMinimize
construct from FCNBase + double[] for parameters and MnUserCovariance
MnMinimize(FCNBase, MnUserParameters) - Constructor for class org.freehep.math.minuit.MnMinimize
construct from FCNBase + MnUserParameters with default strategy
MnMinimize(FCNBase, MnUserParameters, int) - Constructor for class org.freehep.math.minuit.MnMinimize
construct from FCNBase + MnUserParameters
MnMinimize(FCNBase, MnUserParameters, MnUserCovariance) - Constructor for class org.freehep.math.minuit.MnMinimize
construct from FCNBase + MnUserParameters + MnUserCovariance with default strategy
MnMinimize(FCNBase, MnUserParameters, MnUserCovariance, int) - Constructor for class org.freehep.math.minuit.MnMinimize
construct from FCNBase + MnUserParameters + MnUserCovariance
MnMinimize(FCNBase, MnUserParameterState, MnStrategy) - Constructor for class org.freehep.math.minuit.MnMinimize
construct from FCNBase + MnUserParameterState + MnStrategy
MnMinos - Class in org.freehep.math.minuit
API class for Minos error analysis (asymmetric errors).
MnMinos(FCNBase, FunctionMinimum) - Constructor for class org.freehep.math.minuit.MnMinos
construct from FCN + minimum
MnMinos(FCNBase, FunctionMinimum, int) - Constructor for class org.freehep.math.minuit.MnMinos
construct from FCN + minimum + strategy
MnMinos(FCNBase, FunctionMinimum, MnStrategy) - Constructor for class org.freehep.math.minuit.MnMinos
construct from FCN + minimum + strategy
MnPlot - Class in org.freehep.math.minuit
MnPlot produces a text-screen graphical output of (x,y) points.
MnPlot() - Constructor for class org.freehep.math.minuit.MnPlot
 
MnPlot(int, int) - Constructor for class org.freehep.math.minuit.MnPlot
 
MnPrint - Class in org.freehep.math.minuit
Utilities for printing various minuit results.
MnScan - Class in org.freehep.math.minuit
MnScan scans the value of the user function by varying one parameter.
MnScan(FCNBase, double[], double[]) - Constructor for class org.freehep.math.minuit.MnScan
construct from FCNBase + double[] for parameters and errors with default strategy
MnScan(FCNBase, double[], double[], int) - Constructor for class org.freehep.math.minuit.MnScan
construct from FCNBase + double[] for parameters and errors
MnScan(FCNBase, double[], MnUserCovariance) - Constructor for class org.freehep.math.minuit.MnScan
construct from FCNBase + double[] for parameters and MnUserCovariance with default strategy
MnScan(FCNBase, double[], MnUserCovariance, int) - Constructor for class org.freehep.math.minuit.MnScan
construct from FCNBase + double[] for parameters and MnUserCovariance
MnScan(FCNBase, MnUserParameters) - Constructor for class org.freehep.math.minuit.MnScan
construct from FCNBase + MnUserParameters with default strategy
MnScan(FCNBase, MnUserParameters, int) - Constructor for class org.freehep.math.minuit.MnScan
construct from FCNBase + MnUserParameters
MnScan(FCNBase, MnUserParameters, MnUserCovariance) - Constructor for class org.freehep.math.minuit.MnScan
construct from FCNBase + MnUserParameters + MnUserCovariance with default strategy
MnScan(FCNBase, MnUserParameters, MnUserCovariance, int) - Constructor for class org.freehep.math.minuit.MnScan
construct from FCNBase + MnUserParameters + MnUserCovariance
MnScan(FCNBase, MnUserParameterState, MnStrategy) - Constructor for class org.freehep.math.minuit.MnScan
construct from FCNBase + MnUserParameterState + MnStrategy
MnSimplex - Class in org.freehep.math.minuit
SIMPLEX is a function minimization method using the simplex method of Nelder and Mead.
MnSimplex(FCNBase, double[], double[]) - Constructor for class org.freehep.math.minuit.MnSimplex
construct from FCNBase + double[] for parameters and errors with default strategy
MnSimplex(FCNBase, double[], double[], int) - Constructor for class org.freehep.math.minuit.MnSimplex
construct from FCNBase + double[] for parameters and errors
MnSimplex(FCNBase, double[], MnUserCovariance) - Constructor for class org.freehep.math.minuit.MnSimplex
construct from FCNBase + double[] for parameters and MnUserCovariance with default strategy
MnSimplex(FCNBase, double[], MnUserCovariance, int) - Constructor for class org.freehep.math.minuit.MnSimplex
construct from FCNBase + double[] for parameters and MnUserCovariance
MnSimplex(FCNBase, MnUserParameters) - Constructor for class org.freehep.math.minuit.MnSimplex
construct from FCNBase + MnUserParameters with default strategy
MnSimplex(FCNBase, MnUserParameters, int) - Constructor for class org.freehep.math.minuit.MnSimplex
construct from FCNBase + MnUserParameters
MnSimplex(FCNBase, MnUserParameters, MnUserCovariance) - Constructor for class org.freehep.math.minuit.MnSimplex
construct from FCNBase + MnUserParameters + MnUserCovariance with default strategy
MnSimplex(FCNBase, MnUserParameters, MnUserCovariance, int) - Constructor for class org.freehep.math.minuit.MnSimplex
construct from FCNBase + MnUserParameters + MnUserCovariance
MnSimplex(FCNBase, MnUserParameterState, MnStrategy) - Constructor for class org.freehep.math.minuit.MnSimplex
construct from FCNBase + MnUserParameterState + MnStrategy
MnStrategy - Class in org.freehep.math.minuit
API class for defining three levels of strategies: low (0), medium (1), high (>=2).
MnStrategy() - Constructor for class org.freehep.math.minuit.MnStrategy
Creates a MnStrategy object with the default strategy (medium)
MnStrategy(int) - Constructor for class org.freehep.math.minuit.MnStrategy
Creates a MnStrategy object with the user specified strategy.
MnUserCovariance - Class in org.freehep.math.minuit
MnUserCovariance is the external covariance matrix designed for the interaction of the user.
MnUserCovariance(int) - Constructor for class org.freehep.math.minuit.MnUserCovariance
 
MnUserParameters - Class in org.freehep.math.minuit
API class for the user interaction with the parameters.
MnUserParameters() - Constructor for class org.freehep.math.minuit.MnUserParameters
Creates a new instance of MnUserParameters
MnUserParameters(double[], double[]) - Constructor for class org.freehep.math.minuit.MnUserParameters
 
MnUserParameterState - Class in org.freehep.math.minuit
The class MnUserParameterState contains the MnUserParameters and the MnUserCovariance.
mod - Static variable in class cern.jet.math.Functions
Function that returns a % b.
mod(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a % b.
mod - Static variable in class cern.jet.math.IntFunctions
Function that returns a % b.
mod(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a % b.
mod() - Method in class jhplot.math.Complex
Modulus of this Complex number (the distance from the origin in polar coordinates).
mod(Object, Object) - Method in class org.lsmp.djep.groupJep.function.GMod
 
mod(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Integers
 
mod(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Zn
 
mod(Number, Number) - Method in interface org.lsmp.djep.groupJep.interfaces.HasModI
 
MOD - Static variable in class org.lsmp.djep.rpe.RpEval
 
MOD - Static variable in interface org.nfunk.jep.ParserConstants
 
Mode - Static variable in class jminhep.gui.SetEnv
 
mode(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the sample mode(s).
mode(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the sample mode(s).
model - Static variable in class jminhep.clcontrol.Global
 
model - Variable in class jminhep.clcontrol.TableResults
 
model - Variable in class jminhep.gui.TableSummary
 
model - Variable in class jplot3d.JSurface
 
model(MultivariateVectorFunction, MultivariateMatrixFunction) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the model function.
model(MultivariateJacobianFunction) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the model function.
model(MultivariateVectorFunction, MultivariateMatrixFunction) - Static method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresFactory
model2 - Static variable in class jminhep.clcontrol.Global
 
ModelFunction() - Constructor for class jplot3dp.ModelView.ModelFunction
 
ModelFunction - Class in org.apache.commons.math3.optim.nonlinear.vector
Deprecated.
All classes and interfaces in this package are deprecated. The optimizers that were provided here were moved to the org.apache.commons.math3.fitting.leastsquares package (cf. MATH-1008).
ModelFunction(MultivariateVectorFunction) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.ModelFunction
Deprecated.
 
ModelFunctionJacobian - Class in org.apache.commons.math3.optim.nonlinear.vector
Deprecated.
All classes and interfaces in this package are deprecated. The optimizers that were provided here were moved to the org.apache.commons.math3.fitting.leastsquares package (cf. MATH-1008).
ModelFunctionJacobian(MultivariateMatrixFunction) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.ModelFunctionJacobian
Deprecated.
 
ModelSpecificationException - Exception in org.apache.commons.math3.stat.regression
Exception thrown when a regression model is not correctly specified.
ModelSpecificationException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.stat.regression.ModelSpecificationException
 
modelView - Variable in class jplot3dp.MainComponent
 
ModelView - Class in jplot3dp
 
ModelView() - Constructor for class jplot3dp.ModelView
 
ModelView.AxesDefinition - Class in jplot3dp
 
ModelView.FunctionsList - Class in jplot3dp
 
ModelView.ModelFunction - Class in jplot3dp
 
modified() - Method in class org.jlab.groot.ui.ParameterPanel
 
modify(DataVector, double, double) - Method in class org.jlab.groot.data.H1F
 
modify(DataVector, DataVector, double, double, double, double) - Method in class org.jlab.groot.data.H2F
 
modifyEvent(LCEvent) - Method in class hep.lcio.example.RecJob
 
modifyEvent(LCEvent) - Method in interface hep.lcio.io.LCEventListener
Call back for updating an LCEvent.
modifyEvent(LCEvent) - Method in class hep.lcio.util.LCIOConcat
 
modifyEvent(LCEvent) - Method in class hep.lcio.util.LCIOSplitter
 
modifyRunHeader(LCRunHeader) - Method in class hep.lcio.example.RecJob
 
modifyRunHeader(LCRunHeader) - Method in interface hep.lcio.io.LCRunListener
Call back for modifying an existing LCRunHeader.
modifyRunHeader(LCRunHeader) - Method in class hep.lcio.util.LCIOConcat
 
modifyRunHeader(LCRunHeader) - Method in class hep.lcio.util.LCIOSplitter
 
MODULO - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
ModuloAxis - Class in org.jfree.chart.axis
An axis that displays numerical values within a fixed range using a modulo calculation.
ModuloAxis(String, Range) - Constructor for class org.jfree.chart.axis.ModuloAxis
Creates a new axis.
moduloSignedPowerOfTwo(int, int) - Static method in class net.jafama.NumbersUtils
This treatment being designed for optimization, the fact that spot is a signed power of two is not checked.
moduloSignedPowerOfTwo(long, long) - Static method in class net.jafama.NumbersUtils
This treatment being designed for optimization, the fact that spot is a signed power of two is not checked.
Modulus - Class in org.nfunk.jep.function
 
Modulus() - Constructor for class org.nfunk.jep.function.Modulus
 
mole - Static variable in class cern.clhep.Units
 
moment(int, double) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
moment(int, double) - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
moment(int, double, int, double[]) - Static method in class cern.jet.stat.Descriptive
Returns the moment of k-th order with constant c of a data sequence, which is Sum( (data[i]-c)k ) / data.size().
moment(DoubleArrayList, int, double) - Static method in class cern.jet.stat.Descriptive
Returns the moment of k-th order with constant c of a data sequence, which is Sum( (data[i]-c)k ) / data.size().
moment(int, double) - Method in class jhplot.P0D
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
moment(int, double) - Method in class jhplot.P0I
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
Moments - Class in jhplot.stat
Calculations of moments of a distribution.
Moments(int) - Constructor for class jhplot.stat.Moments
Initialization of the moments.
MomentsFac - Class in jhplot.stat
Calculations of factorial moments of a distribution.
MomentsFac(int) - Constructor for class jhplot.stat.MomentsFac
Initialization of the factorial moments.
MomentsNorm - Class in jhplot.stat
Calculations of normalized reduced moments of a distribution.
MomentsNorm(int) - Constructor for class jhplot.stat.MomentsNorm
Initialization of the normalised factorial moments.
MOMENTUMUNIT_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
MOMENTUMUNIT_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
MOMENTUMUNIT_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
MOMENTUMUNIT_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
Monomial - Class in org.lsmp.djep.sjep
Represents an imutable monomial a x^i * y^j * ...
MonotoneChain - Class in org.apache.commons.math3.geometry.euclidean.twod.hull
Implements Andrew's monotone chain method to generate the convex hull of a finite set of points in the two-dimensional euclidean space.
MonotoneChain() - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.hull.MonotoneChain
Create a new MonotoneChain instance.
MonotoneChain(boolean) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.hull.MonotoneChain
Create a new MonotoneChain instance.
MonotoneChain(boolean, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.hull.MonotoneChain
Create a new MonotoneChain instance.
monteCarloP(double, int, int, boolean, int) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Uses Monte Carlo simulation to approximate \(P(D_{n,m} > d)\) where \(D_{n,m}\) is the 2-sample Kolmogorov-Smirnov statistic.
monteCarloP(double, int, int, boolean, int) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
MONTH - Static variable in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of version 1.0.13, use DateTickUnitType instead.
MONTH - Static variable in class org.jfree.chart.axis.DateTickUnitType
Month.
Month - Class in org.jfree.data.time
Represents a single month.
Month() - Constructor for class org.jfree.data.time.Month
Constructs a new Month, based on the current system time.
Month(int, int) - Constructor for class org.jfree.data.time.Month
Constructs a new month instance.
Month(int, Year) - Constructor for class org.jfree.data.time.Month
Constructs a new month instance.
Month(Date) - Constructor for class org.jfree.data.time.Month
Constructs a new Month instance, based on a date/time and the default time zone.
Month(Date, TimeZone) - Constructor for class org.jfree.data.time.Month
Deprecated.
Since 1.0.12, use Month.Month(Date, TimeZone, Locale) instead.
Month(Date, TimeZone, Locale) - Constructor for class org.jfree.data.time.Month
Creates a new Month instance, based on the specified time, zone and locale.
MonthDateFormat - Class in org.jfree.chart.axis
A formatter that formats dates to show the initial letter(s) of the month name and, as an option, the year for the first or last month of each year.
MonthDateFormat() - Constructor for class org.jfree.chart.axis.MonthDateFormat
Creates a new instance for the default time zone.
MonthDateFormat(TimeZone) - Constructor for class org.jfree.chart.axis.MonthDateFormat
Creates a new instance for the specified time zone.
MonthDateFormat(Locale) - Constructor for class org.jfree.chart.axis.MonthDateFormat
Creates a new instance for the specified time zone.
MonthDateFormat(TimeZone, int) - Constructor for class org.jfree.chart.axis.MonthDateFormat
Creates a new instance for the specified time zone.
MonthDateFormat(Locale, int) - Constructor for class org.jfree.chart.axis.MonthDateFormat
Creates a new instance for the specified time zone.
MonthDateFormat(TimeZone, Locale, int, boolean, boolean) - Constructor for class org.jfree.chart.axis.MonthDateFormat
Creates a new formatter.
MonthDateFormat(TimeZone, Locale, int, boolean[], DateFormat) - Constructor for class org.jfree.chart.axis.MonthDateFormat
Creates a new formatter.
mostSignificantBit(int) - Static method in class cern.colt.bitvector.QuickBitVector
Returns the index of the most significant bit in state "true".
MOTHER1_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
MOTHER1_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
MOTHER1_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
MOTHER2_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
MOTHER2_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
MOTHER2_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
mouseClicked(MouseEvent) - Method in class jplot.GraphGeneral.GraphMouseListener
Picks up a mouse-click.
mouseClicked(MouseEvent) - Method in class jplot.SmallButton
 
mouseClicked(MouseEvent) - Method in class org.jfree.chart.ChartPanel
Receives notification of mouse clicks on the panel.
mouseClicked(MouseEvent) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
mouseClicked(MouseEvent) - Method in class org.jlab.groot.studio.StudioUI
 
mouseDown(Event, int, int) - Method in class graph.G2Dint
Handle the Mouse Down events
mouseDrag(Event, int, int) - Method in class graph.G2Dint
Handle the Mouse Drag events
mouseDragged(MouseEvent) - Method in class jplot.GraphGeneral.DragListener
This method does the actual painting during dragging.
mouseDragged(MouseEvent) - Method in class org.jfree.chart.ChartPanel
Handles a 'mouse dragged' event.
mouseDragged(MouseEvent) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
mouseEntered(MouseEvent) - Method in class jplot.GraphGeneral.GraphMouseListener
Picks up a mouse-Entered event.
mouseEntered(MouseEvent) - Method in class jplot.SmallButton
 
mouseEntered(MouseEvent) - Method in class org.jfree.chart.ChartPanel
Handles a 'mouse entered' event.
mouseEntered(MouseEvent) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
mouseEntered(MouseEvent) - Method in class org.jlab.groot.studio.StudioUI
 
mouseExited(MouseEvent) - Method in class jplot.GraphGeneral.GraphMouseListener
Picks up a mouse-Exited event.
mouseExited(MouseEvent) - Method in class jplot.SmallButton
 
mouseExited(MouseEvent) - Method in class org.jfree.chart.ChartPanel
Handles a 'mouse exited' event.
mouseExited(MouseEvent) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
mouseExited(MouseEvent) - Method in class org.jlab.groot.studio.StudioUI
 
MouseHandlerFX - Interface in org.jfree.chart.fx.interaction
The interface for a mouse handler, which is an object that listens for mouse events on a ChartCanvas and performs a function in response to those events (typical functions include tooltip display, drag zooming, mouse wheel zooming and panning).
mouseMove(Event, int, int) - Method in class graph.G2Dint
Handle the Mouse Mouve events
mouseMoved(MouseEvent) - Method in class jplot.GraphGeneral.DragListener
Does nothing.
mouseMoved(MouseEvent) - Method in class org.jfree.chart.ChartPanel
Implementation of the MouseMotionListener's method.
mouseMoved(MouseEvent) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
mousePressed(MouseEvent) - Method in class jplot.GraphGeneral.GraphMouseListener
Picks up a mouse-pressed event.
mousePressed(MouseEvent) - Method in class jplot.SmallButton
 
mousePressed(MouseEvent) - Method in class org.jfree.chart.ChartPanel
Handles a 'mouse pressed' event.
mousePressed(MouseEvent) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
mousePressed(MouseEvent) - Method in class org.jlab.groot.studio.StudioUI
 
mouseReleased(MouseEvent) - Method in class jplot.GraphGeneral.GraphMouseListener
Stops dragging if we are actually dragging, does nothing otherwise.
mouseReleased(MouseEvent) - Method in class jplot.SmallButton
 
mouseReleased(MouseEvent) - Method in class org.jfree.chart.ChartPanel
Handles a 'mouse released' event.
mouseReleased(MouseEvent) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
mouseReleased(MouseEvent) - Method in class org.jlab.groot.studio.StudioUI
 
mouseUp(Event, int, int) - Method in class graph.G2Dint
Handle the Mouse Up events
move(String, String) - Method in class jhplot.P1D
Transform a P1D data holder to some function with error propagation (for both levels)
moveCursor(double, RectangleEdge) - Method in class org.jfree.chart.axis.AxisState
Moves the cursor outwards by the specified number of units.
moveDirectory(File, File) - Static method in class org.apache.commons.io.FileUtils
Moves a directory.
moveDirectoryToDirectory(File, File, boolean) - Static method in class org.apache.commons.io.FileUtils
Moves a directory to another directory.
moveFile(File, File) - Static method in class org.apache.commons.io.FileUtils
Moves a file.
moveFileToDirectory(File, File, boolean) - Static method in class org.apache.commons.io.FileUtils
Moves a file to a directory.
moveIndexToEnd() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Moves the index of this segment to the end of the segment.
moveIndexToStart() - Method in class org.jfree.chart.axis.SegmentedTimeline.Segment
Moves the index of this segment to the beginning if the segment.
moveToDirectory(File, File, boolean) - Static method in class org.apache.commons.io.FileUtils
Moves a file or directory to the destination directory.
MovingAverage - Class in org.jfree.data.time
A utility class for calculating moving averages of time series data.
MovingAverage() - Constructor for class org.jfree.data.time.MovingAverage
 
MPI_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
MPI_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
MPI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
MPower - Class in org.lsmp.djep.matrixJep.function
An overloaded Power function compatible with MatrixJep.
MPower() - Constructor for class org.lsmp.djep.matrixJep.function.MPower
 
mrad - Static variable in class cern.clhep.Units
 
MRpCommandList - Class in org.lsmp.djep.mrpe
A list of commands evaluated in sequence by the evaluator.
MRpDiffExample - Class in org.lsmp.djepExamples
An example of using MRpEval with differentation.
MRpDiffExample() - Constructor for class org.lsmp.djepExamples.MRpDiffExample
 
MRpEval - Class in org.lsmp.djep.mrpe
A fast evaluation algorithm for equations using Vectors and Matrix over the Doubles.
MRpEval(MatrixJep) - Constructor for class org.lsmp.djep.mrpe.MRpEval
 
MRpExample - Class in org.lsmp.djepExamples
Examples using fast reverse polish calculator with vectors and matrices
MRpExample() - Constructor for class org.lsmp.djepExamples.MRpExample
 
MRpRes - Class in org.lsmp.djep.mrpe
The base type for values returned by evaluate.
MRpRes() - Constructor for class org.lsmp.djep.mrpe.MRpRes
 
MRpSpeed - Class in org.lsmp.djepExamples
Compares the speed of matrix operations using mrpe, vectorJep and matrixJep.
MRpSpeed() - Constructor for class org.lsmp.djepExamples.MRpSpeed
 
MRpSurfExample - Class in org.lsmp.djepExamples
 
MRpSurfExample() - Constructor for class org.lsmp.djepExamples.MRpSurfExample
 
MRpTest - Class in org.lsmp.djepJUnit
JUnit test for full Matrix Rp evaluator
MRpTest(String) - Constructor for class org.lsmp.djepJUnit.MRpTest
 
ms - Static variable in class cern.clhep.Units
 
MSubtract - Class in org.lsmp.djep.vectorJep.function
An extension of the Add command to allow it to add MVector's and Matrix's.
MSubtract() - Constructor for class org.lsmp.djep.vectorJep.function.MSubtract
 
MSum - Class in org.lsmp.djep.matrixJep.function
 
MSum(JEP) - Constructor for class org.lsmp.djep.matrixJep.function.MSum
 
mt() - Method in class hephysics.vec.HepLorentzVector
Transverse mass.
mt2() - Method in class hephysics.vec.HepLorentzVector
Transverse mass: e()*e() - pz()*pz()
Mtitle - Static variable in class jminhep.gui.SetEnv
 
mu0 - Static variable in class cern.clhep.PhysicalConstants
 
mul(Object, Object) - Method in class org.lsmp.djep.groupJep.function.GMultiply
 
mul(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.BigReals
 
mul(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
mul(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Integers
 
mul(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Quaternions
 
mul(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
mul(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Reals
 
mul(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Zn
 
mul(Number, Number) - Method in interface org.lsmp.djep.groupJep.interfaces.RingI
Returns the product of two numbers, a*b
mul(Polynomial) - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
mul(Rational) - Method in class org.lsmp.djep.groupJep.values.Rational
 
MUL - Static variable in class org.lsmp.djep.rpe.RpEval
 
mul(PNodeI) - Method in class org.lsmp.djep.sjep.AbstractPNode
 
mul(PNodeI) - Method in class org.lsmp.djep.sjep.Monomial
 
mul(PConstant) - Method in class org.lsmp.djep.sjep.MutiableMonomial
 
mul(PNodeI, PNodeI) - Method in class org.lsmp.djep.sjep.MutiableMonomial
 
mul(PNodeI) - Method in class org.lsmp.djep.sjep.PConstant
 
mul(PNodeI) - Method in interface org.lsmp.djep.sjep.PNodeI
Multiplies this by the argument.
mul(PNodeI) - Method in class org.lsmp.djep.sjep.Polynomial
 
mul(Object, Object) - Method in class org.lsmp.djep.vectorJep.function.ElementMultiply
Multiply arguments element by element.
mul(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.ElementMultiply
 
mul(Object, Object) - Method in class org.lsmp.djep.vectorJep.function.MMultiply
Multiply two objects.
mul(MatrixValueI, MatrixValueI) - Method in class org.lsmp.djep.vectorJep.function.MMultiply
Multiply two objects.
mul(Object, Object) - Method in class org.nfunk.jep.function.Multiply
 
mul(Number, Number) - Method in class org.nfunk.jep.function.Multiply
 
mul(Complex, Complex) - Method in class org.nfunk.jep.function.Multiply
 
mul(Complex, Number) - Method in class org.nfunk.jep.function.Multiply
 
mul(Vector, Number) - Method in class org.nfunk.jep.function.Multiply
 
mul(Vector, Complex) - Method in class org.nfunk.jep.function.Multiply
 
MUL - Static variable in interface org.nfunk.jep.ParserConstants
 
mul(double) - Method in class org.nfunk.jep.type.Complex
Multiply the complex number with a double value.
mul(Complex) - Method in class org.nfunk.jep.type.Complex
Multiply the complex number with another complex value.
mulAndCheck(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Multiply two integers, checking for overflow.
mulAndCheck(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Multiply two long integers, checking for overflow.
MullerSolver - Class in org.apache.commons.math3.analysis.solvers
This class implements the Muller's Method for root finding of real univariate functions.
MullerSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver
Construct a solver with default accuracy (1e-6).
MullerSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver
Construct a solver.
MullerSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver
Construct a solver.
MullerSolver2 - Class in org.apache.commons.math3.analysis.solvers
This class implements the Muller's Method for root finding of real univariate functions.
MullerSolver2() - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver2
Construct a solver with default accuracy (1e-6).
MullerSolver2(double) - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver2
Construct a solver.
MullerSolver2(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver2
Construct a solver.
mult(DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A * s <=> A[i] = A[i] * s.
mult(DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A * B <=> A[i] = A[i] * B[i].
mult(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A * s <=> A[row,col] = A[row,col] * s.
mult(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A * B <=> A[row,col] = A[row,col] * B[row,col].
mult(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Algebra
Inner product of two vectors; Sum(x[i] * y[i]).
mult(DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Algebra
Linear algebraic matrix-vector multiplication; z = A * y.
mult(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Linear algebraic matrix-matrix multiplication; C = A x B.
mult - Static variable in class cern.jet.math.Functions
Function that returns a * b.
mult(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a * b.
mult - Static variable in class cern.jet.math.IntFunctions
Function that returns a * b.
mult(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a * b.
Mult - Class in cern.jet.math
Only for performance tuning of compute intensive linear algebraic computations.
mult(double) - Static method in class cern.jet.math.Mult
a * constant.
mult(Matrix, Matrix) - Static method in class hep.physics.matrix.MatrixOp
 
mult(double, Matrix) - Static method in class hep.physics.matrix.MatrixOp
Multiply a matrix by a scaler constant.
mult(double, Hep3Vector) - Static method in class hep.physics.vec.VecOp
 
mult(Hep3Matrix, Hep3Vector) - Static method in class hep.physics.vec.VecOp
 
mult(Hep3Matrix, Hep3Matrix) - Static method in class hep.physics.vec.VecOp
 
mult(double, Hep3Matrix) - Static method in class hep.physics.vec.VecOp
 
mult(double, HepLorentzVector) - Static method in class hep.physics.vec.VecOp
 
mult(Matrix, Matrix) - Static method in class hephysics.matrix.MatrixOp
 
mult(Hep3Matrix, Hep3Matrix) - Static method in class hephysics.vec.Hep3Matrix
 
mult(double, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Multiply by a scaler
mult(double) - Method in class hephysics.vec.Hep3Vector
Multiply by a scaler
mult(Hep3Matrix, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
 
mult(double, HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Multiply by a scaler
mult(double, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
mult(Hep3Matrix, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
mult(Hep3Matrix, Hep3Matrix) - Static method in class hephysics.vec.VecOp
 
mult(double, Hep3Matrix) - Static method in class hephysics.vec.VecOp
 
mult(Vector3) - Method in class j4np.physics.TransMatrix
 
mult(double) - Method in class org.jlab.groot.data.DataVector
Multiplies the whole data with the provided number
MultidimensionalCounter - Class in org.apache.commons.math3.util
Converter between unidimensional storage structure and multidimensional conceptual structure.
MultidimensionalCounter(int...) - Constructor for class org.apache.commons.math3.util.MultidimensionalCounter
Create a counter.
MultidimensionalCounter.Iterator - Class in org.apache.commons.math3.util
Perform iteration over the multidimensional counter.
MultiDimensionMismatchException - Exception in org.apache.commons.math3.exception
Exception to be thrown when two sets of dimensions differ.
MultiDimensionMismatchException(Integer[], Integer[]) - Constructor for exception org.apache.commons.math3.exception.MultiDimensionMismatchException
Construct an exception from the mismatched dimensions.
MultiDimensionMismatchException(Localizable, Integer[], Integer[]) - Constructor for exception org.apache.commons.math3.exception.MultiDimensionMismatchException
Construct an exception from the mismatched dimensions.
MultiDirectionalSimplex - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
This class implements the multi-directional direct search method.
MultiDirectionalSimplex(int) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(int, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(int, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(int, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(double[], double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(double[][]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(double[][], double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
MultiDirectionalSimplex(int) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated.
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(int, double) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated.
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(int, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated.
Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(int, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated.
Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(double[]) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated.
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(double[], double, double) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated.
Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(double[][]) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated.
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(double[][], double, double) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated.
Build a multi-directional simplex with specified coefficients.
MultiGaus - Class in org.jlab.groot.demo
 
MultiGaus() - Constructor for class org.jlab.groot.demo.MultiGaus
 
MultiIndex - Class in org.jlab.groot.math
Handles the indexing of multidimensional arrays.
MultiIndex() - Constructor for class org.jlab.groot.math.MultiIndex
Initializes the arrays to size 0.
MultiIndex(int...) - Constructor for class org.jlab.groot.math.MultiIndex
Initializes the variables based on the number of arguments
MultiKMeansPlusPlusClusterer<T extends Clusterable> - Class in org.apache.commons.math3.ml.clustering
A wrapper around a k-means++ clustering algorithm which performs multiple trials and returns the best solution.
MultiKMeansPlusPlusClusterer(KMeansPlusPlusClusterer<T>, int) - Constructor for class org.apache.commons.math3.ml.clustering.MultiKMeansPlusPlusClusterer
Build a clusterer.
MultiKMeansPlusPlusClusterer(KMeansPlusPlusClusterer<T>, int, ClusterEvaluator<T>) - Constructor for class org.apache.commons.math3.ml.clustering.MultiKMeansPlusPlusClusterer
Build a clusterer.
MultipleLinearRegression - Interface in org.apache.commons.math3.stat.regression
The multiple linear regression can be represented in matrix-notation.
MultiplePiePlot - Class in org.jfree.chart.plot
A plot that displays multiple pie plots using data from a CategoryDataset.
MultiplePiePlot() - Constructor for class org.jfree.chart.plot.MultiplePiePlot
Creates a new plot with no data.
MultiplePiePlot(CategoryDataset) - Constructor for class org.jfree.chart.plot.MultiplePiePlot
Creates a new plot.
MultipleXYSeriesLabelGenerator - Class in org.jfree.chart.labels
A series label generator for plots that use data from an XYDataset.
MultipleXYSeriesLabelGenerator() - Constructor for class org.jfree.chart.labels.MultipleXYSeriesLabelGenerator
Creates an item label generator using default number formatters.
MultipleXYSeriesLabelGenerator(String) - Constructor for class org.jfree.chart.labels.MultipleXYSeriesLabelGenerator
Creates a new series label generator.
MULTIPLICATIVE_MODE - Static variable in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
MultiplicativeExpression() - Method in class org.nfunk.jep.Parser
 
multiplicator - Variable in class cern.jet.math.Mult
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.PlusMult
Public read/write access to avoid frequent object construction.
MULTIPLY - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
multiply(int) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute n × this.
multiply(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'×' operator.
multiply(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute this × a.
multiply(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Perform multiplication of two derivative structures.
multiply(SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute this × a.
multiply(double) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
'×' operator.
multiply(int) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute n × this.
Multiply - Class in org.apache.commons.math3.analysis.function
Multiply the two operands.
Multiply() - Constructor for class org.apache.commons.math3.analysis.function.Multiply
 
multiply(UnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Multiplies functions.
multiply(UnivariateDifferentiableFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Multiplies functions.
multiply(DifferentiableUnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
multiply(PolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Multiply the instance by a polynomial.
multiply(Complex) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is this * factor.
multiply(int) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is this * factor, with factor interpreted as a integer number.
multiply(double) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is this * factor, with factor interpreted as a real number.
multiply(Quaternion, Quaternion) - Static method in class org.apache.commons.math3.complex.Quaternion
Returns the Hamilton product of two quaternions.
multiply(Quaternion) - Method in class org.apache.commons.math3.complex.Quaternion
Returns the Hamilton product of the instance by a quaternion.
multiply(double) - Method in class org.apache.commons.math3.complex.Quaternion
Multiplies the instance by a scalar.
multiply(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Multiply this by x.
multiply(int) - Method in class org.apache.commons.math3.dfp.Dfp
Multiply this by a single digit x.
multiply(double) - Method in class org.apache.commons.math3.dfp.Dfp
'×' operator.
multiply(int) - Method in interface org.apache.commons.math3.FieldElement
Compute n × this.
multiply(T) - Method in interface org.apache.commons.math3.FieldElement
Compute this × a.
multiply(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
Multiplies the value of this fraction by the passed BigInteger, returning the result in reduced form.
multiply(int) - Method in class org.apache.commons.math3.fraction.BigFraction
Multiply the value of this fraction by the passed int, returning the result in reduced form.
multiply(long) - Method in class org.apache.commons.math3.fraction.BigFraction
Multiply the value of this fraction by the passed long, returning the result in reduced form.
multiply(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
Multiplies the value of this fraction by another, returning the result in reduced form.
multiply(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
Multiplies the value of this fraction by another, returning the result in reduced form.
multiply(int) - Method in class org.apache.commons.math3.fraction.Fraction
Multiply the fraction by an integer.
multiply(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Postmultiply this matrix by m.
multiply(RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of postmultiplying this by m.
multiply(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Postmultiplying this matrix by m.
multiply(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns the result of postmultiplying this by m.
multiply(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Postmultiply this matrix by m.
multiply(BlockFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the result of postmultiplying this by m.
multiply(BlockRealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the result of postmultiplying this by m.
multiply(DiagonalMatrix) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the result of postmultiplying this by m.
multiply(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Postmultiply this matrix by m.
multiply(RealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Returns the result of postmultiplying this by m.
multiply(OpenMapRealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Postmultiply this matrix by m.
multiply(RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of postmultiplying this by m.
multiply(double) - Method in interface org.apache.commons.math3.RealFieldElement
'×' operator.
multiply(BigReal) - Method in class org.apache.commons.math3.util.BigReal
Compute this × a.
multiply(int) - Method in class org.apache.commons.math3.util.BigReal
Compute n × this.
multiply(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute this × a.
multiply(int) - Method in class org.apache.commons.math3.util.Decimal64
Compute n × this.
multiply(double) - Method in class org.apache.commons.math3.util.Decimal64
'×' operator.
multiply(StatNumber) - Method in class org.jlab.groot.math.StatNumber
Multiplies the parameter and the current StatNumber
Multiply - Class in org.nfunk.jep.function
 
Multiply() - Constructor for class org.nfunk.jep.function.Multiply
 
MultiplyDiffRule - Class in org.lsmp.djep.djep.diffRules
Diffrentiates a product with respect to var.
MultiplyDiffRule(String) - Constructor for class org.lsmp.djep.djep.diffRules.MultiplyDiffRule
 
MultiplyDiffRule(String, Operator) - Constructor for class org.lsmp.djep.djep.diffRules.MultiplyDiffRule
 
multiplyEntry(int, int, T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, T) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, T) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Change an entry in the specified row and column.
multiplyExact(int, int) - Static method in class org.apache.commons.math3.util.FastMath
Multiply two numbers, detecting overflows.
multiplyExact(long, long) - Static method in class org.apache.commons.math3.util.FastMath
Multiply two numbers, detecting overflows.
multiplyInPlace(SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Multiply in place.
MultiStartMultivariateOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar
Multi-start optimizer.
MultiStartMultivariateOptimizer(MultivariateOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
Create a multi-start optimizer from a single-start optimizer.
MultiStartMultivariateVectorOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector
Deprecated.
MultiStartMultivariateVectorOptimizer(MultivariateVectorOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.MultiStartMultivariateVectorOptimizer
Deprecated.
Create a multi-start optimizer from a single-start optimizer.
MultiStartUnivariateOptimizer - Class in org.apache.commons.math3.optim.univariate
Special implementation of the UnivariateOptimizer interface adding multi-start features to an existing optimizer.
MultiStartUnivariateOptimizer(UnivariateOptimizer, int, RandomGenerator) - Constructor for class org.apache.commons.math3.optim.univariate.MultiStartUnivariateOptimizer
Create a multi-start optimizer from a single-start optimizer.
MultistepFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode
This class is the base class for multistep integrators for Ordinary Differential Equations.
MultistepIntegrator - Class in org.apache.commons.math3.ode
This class is the base class for multistep integrators for Ordinary Differential Equations.
MultistepIntegrator.NordsieckTransformer - Interface in org.apache.commons.math3.ode
Deprecated.
as of 3.6 this unused interface is deprecated
MultiValueCategoryDataset - Interface in org.jfree.data.statistics
A category dataset that defines multiple values for each item.
MultivariateDifferentiableFunction - Interface in org.apache.commons.math3.analysis.differentiation
Extension of MultivariateFunction representing a multivariate differentiable real function.
MultivariateDifferentiableMultiStartOptimizer - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
MultivariateDifferentiableMultiStartOptimizer(MultivariateDifferentiableOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.MultivariateDifferentiableMultiStartOptimizer
Deprecated.
Create a multi-start optimizer from a single-start optimizer.
MultivariateDifferentiableOptimizer - Interface in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
MultivariateDifferentiableVectorFunction - Interface in org.apache.commons.math3.analysis.differentiation
Extension of MultivariateVectorFunction representing a multivariate differentiable vectorial function.
MultivariateDifferentiableVectorMultiStartOptimizer - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
MultivariateDifferentiableVectorMultiStartOptimizer(MultivariateDifferentiableVectorOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.MultivariateDifferentiableVectorMultiStartOptimizer
Deprecated.
Create a multi-start optimizer from a single-start optimizer.
MultivariateDifferentiableVectorOptimizer - Interface in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
MultivariateFunction - Interface in org.apache.commons.math3.analysis
An interface representing a multivariate real function.
MultivariateFunctionMappingAdapter - Class in org.apache.commons.math3.optim.nonlinear.scalar
Adapter for mapping bounded MultivariateFunction to unbounded ones.
MultivariateFunctionMappingAdapter(MultivariateFunction, double[], double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
Simple constructor.
MultivariateFunctionMappingAdapter - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
MultivariateFunctionMappingAdapter(MultivariateFunction, double[], double[]) - Constructor for class org.apache.commons.math3.optimization.direct.MultivariateFunctionMappingAdapter
Deprecated.
Simple constructor.
MultivariateFunctionPenaltyAdapter - Class in org.apache.commons.math3.optim.nonlinear.scalar
Adapter extending bounded MultivariateFunction to an unbouded domain using a penalty function.
MultivariateFunctionPenaltyAdapter(MultivariateFunction, double[], double[], double, double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionPenaltyAdapter
Simple constructor.
MultivariateFunctionPenaltyAdapter - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
MultivariateFunctionPenaltyAdapter(MultivariateFunction, double[], double[], double, double[]) - Constructor for class org.apache.commons.math3.optimization.direct.MultivariateFunctionPenaltyAdapter
Deprecated.
Simple constructor.
MultivariateInterpolator - Interface in org.apache.commons.math3.analysis.interpolation
Interface representing a univariate real interpolating function.
MultivariateJacobianFunction - Interface in org.apache.commons.math3.fitting.leastsquares
A interface for functions that compute a vector of values and can compute their derivatives (Jacobian).
MultivariateMatrixFunction - Interface in org.apache.commons.math3.analysis
An interface representing a multivariate matrix function.
MultivariateMultiStartOptimizer - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
MultivariateMultiStartOptimizer(MultivariateOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.MultivariateMultiStartOptimizer
Deprecated.
Create a multi-start optimizer from a single-start optimizer.
MultivariateNormalDistribution - Class in org.apache.commons.math3.distribution
Implementation of the multivariate normal (Gaussian) distribution.
MultivariateNormalDistribution(double[], double[][]) - Constructor for class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Creates a multivariate normal distribution with the given mean vector and covariance matrix.
MultivariateNormalDistribution(RandomGenerator, double[], double[][]) - Constructor for class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Creates a multivariate normal distribution with the given mean vector and covariance matrix.
MultivariateNormalMixtureExpectationMaximization - Class in org.apache.commons.math3.distribution.fitting
Expectation-Maximization algorithm for fitting the parameters of multivariate normal mixture model distributions.
MultivariateNormalMixtureExpectationMaximization(double[][]) - Constructor for class org.apache.commons.math3.distribution.fitting.MultivariateNormalMixtureExpectationMaximization
Creates an object to fit a multivariate normal mixture model to data.
MultivariateOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar
Base class for a multivariate scalar function optimizer.
MultivariateOptimizer - Interface in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
MultivariateRealDistribution - Interface in org.apache.commons.math3.distribution
Base interface for multivariate distributions on the reals.
MultivariateSummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
Computes summary statistics for a stream of n-tuples added using the addValue method.
MultivariateSummaryStatistics(int, boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Construct a MultivariateSummaryStatistics instance
MultivariateVectorFunction - Interface in org.apache.commons.math3.analysis
An interface representing a multivariate vectorial function.
MultivariateVectorOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector
Deprecated.
multLimits(double) - Method in class org.jlab.groot.math.UserParameter
 
multOuter(DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Outer product of two vectors; Sets A[i,j] = x[i] * y[j].
MUMinus - Class in org.lsmp.djep.vectorJep.function
Unitary minus for matrices.
MUMinus() - Constructor for class org.lsmp.djep.vectorJep.function.MUMinus
 
MUONS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent
 
MutableMatrix - Interface in hep.physics.matrix
A matrix that can be changed
MutableMatrix - Interface in hephysics.matrix
A matrix that can be changed
mutate(Chromosome) - Method in class org.apache.commons.math3.genetics.BinaryMutation
Mutate the given chromosome.
mutate(Chromosome) - Method in interface org.apache.commons.math3.genetics.MutationPolicy
Mutate the given chromosome.
mutate(Chromosome) - Method in class org.apache.commons.math3.genetics.RandomKeyMutation
Mutate the given chromosome.
MutationPolicy - Interface in org.apache.commons.math3.genetics
Algorithm used to mutate a chromosome.
MutiableMonomial - Class in org.lsmp.djep.sjep
A mutable monomial representing a * x^i * y^j * ...
MutiableMonomial(PolynomialCreator, PConstant, PNodeI[], PNodeI[]) - Constructor for class org.lsmp.djep.sjep.MutiableMonomial
Note arrays parsed may be modified.
MutiablePolynomial - Class in org.lsmp.djep.sjep
A mutable polynomial representing a + b + c.
MutiablePolynomial(PolynomialCreator, PNodeI[]) - Constructor for class org.lsmp.djep.sjep.MutiablePolynomial
Note arrays parsed may be modified.
MutualInformation - Class in jhplot.stat
Implements common discrete Mutual Information functions.
MVector - Class in org.lsmp.djep.vectorJep.values
A Vector of elements.
MVector(int) - Constructor for class org.lsmp.djep.vectorJep.values.MVector
constructs a vector of a given size.
myAssertEquals(String, String, String) - Method in class org.lsmp.djepJUnit.GroupJepTest
 
myAssertEquals(String, String, String, String) - Method in class org.lsmp.djepJUnit.GroupJepTest
 
myAssertEquals(String, Object, Object) - Method in class org.lsmp.djepJUnit.JepTest
Assertion with message on command line.
myAssertEquals(String, String, String) - Method in class org.lsmp.djepJUnit.MRpTest
 
myAssertEquals(String, String, String) - Method in class org.lsmp.djepJUnit.RpTest
 
myAssertEquals(String, String, String) - Method in class org.lsmp.djepJUnit.SJepTest
 
myAssertNaN(String, Object) - Method in class org.lsmp.djepJUnit.JepTest
 
MyUtils - Class in jplot
Provides a number of handy functions which I use all the time, but which are too short to bring into a package or class.
MyUtils() - Constructor for class jplot.MyUtils
 

N

n - Variable in class Jampack.Zchol
The order of A and R
n - Variable in class Jampack.Zdiagmat
The order of the matrix (public)
N_AXES - Static variable in class jplot.GraphSettings
Total number of axes currently known by JPlot.
NACCEPTED_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
NACCEPTED_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat
 
NACCEPTED_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat
 
NACCEPTED_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat
 
NakagamiDistribution - Class in org.apache.commons.math3.distribution
This class implements the Nakagami distribution.
NakagamiDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.NakagamiDistribution
Build a new instance.
NakagamiDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.NakagamiDistribution
Build a new instance.
NakagamiDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.NakagamiDistribution
Build a new instance.
name() - Method in interface cern.hep.aida.bin.BinFunction1D
Returns the name of this function.
name() - Method in class j4np.physics.PDGParticle
 
name - Variable in class jplot3dp.ModelView.ModelFunction
 
name(int) - Method in class org.freehep.math.minuit.MnApplication
convert external number into name of parameter
name(int) - Method in class org.freehep.math.minuit.MnUserParameterState
convert external number into name of parameter
name() - Method in class org.jlab.groot.math.UserParameter
 
name() - Method in class root.TLeafFolderColumn
 
NAME_COMPARATOR - Static variable in class org.apache.commons.io.comparator.NameFileComparator
Case-sensitive name comparator instance (see IOCase.SENSITIVE)
NAME_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
NAME_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
NAME_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.F1D
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.F2D
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.FND
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.FPR
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P0D
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P0I
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P1D
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PND
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PNI
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PXY
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PXYZ
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PEventFile.HEvent.Entry
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PEventFile.HEvent.Group
 
NAME_FIELD_NUMBER - Static variable in class promc.io.PEventFile.HEvent
 
NAME_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
NAME_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
NAME_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
NAME_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
NAME_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
NAME_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
NAME_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
NAME_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
NAME_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
NAME_INSENSITIVE_COMPARATOR - Static variable in class org.apache.commons.io.comparator.NameFileComparator
Case-insensitive name comparator instance (see IOCase.INSENSITIVE)
NAME_INSENSITIVE_REVERSE - Static variable in class org.apache.commons.io.comparator.NameFileComparator
Reverse case-insensitive name comparator instance (see IOCase.INSENSITIVE)
NAME_REVERSE - Static variable in class org.apache.commons.io.comparator.NameFileComparator
Reverse case-sensitive name comparator instance (see IOCase.SENSITIVE)
NAME_SYSTEM_COMPARATOR - Static variable in class org.apache.commons.io.comparator.NameFileComparator
System sensitive name comparator instance (see IOCase.SYSTEM)
NAME_SYSTEM_REVERSE - Static variable in class org.apache.commons.io.comparator.NameFileComparator
Reverse system sensitive name comparator instance (see IOCase.SYSTEM)
NameFileComparator - Class in org.apache.commons.io.comparator
Compare the names of two files for order (see File.getName()).
NameFileComparator() - Constructor for class org.apache.commons.io.comparator.NameFileComparator
Construct a case sensitive file name comparator instance.
NameFileComparator(IOCase) - Constructor for class org.apache.commons.io.comparator.NameFileComparator
Construct a file name comparator instance with the specified case-sensitivity.
nameFileFilter(String) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that returns true if the file name matches the specified text.
nameFileFilter(String, IOCase) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that returns true if the file name matches the specified text.
NameFileFilter - Class in org.apache.commons.io.filefilter
Filters file names for a certain name.
NameFileFilter(String) - Constructor for class org.apache.commons.io.filefilter.NameFileFilter
Constructs a new case-sensitive name file filter for a single name.
NameFileFilter(String, IOCase) - Constructor for class org.apache.commons.io.filefilter.NameFileFilter
Construct a new name file filter specifying case-sensitivity.
NameFileFilter(String...) - Constructor for class org.apache.commons.io.filefilter.NameFileFilter
Constructs a new case-sensitive name file filter for an array of names.
NameFileFilter(String[], IOCase) - Constructor for class org.apache.commons.io.filefilter.NameFileFilter
Constructs a new name file filter for an array of names specifying case-sensitivity.
NameFileFilter(List<String>) - Constructor for class org.apache.commons.io.filefilter.NameFileFilter
Constructs a new case-sensitive name file filter for a list of names.
NameFileFilter(List<String>, IOCase) - Constructor for class org.apache.commons.io.filefilter.NameFileFilter
Constructs a new name file filter for a list of names specifying case-sensitivity.
NAMELENGTHUNIT_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
NAMELENGTHUNIT_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
NAMELENGTHUNIT_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
NAMELENGTHUNIT_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
NAMEMOMENTUMUNIT_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
NAMEMOMENTUMUNIT_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
NAMEMOMENTUMUNIT_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
NAMEMOMENTUMUNIT_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
NaN - Static variable in class org.apache.commons.math3.complex.Complex
A complex number representing "NaN + NaNi"
NaN - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
A vector with all coordinates set to NaN.
NaN - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
A vector with all coordinates set to NaN.
NaN - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
A vector with all coordinates set to NaN.
NaN - Static variable in class org.apache.commons.math3.geometry.spherical.oned.S1Point
A vector with all coordinates set to NaN.
NaN - Static variable in class org.apache.commons.math3.geometry.spherical.twod.S2Point
A vector with all coordinates set to NaN.
NAN - Static variable in class org.apache.commons.math3.util.Decimal64
The constant value of Double.NaN as a Decimal64.
nanoampere - Static variable in class cern.clhep.Units
 
nanobarn - Static variable in class cern.clhep.Units
 
nanofarad - Static variable in class cern.clhep.Units
 
nanometer - Static variable in class cern.clhep.Units
 
nanosecond - Static variable in class cern.clhep.Units
 
NaNStrategy - Enum in org.apache.commons.math3.stat.ranking
Strategies for handling NaN values in rank transformations.
NARY - Static variable in class org.lsmp.djep.xjep.XOperator
Trinary ops such as ?: and or higher like [x,y,z,w]
NaryOperatorI - Interface in org.lsmp.djep.vectorJep.function
A matrix enabled operator with N arguments.
natural(int) - Static method in class org.apache.commons.math3.util.MathArrays
Returns an array representing the natural number n.
NaturalLogarithm - Class in org.nfunk.jep.function
Natural logarithm.
NaturalLogarithm() - Constructor for class org.nfunk.jep.function.NaturalLogarithm
 
NaturalLogarithmTest - Class in org.nfunk.jeptesting
 
NaturalLogarithmTest(String) - Constructor for class org.nfunk.jeptesting.NaturalLogarithmTest
 
NaturalRanking - Class in org.apache.commons.math3.stat.ranking
Ranking based on the natural ordering on doubles.
NaturalRanking() - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with default strategies for handling ties and NaNs.
NaturalRanking(TiesStrategy) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with the given TiesStrategy.
NaturalRanking(NaNStrategy) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with the given NaNStrategy.
NaturalRanking(NaNStrategy, TiesStrategy) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with the given NaNStrategy and TiesStrategy.
NaturalRanking(RandomGenerator) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with TiesStrategy.RANDOM and the given RandomGenerator as the source of random data.
NaturalRanking(NaNStrategy, RandomGenerator) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with the given NaNStrategy, TiesStrategy.RANDOM and the given source of random data.
nc - Variable in class Jampack.Zmat
The number of columns
ncl - Variable in class Jampack.Zludpp
The number of columns in L
Ncluster - Static variable in class jminhep.clcontrol.Global
 
ncol - Variable in class Jampack.Zhqrd
The number of columns in A
ncol() - Method in class org.freehep.math.minuit.MnUserCovariance
 
nd() - Static method in class Jampack.Rand
Generates a normal random double.
ndary(int) - Static method in class Jampack.Rand
Generates a one-dimensional array of normal random doubles.
ndary(int, int) - Static method in class Jampack.Rand
Generates a two-dimensional array of normal random doubles.
Ndata - Variable in class jminhep.gui.Plotter
 
NE - Static variable in class org.lsmp.djep.rpe.RpEval
 
NE - Static variable in class org.nfunk.jep.function.Comparative
 
ne(Object, Object) - Method in class org.nfunk.jep.function.Comparative
 
NE - Static variable in interface org.nfunk.jep.ParserConstants
 
NeedRemove(String[]) - Static method in class jplot3d.NumUtil
Determin: should 0 be remove?
neg - Static variable in class cern.jet.math.Functions
Function that returns -a.
neg - Static variable in class cern.jet.math.IntFunctions
Function that returns -a.
neg(Hep3Vector) - Static method in class hep.physics.vec.VecOp
 
neg(HepLorentzVector) - Static method in class hep.physics.vec.VecOp
 
neg(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Invert
neg(HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Inverse
neg(Hep3Vector) - Method in class hephysics.vec.HepLorentzVector
 
neg(Hep3Vector) - Static method in class hephysics.vec.VecOp
 
neg() - Method in class org.nfunk.jep.type.Complex
Returns the negative value of this complex number.
negate(DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = -A <=> A[i] = -A[i] for all cells.
negate(DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = -A <=> A[row,col] = -A[row,col].
negate() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Returns the additive inverse of this element.
negate() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Returns the additive inverse of this element.
negate() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Negate the instance.
negate() - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (-this).
negate() - Method in class org.apache.commons.math3.dfp.Dfp
Returns a number that is this number with the sign bit reversed.
negate() - Method in interface org.apache.commons.math3.FieldElement
Returns the additive inverse of this element.
negate() - Method in class org.apache.commons.math3.fraction.BigFraction
Return the additive inverse of this fraction, returning the result in reduced form.
negate() - Method in class org.apache.commons.math3.fraction.Fraction
Return the additive inverse of this fraction.
negate() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the opposite of the instance.
negate() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the opposite of the instance.
negate() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the opposite of the instance.
negate() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the opposite of the instance.
negate() - Method in class org.apache.commons.math3.geometry.spherical.twod.S2Point
Get the opposite of the instance.
negate() - Method in interface org.apache.commons.math3.geometry.Vector
Get the opposite of the instance.
negate() - Method in class org.apache.commons.math3.util.BigReal
Returns the additive inverse of this element.
negate() - Method in class org.apache.commons.math3.util.Decimal64
Returns the additive inverse of this element.
negate() - Method in class org.lsmp.djep.groupJep.values.Rational
 
negate() - Method in class org.lsmp.djep.sjep.AbstractPNode
 
negate() - Method in class org.lsmp.djep.sjep.Monomial
 
negate() - Method in class org.lsmp.djep.sjep.PConstant
 
negate() - Method in interface org.lsmp.djep.sjep.PNodeI
negates node i.e.
negate() - Method in class org.lsmp.djep.sjep.Polynomial
 
negative() - Method in class j4np.physics.Vector3
 
NEGATIVE - Static variable in class org.jfree.data.RangeType
Negative range.
NEGATIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
A vector with all coordinates set to negative infinity.
NEGATIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
A vector with all coordinates set to negative infinity.
NEGATIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
A vector with all coordinates set to negative infinity.
NEGATIVE_INFINITY - Static variable in class org.apache.commons.math3.util.Decimal64
The constant value of Double.NEGATIVE_INFINITY as a Decimal64.
NegativeBinomial - Class in cern.jet.random
Negative Binomial distribution; See the math definition.
NegativeBinomial(int, double, RandomEngine) - Constructor for class cern.jet.random.NegativeBinomial
Constructs a Negative Binomial distribution.
negativeBinomial(int, int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the terms 0 through k of the Negative Binomial Distribution.
NegativeBinomial - Class in jhplot.fit
Negative binomial distribution.
NegativeBinomial() - Constructor for class jhplot.fit.NegativeBinomial
 
NegativeBinomial(String) - Constructor for class jhplot.fit.NegativeBinomial
 
NegativeBinomial(String[], String[]) - Constructor for class jhplot.fit.NegativeBinomial
 
NegativeBinomial - Class in jhplot.math.num.pdf
The Negative Binomial distribution.
NegativeBinomial() - Constructor for class jhplot.math.num.pdf.NegativeBinomial
Default constructor.
NegativeBinomial(int, double) - Constructor for class jhplot.math.num.pdf.NegativeBinomial
Create a distribution with the given number of successes and probability of success.
negativeBinomialComplemented(int, int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the terms k+1 to infinity of the Negative Binomial distribution.
NegativeBinomialRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Negative Binomial distribution.
NegativeBinomialRandomVariable() - Constructor for class jhplot.math.num.random.NegativeBinomialRandomVariable
Default constructor.
NegativeBinomialRandomVariable(int, double) - Constructor for class jhplot.math.num.random.NegativeBinomialRandomVariable
Create a random variable with the given number of successes and probability of success.
NegativeBinomialRandomVariable(int, double, RNG) - Constructor for class jhplot.math.num.random.NegativeBinomialRandomVariable
Create a random variable with the given parameters.
negativeOrNull() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is less than or equal to 0.
negHalfWidth(int, int) - Static method in class net.jafama.NumbersUtils
Useful because a positive int value could not represent half the width of full int range width, which is mathematically Integer.MAX_VALUE+1.
negHalfWidth(long, long) - Static method in class net.jafama.NumbersUtils
Useful because a positive long value could not represent half the width of full long range width, which is mathematically Long.MAX_VALUE+1.
NeighbourhoodSizeFunction - Interface in org.apache.commons.math3.ml.neuralnet.sofm
Provides the network neighbourhood's size as a function of the number of calls already performed during the learning task.
NeighbourhoodSizeFunctionFactory - Class in org.apache.commons.math3.ml.neuralnet.sofm
Factory for creating instances of NeighbourhoodSizeFunction.
NelderMeadSimplex - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
This class implements the Nelder-Mead simplex algorithm.
NelderMeadSimplex(int) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(int, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(int, double, double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(int, double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(double[], double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(double[][]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(double[][], double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
NelderMeadSimplex(int) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated.
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(int, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated.
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(int, double, double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated.
Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(int, double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated.
Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(double[]) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated.
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(double[], double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated.
Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(double[][]) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated.
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(double[][], double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated.
Build a Nelder-Mead simplex with specified coefficients.
NENTRIES_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
NENTRIES_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
net.jafama - package net.jafama
 
net.java.dev.colorchooser - package net.java.dev.colorchooser
 
Network - Class in org.apache.commons.math3.ml.neuralnet
Neural network, composed of Neuron instances and the links between them.
Network(long, int) - Constructor for class org.apache.commons.math3.ml.neuralnet.Network
 
Network.NeuronIdentifierComparator - Class in org.apache.commons.math3.ml.neuralnet
Comparator that prescribes an order of the neurons according to the increasing order of their identifier.
Neuron - Class in org.apache.commons.math3.ml.neuralnet
Describes a neuron element of a neural network.
NeuronIdentifierComparator() - Constructor for class org.apache.commons.math3.ml.neuralnet.Network.NeuronIdentifierComparator
 
NeuronSquareMesh2D - Class in org.apache.commons.math3.ml.neuralnet.twod
Neural network with the topology of a two-dimensional surface.
NeuronSquareMesh2D(int, boolean, int, boolean, SquareNeighbourhood, FeatureInitializer[]) - Constructor for class org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D
Creates a two-dimensional network composed of square cells: Each neuron not located on the border of the mesh has four neurons linked to it.
NeuronSquareMesh2D.HorizontalDirection - Enum in org.apache.commons.math3.ml.neuralnet.twod
Horizontal (along row) direction.
NeuronSquareMesh2D.VerticalDirection - Enum in org.apache.commons.math3.ml.neuralnet.twod
Vertical (along column) direction.
NeuronString - Class in org.apache.commons.math3.ml.neuralnet.oned
Neural network with the topology of a one-dimensional line.
NeuronString(int, boolean, FeatureInitializer[]) - Constructor for class org.apache.commons.math3.ml.neuralnet.oned.NeuronString
Creates a one-dimensional network: Each neuron not located on the border of the mesh has two neurons linked to it.
neutron_mass_c2 - Static variable in class cern.clhep.PhysicalConstants
 
NEVENTS_FAILED_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
NEVENTS_FAILED_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat
 
NEVENTS_FAILED_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat
 
NEVENTS_FAILED_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat
 
NEVENTS_REQUESTED_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
NEVENTS_REQUESTED_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat
 
NEVENTS_REQUESTED_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat
 
NEVENTS_REQUESTED_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat
 
NevilleInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Implements the Neville's Algorithm for interpolation of real univariate functions.
NevilleInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.NevilleInterpolator
 
NEW_DATASET - Static variable in class org.jfree.chart.event.ChartChangeEventType
NEW_DATASET.
newBuilder() - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
newBuilder(ProMC.ProMCEvent.Event) - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
newBuilder() - Static method in class proeic.io.ProMC.ProMCEvent
 
newBuilder(ProMC.ProMCEvent) - Static method in class proeic.io.ProMC.ProMCEvent
 
newBuilder() - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
newBuilder(ProMC.ProMCEvent.Particles) - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
newBuilder() - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
newBuilder(ProMCDescriptionFile.ProMCDescription) - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
newBuilder() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilder(ProMCHeaderFile.ProMCHeader.MetaFloat) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilder() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilder(ProMCHeaderFile.ProMCHeader.MetaInt) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilder() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
newBuilder(ProMCHeaderFile.ProMCHeader) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
newBuilder() - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilder(ProMCHeaderFile.ProMCHeader.ParticleData) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilder() - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
newBuilder(ProMCStatFile.ProMCStat.MetaFloat) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
newBuilder() - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
newBuilder(ProMCStatFile.ProMCStat.MetaInt) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
newBuilder() - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
newBuilder(ProMCStatFile.ProMCStat) - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
newBuilder() - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
newBuilder(ProMCStatFile.ProMCStat.ProcessData) - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
newBuilder() - Static method in class promc.io.PBufFile.Record.F1D
 
newBuilder(PBufFile.Record.F1D) - Static method in class promc.io.PBufFile.Record.F1D
 
newBuilder() - Static method in class promc.io.PBufFile.Record.F2D
 
newBuilder(PBufFile.Record.F2D) - Static method in class promc.io.PBufFile.Record.F2D
 
newBuilder() - Static method in class promc.io.PBufFile.Record.FND
 
newBuilder(PBufFile.Record.FND) - Static method in class promc.io.PBufFile.Record.FND
 
newBuilder() - Static method in class promc.io.PBufFile.Record.FPR
 
newBuilder(PBufFile.Record.FPR) - Static method in class promc.io.PBufFile.Record.FPR
 
newBuilder() - Static method in class promc.io.PBufFile.Record.H1D
 
newBuilder(PBufFile.Record.H1D) - Static method in class promc.io.PBufFile.Record.H1D
 
newBuilder() - Static method in class promc.io.PBufFile.Record.H2D
 
newBuilder(PBufFile.Record.H2D) - Static method in class promc.io.PBufFile.Record.H2D
 
newBuilder() - Static method in class promc.io.PBufFile.Record
 
newBuilder(PBufFile.Record) - Static method in class promc.io.PBufFile.Record
 
newBuilder() - Static method in class promc.io.PBufFile.Record.P0D
 
newBuilder(PBufFile.Record.P0D) - Static method in class promc.io.PBufFile.Record.P0D
 
newBuilder() - Static method in class promc.io.PBufFile.Record.P0I
 
newBuilder(PBufFile.Record.P0I) - Static method in class promc.io.PBufFile.Record.P0I
 
newBuilder() - Static method in class promc.io.PBufFile.Record.P1D
 
newBuilder(PBufFile.Record.P1D) - Static method in class promc.io.PBufFile.Record.P1D
 
newBuilder() - Static method in class promc.io.PBufFile.Record.PND
 
newBuilder(PBufFile.Record.PND) - Static method in class promc.io.PBufFile.Record.PND
 
newBuilder() - Static method in class promc.io.PBufFile.Record.PNI
 
newBuilder(PBufFile.Record.PNI) - Static method in class promc.io.PBufFile.Record.PNI
 
newBuilder() - Static method in class promc.io.PBufFile.Record.PXY
 
newBuilder(PBufFile.Record.PXY) - Static method in class promc.io.PBufFile.Record.PXY
 
newBuilder() - Static method in class promc.io.PBufFile.Record.PXYZ
 
newBuilder(PBufFile.Record.PXYZ) - Static method in class promc.io.PBufFile.Record.PXYZ
 
newBuilder() - Static method in class promc.io.PEventFile.HEvent.Entry
 
newBuilder(PEventFile.HEvent.Entry) - Static method in class promc.io.PEventFile.HEvent.Entry
 
newBuilder() - Static method in class promc.io.PEventFile.HEvent.Group
 
newBuilder(PEventFile.HEvent.Group) - Static method in class promc.io.PEventFile.HEvent.Group
 
newBuilder() - Static method in class promc.io.PEventFile.HEvent
 
newBuilder(PEventFile.HEvent) - Static method in class promc.io.PEventFile.HEvent
 
newBuilder() - Static method in class promc.io.ProMC.ProMCEvent.Event
 
newBuilder(ProMC.ProMCEvent.Event) - Static method in class promc.io.ProMC.ProMCEvent.Event
 
newBuilder() - Static method in class promc.io.ProMC.ProMCEvent
 
newBuilder(ProMC.ProMCEvent) - Static method in class promc.io.ProMC.ProMCEvent
 
newBuilder() - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
newBuilder(ProMC.ProMCEvent.Particles) - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
newBuilder() - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
newBuilder(ProMCDescriptionFile.ProMCDescription) - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
newBuilder() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilder(ProMCHeaderFile.ProMCHeader.MetaFloat) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilder() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilder(ProMCHeaderFile.ProMCHeader.MetaInt) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilder() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
newBuilder(ProMCHeaderFile.ProMCHeader) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
newBuilder() - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilder(ProMCHeaderFile.ProMCHeader.ParticleData) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilder() - Static method in class promc.io.ProMCStatFile.ProMCStat
 
newBuilder(ProMCStatFile.ProMCStat) - Static method in class promc.io.ProMCStatFile.ProMCStat
 
newBuilder() - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
newBuilder(ProMCStatFile.ProMCStat.ProcessData) - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
newBuilder() - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
newBuilder(ProMC.ProMCEvent.Event) - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
newBuilder() - Static method in class pronlo.io.ProMC.ProMCEvent
 
newBuilder(ProMC.ProMCEvent) - Static method in class pronlo.io.ProMC.ProMCEvent
 
newBuilder() - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
newBuilder(ProMC.ProMCEvent.Particles) - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
newBuilder() - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
newBuilder(ProMCDescriptionFile.ProMCDescription) - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
newBuilder() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilder(ProMCHeaderFile.ProMCHeader.MetaFloat) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilder() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilder(ProMCHeaderFile.ProMCHeader.MetaInt) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilder() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
newBuilder(ProMCHeaderFile.ProMCHeader) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
newBuilder() - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilder(ProMCHeaderFile.ProMCHeader.ParticleData) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilder() - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
newBuilder(ProMCStatFile.ProMCStat) - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
newBuilder() - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
newBuilder(ProMCStatFile.ProMCStat.ProcessData) - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
newBuilder() - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
newBuilder(ProMC.ProMCEvent.BLJets) - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
newBuilder() - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
newBuilder(ProMC.ProMCEvent.Electrons) - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
newBuilder() - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
newBuilder(ProMC.ProMCEvent.Event) - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
newBuilder() - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
newBuilder(ProMC.ProMCEvent.GenJets) - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
newBuilder() - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
newBuilder(ProMC.ProMCEvent.Jets) - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
newBuilder() - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
newBuilder(ProMC.ProMCEvent.MissingET) - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
newBuilder() - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
newBuilder(ProMC.ProMCEvent.Muons) - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
newBuilder() - Static method in class proreco.io.ProMC.ProMCEvent
 
newBuilder(ProMC.ProMCEvent) - Static method in class proreco.io.ProMC.ProMCEvent
 
newBuilder() - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
newBuilder(ProMC.ProMCEvent.Particles) - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
newBuilder() - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
newBuilder(ProMC.ProMCEvent.Photons) - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
newBuilder() - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
newBuilder(ProMC.ProMCEvent.Tracks) - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
newBuilder() - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
newBuilder(ProMCDescriptionFile.ProMCDescription) - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
newBuilder() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilder(ProMCHeaderFile.ProMCHeader.MetaFloat) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilder() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilder(ProMCHeaderFile.ProMCHeader.MetaInt) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilder() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
newBuilder(ProMCHeaderFile.ProMCHeader) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
newBuilder() - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilder(ProMCHeaderFile.ProMCHeader.ParticleData) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilder() - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
newBuilder(ProMCStatFile.ProMCStat) - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
newBuilder() - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
newBuilder(ProMCStatFile.ProMCStat.ProcessData) - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
newBuilderForType() - Method in class proeic.io.ProMC.ProMCEvent.Event
 
newBuilderForType() - Method in class proeic.io.ProMC.ProMCEvent
 
newBuilderForType() - Method in class proeic.io.ProMC.ProMCEvent.Particles
 
newBuilderForType() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
newBuilderForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilderForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilderForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
newBuilderForType() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilderForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
newBuilderForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
newBuilderForType() - Method in class proeic.io.ProMCStatFile.ProMCStat
 
newBuilderForType() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.F1D
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.F2D
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.FND
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.FPR
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.H1D
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.H2D
 
newBuilderForType() - Method in class promc.io.PBufFile.Record
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.P0D
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.P0I
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.P1D
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.PND
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.PNI
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.PXY
 
newBuilderForType() - Method in class promc.io.PBufFile.Record.PXYZ
 
newBuilderForType() - Method in class promc.io.PEventFile.HEvent.Entry
 
newBuilderForType() - Method in class promc.io.PEventFile.HEvent.Group
 
newBuilderForType() - Method in class promc.io.PEventFile.HEvent
 
newBuilderForType() - Method in class promc.io.ProMC.ProMCEvent.Event
 
newBuilderForType() - Method in class promc.io.ProMC.ProMCEvent
 
newBuilderForType() - Method in class promc.io.ProMC.ProMCEvent.Particles
 
newBuilderForType() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
newBuilderForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilderForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilderForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
 
newBuilderForType() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilderForType() - Method in class promc.io.ProMCStatFile.ProMCStat
 
newBuilderForType() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
newBuilderForType() - Method in class pronlo.io.ProMC.ProMCEvent.Event
 
newBuilderForType() - Method in class pronlo.io.ProMC.ProMCEvent
 
newBuilderForType() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
 
newBuilderForType() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
newBuilderForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilderForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilderForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
newBuilderForType() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilderForType() - Method in class pronlo.io.ProMCStatFile.ProMCStat
 
newBuilderForType() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
newBuilderForType() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
 
newBuilderForType() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
 
newBuilderForType() - Method in class proreco.io.ProMC.ProMCEvent.Event
 
newBuilderForType() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
 
newBuilderForType() - Method in class proreco.io.ProMC.ProMCEvent.Jets
 
newBuilderForType() - Method in class proreco.io.ProMC.ProMCEvent.MissingET
 
newBuilderForType() - Method in class proreco.io.ProMC.ProMCEvent.Muons
 
newBuilderForType() - Method in class proreco.io.ProMC.ProMCEvent
 
newBuilderForType() - Method in class proreco.io.ProMC.ProMCEvent.Particles
 
newBuilderForType() - Method in class proreco.io.ProMC.ProMCEvent.Photons
 
newBuilderForType() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
 
newBuilderForType() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
newBuilderForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
newBuilderForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
newBuilderForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
newBuilderForType() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
newBuilderForType() - Method in class proreco.io.ProMCStatFile.ProMCStat
 
newBuilderForType() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
newChildInstance(File) - Method in class org.apache.commons.io.monitor.FileEntry
Create a new child instance.
newDfp() - Method in class org.apache.commons.math3.dfp.DfpField
Makes a Dfp with a value of 0.
newDfp(byte) - Method in class org.apache.commons.math3.dfp.DfpField
Create an instance from a byte value.
newDfp(int) - Method in class org.apache.commons.math3.dfp.DfpField
Create an instance from an int value.
newDfp(long) - Method in class org.apache.commons.math3.dfp.DfpField
Create an instance from a long value.
newDfp(double) - Method in class org.apache.commons.math3.dfp.DfpField
Create an instance from a double value.
newDfp(Dfp) - Method in class org.apache.commons.math3.dfp.DfpField
Copy constructor.
newDfp(String) - Method in class org.apache.commons.math3.dfp.DfpField
Create a Dfp given a String representation.
newDfp(byte, byte) - Method in class org.apache.commons.math3.dfp.DfpField
Creates a Dfp with a non-finite value.
newDoubleQuantileFinder(boolean, long, double, double, int, RandomEngine) - Static method in class cern.jet.stat.quantile.QuantileFinderFactory
Returns a quantile finder that minimizes the amount of memory needed under the user provided constraints.
newEquiDepthPhis(int) - Static method in class cern.jet.stat.quantile.QuantileFinderFactory
Convenience method that computes phi's for equi-depth histograms.
newFifteenMinuteTimeline() - Static method in class org.jfree.chart.axis.SegmentedTimeline
Factory method to create a 15-min, 9:00 AM thought 4:00 PM, Monday through Friday SegmentedTimeline.
newFixedLengthChromosome(List<T>) - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
Creates a new instance of the same class as this is, with a given arrayRepresentation.
newInstance() - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance with a value of 0.
newInstance(byte) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance from a byte value.
newInstance(int) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance from an int value.
newInstance(long) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance from a long value.
newInstance(double) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance from a double value.
newInstance(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance by copying an existing one.
newInstance(String) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance from a String representation.
newInstance(byte, byte) - Method in class org.apache.commons.math3.dfp.Dfp
Creates an instance with a non-finite value.
newInstance() - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance with a value of 0.
newInstance(byte) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance from a byte value.
newInstance(int) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance from an int value.
newInstance(long) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance from a long value.
newInstance(double) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance from a double value.
newInstance(Dfp) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance by copying an existing one.
newInstance(String) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance from a String representation.
newInstance(byte, byte) - Method in class org.apache.commons.math3.dfp.DfpDec
Creates an instance with a non-finite value.
newInstance(String) - Static method in class org.jfree.chart.encoders.ImageEncoderFactory
Used to retrieve an ImageEncoder for a specific image format.
newInstance(String, float) - Static method in class org.jfree.chart.encoders.ImageEncoderFactory
Used to retrieve an ImageEncoder for a specific image format.
newInstance(String, boolean) - Static method in class org.jfree.chart.encoders.ImageEncoderFactory
Used to retrieve an ImageEncoder for a specific image format.
newInstance(String, float, boolean) - Static method in class org.jfree.chart.encoders.ImageEncoderFactory
Used to retrieve an ImageEncoder for a specific image format.
newInstance() - Method in class org.lsmp.djep.djep.DJep
 
newInstance(SymbolTable) - Method in class org.lsmp.djep.djep.DJep
 
newInstance() - Method in class org.lsmp.djep.djep.DSymbolTable
Creates a new SymbolTable with the same variable factory as this.
newInstance() - Method in class org.lsmp.djep.xjep.XJep
Creates a new instance of XJep with the same components as this one.
newInstance(SymbolTable) - Method in class org.lsmp.djep.xjep.XJep
Creates a new instance of XJep with the same components as this one and the specified symbol table.
newInstance() - Method in class org.lsmp.djep.xjep.XSymbolTable
Creates a new SymbolTable with the same variable factory as this.
newline - Static variable in interface jminhep.gui.Constants
 
newMarkers(List<Double>, double) - Static method in class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile
A creation method to build Markers
newMondayThroughFridayTimeline() - Static method in class org.jfree.chart.axis.SegmentedTimeline
Factory method to create a Monday through Friday SegmentedTimeline.
newPlotter(int) - Method in class jplot3d.SurfaceModelCanvas
 
newSampleData(double[], int, int) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Loads model x and y sample data from a flat input array, overriding any previous sample.
newSampleData(double[], double[][], double[][]) - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
Replace sample data, overriding any previous sample.
newSampleData(double[], double[][]) - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Loads model x and y sample data, overriding any previous sample.
newSampleData(double[], int, int) - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Loads model x and y sample data from a flat input array, overriding any previous sample.
newToken(int) - Static method in class jplot3dp.MathParser.Token
Returns a new Token object, by default.
newToken(int) - Static method in class org.nfunk.jep.Token
Returns a new Token object, by default.
newton - Static variable in class cern.clhep.Units
 
NewtonRaphsonSolver - Class in org.apache.commons.math3.analysis.solvers
Implements Newton's Method for finding zeros of real univariate differentiable functions.
NewtonRaphsonSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.NewtonRaphsonSolver
Construct a solver.
NewtonRaphsonSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.NewtonRaphsonSolver
Construct a solver.
NewtonRootFinder - Class in jhplot.math.num.root
Newton's method (1) for finding roots of functions.
NewtonRootFinder(Function, Function) - Constructor for class jhplot.math.num.root.NewtonRootFinder
Create a root finder for the given function.
NewtonRootFinder(Function, Function, int, double) - Constructor for class jhplot.math.num.root.NewtonRootFinder
Create a root finder for the given function.
NewtonSolver - Class in org.apache.commons.math3.analysis.solvers
Deprecated.
as of 3.1, replaced by NewtonRaphsonSolver
NewtonSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.NewtonSolver
Deprecated.
Construct a solver.
NewtonSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.NewtonSolver
Deprecated.
Construct a solver.
next() - Method in class hep.physics.filter.Filter
 
next() - Method in class jhplot.math.Poisson
Get next Poisson random number with the lambda given in constructor
next(double) - Method in class jhplot.math.Poisson
Get next Poisson random number with a new lambda (overwrides the default)
next - Variable in class jplot3dp.MathParser.Token
A reference to the next regular (non-special) token from the input stream.
next() - Method in class org.apache.commons.io.LineIterator
Returns the next line in the wrapped Reader.
next() - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
next() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
 
next() - Method in class org.jfree.data.time.Day
Returns the day following this one, or null if some limit has been reached.
next() - Method in class org.jfree.data.time.FixedMillisecond
Returns the millisecond following this one.
next() - Method in class org.jfree.data.time.Hour
Returns the hour following this one.
next() - Method in class org.jfree.data.time.Millisecond
Returns the millisecond following this one.
next() - Method in class org.jfree.data.time.Minute
Returns the minute following this one.
next() - Method in class org.jfree.data.time.Month
Returns the month following this one.
next() - Method in class org.jfree.data.time.Quarter
Returns the quarter following this one.
next() - Method in class org.jfree.data.time.RegularTimePeriod
Returns the time period following this one, or null if some limit has been reached.
next() - Method in class org.jfree.data.time.Second
Returns the second following this one.
next() - Method in class org.jfree.data.time.Week
Returns the week following this one.
next() - Method in class org.jfree.data.time.Year
Returns the year following this one.
next - Variable in class org.nfunk.jep.Token
A reference to the next regular (non-special) token from the input stream.
nextAfter(float, double) - Static method in class net.jafama.FastMath
If both arguments are +-0.0(f), (float)direction is returned.
nextAfter(double, double) - Static method in class net.jafama.FastMath
If both arguments are +-0.0, direction is returned.
nextAfter(float, double) - Static method in class net.jafama.StrictFastMath
If both arguments are +-0.0(f), (float)direction is returned.
nextAfter(double, double) - Static method in class net.jafama.StrictFastMath
If both arguments are +-0.0, direction is returned.
nextAfter(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Returns the next number greater than this one in the direction of x.
nextAfter(Dfp) - Method in class org.apache.commons.math3.dfp.DfpDec
Returns the next number greater than this one in the direction of x.
nextAfter(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Get the next machine representable number after a number, moving in the direction of another number.
nextAfter(float, double) - Static method in class org.apache.commons.math3.util.FastMath
Get the next machine representable number after a number, moving in the direction of another number.
nextBeta(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Beta Distribution.
nextBeta(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the Beta Distribution.
nextBinomial(int, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Binomial Distribution.
nextBinomial(int, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the Binomial Distribution.
nextBlock(int, long[], int) - Method in class cern.jet.random.sampling.RandomSampler
Computes the next count random numbers of the sorted random set specified on instance construction and fills them into values, starting at index fromIndex.
nextBoolean() - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random boolean.
nextBoolean() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBurr1(double, int, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a random number from the Burr II, VII, VIII, X Distributions.
nextBurr2(double, double, int, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a random number from the Burr III, IV, V, VI, IX, XII distributions.
nextBytes(byte[]) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Generates random bytes and places them into a user-supplied array.
nextBytes(byte[], int, int) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Generates random bytes and places them into a user-supplied array.
nextBytes(byte[]) - Method in class org.apache.commons.math3.random.RandomAdaptor
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in interface org.apache.commons.math3.random.RandomGenerator
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Generates random bytes and places them into a user-supplied byte array.
nextCauchy(RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a cauchy distributed random number from the standard Cauchy distribution C(0,1).
nextCauchy(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Cauchy Distribution.
nextCauchy(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the Cauchy Distribution.
nextChiSquare(double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the ChiSquare Distribution.
nextChiSquare(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the ChiSquare Distribution.
nextColor(int) - Method in class jplot.LinePars
Sets the color of the pen.
nextDouble() - Method in class cern.jet.random.AbstractDiscreteDistribution
Returns a random number from the distribution; returns (double) nextInt().
nextDouble() - Method in class cern.jet.random.AbstractDistribution
Returns a random number from the distribution.
nextDouble() - Method in class cern.jet.random.Beta
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.Beta
Returns a beta distributed random number; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.BreitWigner
Returns a random number from the distribution.
nextDouble(double, double, double) - Method in class cern.jet.random.BreitWigner
Returns a random number from the distribution; bypasses the internal state.
nextDouble(double, double, double) - Method in class cern.jet.random.BreitWignerMeanSquare
Returns a mean-squared random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.ChiSquare
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.ChiSquare
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Empirical
Returns a random number from the distribution.
nextDouble() - Method in class cern.jet.random.engine.RandomEngine
Returns a 64 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
nextDouble() - Method in interface cern.jet.random.engine.RandomGenerator
Returns a 64 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
nextDouble() - Method in class cern.jet.random.Exponential
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.Exponential
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.ExponentialPower
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.ExponentialPower
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Gamma
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.Gamma
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Hyperbolic
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.Hyperbolic
Returns a hyperbolic distributed random number; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Logarithmic
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.Logarithmic
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Normal
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.Normal
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.StudentT
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.StudentT
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (min,max) (excluding min and max).
nextDouble() - Method in class cern.jet.random.VonMises
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.VonMises
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDoubleFromTo(double, double) - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
nextDown(float) - Static method in class net.jafama.FastMath
Semantically equivalent to nextAfter(start,Double.NEGATIVE_INFINITY).
nextDown(double) - Static method in class net.jafama.FastMath
Semantically equivalent to nextAfter(start,Double.NEGATIVE_INFINITY).
nextDown(float) - Static method in class net.jafama.StrictFastMath
Semantically equivalent to nextAfter(start,Double.NEGATIVE_INFINITY).
nextDown(double) - Static method in class net.jafama.StrictFastMath
Semantically equivalent to nextAfter(start,Double.NEGATIVE_INFINITY).
nextDown(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute next number towards negative infinity.
nextDown(float) - Static method in class org.apache.commons.math3.util.FastMath
Compute next number towards negative infinity.
nextErlang(double, double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns an erlang distributed random number with the given variance and mean.
nextEvent() - Method in class hep.lcio.util.MergeFileParameters
Get the next event.
nextExponential(double) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates a random value from the exponential distribution with specified mean.
nextExponential(double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the exponential distribution with specified mean.
nextExponential(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the exponential distribution with specified mean.
nextF(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the F Distribution.
nextF(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the F Distribution.
nextFloat() - Method in class cern.jet.random.engine.RandomEngine
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0f,1.0f) (excluding 0.0f and 1.0f).
nextFloat() - Method in interface cern.jet.random.engine.RandomGenerator
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0f,1.0f) (excluding 0.0f and 1.0f).
nextFloat() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloatFromTo(float, float) - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
nextGamma(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Gamma Distribution.
nextGamma(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the Gamma Distribution.
nextGaussian() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian(double, double) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates a random value from the Normal (or Gaussian) distribution with specified mean and standard deviation.
nextGaussian(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Normal (or Gaussian) distribution with specified mean and standard deviation.
nextGaussian(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the Normal (or Gaussian) distribution with specified mean and standard deviation.
nextGaussian() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGeneration() - Method in class org.apache.commons.math3.genetics.ElitisticListPopulation
Start the population for the next generation.
nextGeneration(Population) - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Evolve the given population into the next generation.
nextGeneration() - Method in interface org.apache.commons.math3.genetics.Population
Start the population for the next generation.
nextGeometric(double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a discrete geometric distributed random number; Definition.
nextHexString(int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates a random string of hex characters of length len.
nextHexString(int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random string of hex characters of length len.
nextHexString(int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random string of hex characters of length len.
nextHypergeometric(int, int, int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Hypergeometric Distribution.
nextHypergeometric(int, int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the Hypergeometric Distribution.
nextInt() - Method in class cern.jet.random.AbstractDiscreteDistribution
Returns a random number from the distribution.
nextInt() - Method in class cern.jet.random.AbstractDistribution
Returns a random number from the distribution; returns (int) Math.round(nextDouble()).
nextInt() - Method in class cern.jet.random.Binomial
Returns a random number from the distribution.
nextInt(int, double) - Method in class cern.jet.random.Binomial
Returns a random number from the distribution with the given parameters n and p; bypasses the internal state.
nextInt() - Method in class cern.jet.random.EmpiricalWalker
Returns a random integer k with probability pdf(k).
nextInt() - Method in class cern.jet.random.engine.DRand
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE).
nextInt() - Method in class cern.jet.random.engine.MersenneTwister
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE).
nextInt() - Method in class cern.jet.random.engine.RandomEngine
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE);
nextInt() - Method in interface cern.jet.random.engine.RandomGenerator
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE);
nextInt() - Method in class cern.jet.random.HyperGeometric
Returns a random number from the distribution.
nextInt(int, int, int) - Method in class cern.jet.random.HyperGeometric
Returns a random number from the distribution; bypasses the internal state.
nextInt() - Method in class cern.jet.random.NegativeBinomial
Returns a random number from the distribution.
nextInt(int, double) - Method in class cern.jet.random.NegativeBinomial
Returns a random number from the distribution; bypasses the internal state.
nextInt() - Method in class cern.jet.random.Poisson
Returns a random number from the distribution.
nextInt(double) - Method in class cern.jet.random.Poisson
Returns a random number from the distribution; bypasses the internal state.
nextInt() - Method in class cern.jet.random.PoissonSlow
Returns a random number from the distribution.
nextInt() - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the closed interval [min,max] (including min and max).
nextInt() - Method in class cern.jet.random.Zeta
Returns a random number from the distribution.
nextInt() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt(int, int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates a uniformly distributed random integer between lower and upper (endpoints included).
nextInt(int, int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random integer between lower and upper (endpoints included).
nextInt(int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a uniformly distributed random integer between lower and upper (endpoints included).
nextInt() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextIntFromTo(int, int) - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
nextInversionDeviate(RealDistribution) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
use the distribution's sample() method
nextInversionDeviate(IntegerDistribution) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
use the distribution's sample() method
nextLambda(double, double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a lambda distributed random number with parameters l3 and l4.
nextLaplace(RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a Laplace (Double Exponential) distributed random number from the standard Laplace distribution L(0,1).
nextLine() - Method in class org.apache.commons.io.LineIterator
Returns the next line in the wrapped Reader.
nextLogistic(RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a random number from the standard Logistic distribution Log(0,1).
nextLong() - Method in class cern.jet.random.engine.RandomEngine
Returns a 64 bit uniformly distributed random number in the closed interval [Long.MIN_VALUE,Long.MAX_VALUE] (including Long.MIN_VALUE and Long.MAX_VALUE).
nextLong() - Method in interface cern.jet.random.engine.RandomGenerator
Returns a 64 bit uniformly distributed random number in the closed interval [Long.MIN_VALUE,Long.MAX_VALUE] (including Long.MIN_VALUE and Long.MAX_VALUE).
nextLong() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong(long) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns a pseudorandom, uniformly distributed long value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextLong() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong(long, long) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates a uniformly distributed random long integer between lower and upper (endpoints included).
nextLong(long, long) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random long integer between lower and upper (endpoints included).
nextLong(long, long) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a uniformly distributed random long integer between lower and upper (endpoints included).
nextLong() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLongFromTo(long, long) - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
nextNormalizedDouble() - Method in class org.apache.commons.math3.random.GaussianRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextNormalizedDouble() - Method in interface org.apache.commons.math3.random.NormalizedRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextNormalizedDouble() - Method in class org.apache.commons.math3.random.StableRandomGenerator
Generate a random scalar with zero location and unit scale.
nextNormalizedDouble() - Method in class org.apache.commons.math3.random.UniformRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextPage() - Method in class org.jlab.groot.graphics.EmbeddedCanvasGroup
 
nextPascal(int, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Pascal Distribution.
nextPascal(int, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the Pascal Distribution.
nextPermutation(int, int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates an integer array of length k whose entries are selected randomly, without repetition, from the integers 0, ..., n - 1 (inclusive).
nextPermutation(int, int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates an integer array of length k whose entries are selected randomly, without repetition, from the integers 0, ..., n - 1 (inclusive).
nextPermutation(int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates an integer array of length k whose entries are selected randomly, without repetition, from the integers 0, ..., n - 1 (inclusive).
nextPoisson(double) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates a random value from the Poisson distribution with the given mean.
nextPoisson(double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Poisson distribution with the given mean.
nextPoisson(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the Poisson distribution with the given mean.
nextPowLaw(double, double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a power-law distributed random number with the given exponent and lower cutoff.
nextPrime(int) - Static method in class cern.colt.map.PrimeFinder
Returns a prime number which is >= desiredCapacity and very close to desiredCapacity (within 11% if desiredCapacity >= 1000).
nextPrime(int) - Static method in class org.apache.commons.math3.primes.Primes
Return the smallest prime greater than or equal to n.
nextRandomNumber() - Method in class jhplot.math.num.random.LinearCongruentialRNG
Access the next random number from this generator.
nextRandomNumber() - Method in class jhplot.math.num.random.MathRNG
Access the next random number from this generator.
nextRandomNumber() - Method in class jhplot.math.num.random.RandomRNG
Access the next random number from this generator.
nextRandomNumber() - Method in interface jhplot.math.num.random.RNG
Access the next random number from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.BernoulliRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.BernoulliRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.BetaRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.BetaRandomVariable
Access the next random variable from this generator.
nextRandomVariable(int, double, RNG) - Static method in class jhplot.math.num.random.BinomialRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.BinomialRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.CauchyRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.CauchyRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.ChiSquaredRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.ChiSquaredRandomVariable
Access the next random variable from this generator.
nextRandomVariable() - Method in interface jhplot.math.num.random.ContinuousRandomVariable
Access the next random variable from this generator.
nextRandomVariable() - Method in interface jhplot.math.num.random.DiscreteRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.ExponentialRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.ExponentialRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.FRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.FRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.GammaRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.GammaRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.GeometricRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.GeometricRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.LaplaceRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.LaplaceRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.LogisticRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.LogisticRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.LogNormalRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.LogNormalRandomVariable
Access the next random variable from this generator.
nextRandomVariable(int, double, RNG) - Static method in class jhplot.math.num.random.NegativeBinomialRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.NegativeBinomialRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.NormalRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.NormalRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.PoissonRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.PoissonRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.RayleighRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.RayleighRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.TRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.TRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.UniformRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.UniformRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, double, RNG) - Static method in class jhplot.math.num.random.WeibullRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.WeibullRandomVariable
Access the next random variable from this generator.
nextSample(Collection<?>, int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Returns an array of k objects selected randomly from the Collection c.
nextSample(Collection<?>, int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Returns an array of k objects selected randomly from the Collection c.
nextSample(Collection<?>, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Returns an array of k objects selected randomly from the Collection c.
nextSecureHexString(int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates a random string of hex characters from a secure random sequence.
nextSecureHexString(int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random string of hex characters from a secure random sequence.
nextSecureHexString(int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random string of hex characters from a secure random sequence.
nextSecureInt(int, int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates a uniformly distributed random integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureInt(int, int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureInt(int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a uniformly distributed random integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureLong(long, long) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates a uniformly distributed random long integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureLong(long, long) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random long integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureLong(long, long) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a uniformly distributed random long integer between lower and upper (endpoints included) from a secure random sequence.
nextSeed() - Method in class cern.jet.random.engine.RandomSeedGenerator
Returns the next seed.
nextT(double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the T Distribution.
nextT(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the T Distribution.
nextToken() - Method in class jhplot.math.exp4j.tokenizer.Tokenizer
 
nextTriangular(RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a random number from the standard Triangular distribution in (-1,1).
nextUniform(double, double) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates a uniformly distributed random value from the open interval (lower, upper) (i.e., endpoints excluded).
nextUniform(double, double, boolean) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated.
Generates a uniformly distributed random value from the interval (lower, upper) or the interval [lower, upper).
nextUniform(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random value from the open interval (lower, upper) (i.e., endpoints excluded).
nextUniform(double, double, boolean) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random value from the interval (lower, upper) or the interval [lower, upper).
nextUniform(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a uniformly distributed random value from the open interval (lower, upper) (i.e., endpoints excluded).
nextUniform(double, double, boolean) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a uniformly distributed random value from the interval (lower, upper) or the interval [lower, upper).
nextUp(float) - Static method in class net.jafama.FastMath
Semantically equivalent to nextAfter(start,Double.POSITIVE_INFINITY).
nextUp(double) - Static method in class net.jafama.FastMath
Semantically equivalent to nextAfter(start,Double.POSITIVE_INFINITY).
nextUp(float) - Static method in class net.jafama.StrictFastMath
Semantically equivalent to nextAfter(start,Double.POSITIVE_INFINITY).
nextUp(double) - Static method in class net.jafama.StrictFastMath
Semantically equivalent to nextAfter(start,Double.POSITIVE_INFINITY).
nextUp(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute next number towards positive infinity.
nextUp(float) - Static method in class org.apache.commons.math3.util.FastMath
Compute next number towards positive infinity.
nextVector() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Generate a correlated random vector.
nextVector() - Method in class org.apache.commons.math3.random.HaltonSequenceGenerator
Generate a random vector.
nextVector() - Method in interface org.apache.commons.math3.random.RandomVectorGenerator
Generate a random vector.
nextVector() - Method in class org.apache.commons.math3.random.SobolSequenceGenerator
Generate a random vector.
nextVector() - Method in class org.apache.commons.math3.random.UncorrelatedRandomVectorGenerator
Generate an uncorrelated random vector.
nextVector() - Method in class org.apache.commons.math3.random.UnitSphereRandomVectorGenerator
Generate a random vector.
nextWeibull(double, double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a weibull distributed random number.
nextWeibull(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Weibull Distribution.
nextWeibull(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the Weibull Distribution.
nextWord() - Method in class graph.ScanString
Process the string and return the next token found.
nextWord() - Method in class graph.ScanWord
Read the input stream and return the next token found.
nextZipf(int, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Zipf Distribution.
nextZipf(int, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Generates a random value from the Zipf Distribution.
nextZipfInt(double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a zipfian distributed random number with the given skew.
nfcn() - Method in class org.freehep.math.minuit.ContoursError
 
nfcn() - Method in class org.freehep.math.minuit.FunctionMinimum
returns the total number of function calls during the minimization.
nfcn() - Method in class org.freehep.math.minuit.MinosError
 
nfcn() - Method in class org.freehep.math.minuit.MnUserParameterState
Returns the number of function calls during the minimization.
Niterations - Static variable in class jminhep.clcontrol.Global
 
njets() - Method in class hep.physics.jet.AbstractJetFinder
 
njets() - Method in class hep.physics.jet.FixNumberOfJetsFinder
Actual number jets formed.
njets() - Method in interface hep.physics.jet.JetFinder
The number of jets found
NO_ARGS - Static variable in class org.lsmp.djep.xjep.XOperator
No arguments to operator
NO_COMPARISON - Static variable in class hep.lcio.util.ObjectComparator
 
NO_DOT_IN_IDENTIFIERS - Static variable in interface org.nfunk.jep.ParserConstants
 
NO_DST_TIME_ZONE - Static variable in class org.jfree.chart.axis.SegmentedTimeline
Deprecated.
As of 1.0.7. This field is initialised based on the default time zone, and doesn't take into account subsequent changes to the default.
NO_INTERPOLATION - Static variable in class cern.jet.random.Empirical
 
NO_LABELS - Static variable in class org.jfree.chart.plot.CompassPlot
A constant for the label type.
NO_LINE - Static variable in class jplot.GraphSettings
Symbolic constant used for no lines (solid or dashed).
NO_SYMBOL - Static variable in class jplot.GraphSettings
Symbolic constant used for no symbols (points).
NoBracketingException - Exception in org.apache.commons.math3.exception
Exception to be thrown when function values have the same sign at both ends of an interval.
NoBracketingException(double, double, double, double) - Constructor for exception org.apache.commons.math3.exception.NoBracketingException
Construct the exception.
NoBracketingException(Localizable, double, double, double, double, Object...) - Constructor for exception org.apache.commons.math3.exception.NoBracketingException
Construct the exception with a specific context.
noContours - Variable in class graph.Contour
Boolean value if true Contours will not be calculated
noContours - Variable in class jplot.Contour
Boolean value if true Contours will not be calculated
NoDataException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the required data is missing.
NoDataException() - Constructor for exception org.apache.commons.math3.exception.NoDataException
Construct the exception.
NoDataException(Localizable) - Constructor for exception org.apache.commons.math3.exception.NoDataException
Construct the exception with a specific context.
Node - Interface in org.nfunk.jep
 
NodeFactory - Class in org.lsmp.djep.xjep
This class is used to create nodes of specified types.
NodeFactory(XJep) - Constructor for class org.lsmp.djep.xjep.NodeFactory
 
NodesSet<S extends Space> - Class in org.apache.commons.math3.geometry.partitioning
Set of BSP tree nodes.
NodesSet() - Constructor for class org.apache.commons.math3.geometry.partitioning.NodesSet
Simple constructor.
NoFeasibleSolutionException - Exception in org.apache.commons.math3.optim.linear
This class represents exceptions thrown by optimizers when no solution fulfills the constraints.
NoFeasibleSolutionException() - Constructor for exception org.apache.commons.math3.optim.linear.NoFeasibleSolutionException
Simple constructor using a default message.
NoFeasibleSolutionException - Exception in org.apache.commons.math3.optimization.linear
Deprecated.
As of 3.1 (to be removed in 4.0).
NoFeasibleSolutionException() - Constructor for exception org.apache.commons.math3.optimization.linear.NoFeasibleSolutionException
Deprecated.
Simple constructor using a default message.
NOLINE - Static variable in class graph.DataSet
A constant value flag used to specify no straight line segment is to join the data points
NONE - Static variable in class org.jfree.chart.block.BlockBorder
An empty border.
NONE - Static variable in class org.jfree.chart.block.LengthConstraintType
NONE.
NONE - Static variable in class org.jfree.chart.block.RectangleConstraint
An instance representing no constraint.
NONE - Static variable in class org.jfree.chart.plot.ThermometerPlot
A constant for the value label position (no label).
NONE - Static variable in class org.jfree.data.DomainOrder
No order.
NonGridContourDataset - Class in org.jfree.data.contour
Deprecated.
This class is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
NonGridContourDataset() - Constructor for class org.jfree.data.contour.NonGridContourDataset
Deprecated.
Default constructor.
NonGridContourDataset(String, Object[], Object[], Object[]) - Constructor for class org.jfree.data.contour.NonGridContourDataset
Deprecated.
Constructor for NonGridContourDataset.
NonGridContourDataset(String, Object[], Object[], Object[], int, int, int) - Constructor for class org.jfree.data.contour.NonGridContourDataset
Deprecated.
Constructor for NonGridContourDataset.
NonLinearConjugateGradientOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar.gradient
Non-linear conjugate gradient optimizer.
NonLinearConjugateGradientOptimizer(NonLinearConjugateGradientOptimizer.Formula, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
Constructor with default tolerances for the line search (1e-8) and preconditioner.
NonLinearConjugateGradientOptimizer(NonLinearConjugateGradientOptimizer.Formula, ConvergenceChecker<PointValuePair>, UnivariateSolver) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
NonLinearConjugateGradientOptimizer(NonLinearConjugateGradientOptimizer.Formula, ConvergenceChecker<PointValuePair>, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
Constructor with default preconditioner.
NonLinearConjugateGradientOptimizer(NonLinearConjugateGradientOptimizer.Formula, ConvergenceChecker<PointValuePair>, UnivariateSolver, Preconditioner) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
NonLinearConjugateGradientOptimizer(NonLinearConjugateGradientOptimizer.Formula, ConvergenceChecker<PointValuePair>, double, double, double, Preconditioner) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
 
NonLinearConjugateGradientOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated.
As of 3.1 (to be removed in 4.0).
NonLinearConjugateGradientOptimizer(ConjugateGradientFormula) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
NonLinearConjugateGradientOptimizer(ConjugateGradientFormula, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
Deprecated.
Constructor with default line search solver and preconditioner.
NonLinearConjugateGradientOptimizer(ConjugateGradientFormula, ConvergenceChecker<PointValuePair>, UnivariateSolver) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
Deprecated.
Constructor with default preconditioner.
NonLinearConjugateGradientOptimizer(ConjugateGradientFormula, ConvergenceChecker<PointValuePair>, UnivariateSolver, Preconditioner) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
Deprecated.
 
NonLinearConjugateGradientOptimizer.BracketingStep - Class in org.apache.commons.math3.optim.nonlinear.scalar.gradient
Deprecated.
As of v3.3, this class is not used anymore. This setting is replaced by the initialBracketingRange argument to the new constructors.
NonLinearConjugateGradientOptimizer.Formula - Enum in org.apache.commons.math3.optim.nonlinear.scalar.gradient
Available choices of update formulas for the updating the parameter that is used to compute the successive conjugate search directions.
NonLinearConjugateGradientOptimizer.IdentityPreconditioner - Class in org.apache.commons.math3.optim.nonlinear.scalar.gradient
Default identity preconditioner.
NonLinearConjugateGradientOptimizer.IdentityPreconditioner - Class in org.apache.commons.math3.optimization.general
Deprecated.
Default identity preconditioner.
NonMonotonicSequenceException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the a sequence of values is not monotonically increasing or decreasing.
NonMonotonicSequenceException(Number, Number, int) - Constructor for exception org.apache.commons.math3.exception.NonMonotonicSequenceException
Construct the exception.
NonMonotonicSequenceException(Number, Number, int, MathArrays.OrderDirection, boolean) - Constructor for exception org.apache.commons.math3.exception.NonMonotonicSequenceException
Construct the exception.
NonNegativeConstraint - Class in org.apache.commons.math3.optim.linear
A constraint for a linear optimization problem indicating whether all variables must be restricted to non-negative values.
NonNegativeConstraint(boolean) - Constructor for class org.apache.commons.math3.optim.linear.NonNegativeConstraint
 
NONNUMERIC - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
NonPositiveDefiniteMatrixException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a positive definite matrix is expected.
NonPositiveDefiniteMatrixException(double, int, double) - Constructor for exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
Construct an exception.
NonPositiveDefiniteOperatorException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a symmetric, definite positive RealLinearOperator is expected.
NonPositiveDefiniteOperatorException() - Constructor for exception org.apache.commons.math3.linear.NonPositiveDefiniteOperatorException
Creates a new instance of this class.
NonSelfAdjointOperatorException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a self-adjoint RealLinearOperator is expected.
NonSelfAdjointOperatorException() - Constructor for exception org.apache.commons.math3.linear.NonSelfAdjointOperatorException
Creates a new instance of this class.
NonSquareMatrixException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a square matrix is expected.
NonSquareMatrixException(int, int) - Constructor for exception org.apache.commons.math3.linear.NonSquareMatrixException
Construct an exception from the mismatched dimensions.
NonSquareOperatorException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a square linear operator is expected.
NonSquareOperatorException(int, int) - Constructor for exception org.apache.commons.math3.linear.NonSquareOperatorException
Construct an exception from the mismatched dimensions.
NonSymmetricMatrixException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a symmetric matrix is expected.
NonSymmetricMatrixException(int, int, double) - Constructor for exception org.apache.commons.math3.linear.NonSymmetricMatrixException
Construct an exception.
NordsieckStepInterpolator - Class in org.apache.commons.math3.ode.sampling
This class implements an interpolator for integrators using Nordsieck representation.
NordsieckStepInterpolator() - Constructor for class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Simple constructor.
NordsieckStepInterpolator(NordsieckStepInterpolator) - Constructor for class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Copy constructor.
Norm - Class in Jampack
Norm computes norms of matrices.
Norm() - Constructor for class Jampack.Norm
 
norm(double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the L2 norm of an array (Euclidean norm or "length").
norm(int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the L2 norm of an array (Euclidean norm or "length").
norm1(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the one-norm of vector x, which is Sum(abs(x[i])).
norm1(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the one-norm of matrix A, which is the maximum absolute column sum.
norm1() - Method in class Jama.Matrix
One norm
norm1() - Method in class jhplot.math.kalman.jama.Matrix
One norm
norm1(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
norm2(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the two-norm (aka euclidean norm) of vector x; equivalent to mult(x,x).
norm2(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the two-norm of matrix A, which is the maximum singular value; obtained from SVD.
norm2() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the two norm, which is max(S).
norm2() - Method in class Jama.Matrix
Two norm
norm2() - Method in class Jama.SingularValueDecomposition
Two norm
norm2(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
norm2() - Method in class jhplot.math.SingularValueDecomposition
Two norm
Normal - Class in cern.jet.random
Normal (aka Gaussian) distribution; See the math definition and animated definition.
Normal(double, double, RandomEngine) - Constructor for class cern.jet.random.Normal
Constructs a normal (gauss) distribution.
normal(double) - Static method in class cern.jet.stat.Probability
Returns the area under the Normal (Gaussian) probability density function, integrated from minus infinity to x (assumes mean is zero, variance is one).
normal(double, double, double) - Static method in class cern.jet.stat.Probability
Returns the area under the Normal (Gaussian) probability density function, integrated from minus infinity to x.
normal(double) - Static method in class graph.SpecialFunction
 
Normal - Class in jhplot.math.num.pdf
The Normal distribution (1).
Normal() - Constructor for class jhplot.math.num.pdf.Normal
Default constructor.
Normal(double, double) - Constructor for class jhplot.math.num.pdf.Normal
Create a distribution with the given mean and standard deviation.
normal(double, double) - Static method in class jhplot.math.Random
Generate a random number from a Gaussian (Normal) random variable.
NORMAL - Static variable in class org.apache.commons.io.FileDeleteStrategy
The singleton instance for normal file deletion, which does not permit the deletion of directories that are not empty.
NORMAL - Static variable in class org.jfree.chart.plot.ThermometerPlot
A constant for the 'normal' range.
normalApproximateProbability(int) - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Calculates the Poisson distribution function using a normal approximation.
NormalApproximationInterval - Class in org.apache.commons.math3.stat.interval
Implements the normal approximation method for creating a binomial proportion confidence interval.
NormalApproximationInterval() - Constructor for class org.apache.commons.math3.stat.interval.NormalApproximationInterval
 
NormalDistribution - Class in org.apache.commons.math3.distribution
Implementation of the normal (gaussian) distribution.
NormalDistribution() - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
Create a normal distribution with mean equal to zero and standard deviation equal to one.
NormalDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
Create a normal distribution using the given mean and standard deviation.
NormalDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
Create a normal distribution using the given mean, standard deviation and inverse cumulative distribution accuracy.
NormalDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
Creates a normal distribution.
NormalDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
Creates a normal distribution.
NormalDistributionFunction2D - Class in org.jfree.data.function
A normal distribution function.
NormalDistributionFunction2D(double, double) - Constructor for class org.jfree.data.function.NormalDistributionFunction2D
Constructs a new normal distribution function.
normalInverse(double) - Static method in class cern.jet.stat.Probability
Returns the value, x, for which the area under the Normal (Gaussian) probability density function (integrated from minus infinity to x) is equal to the argument y (assumes mean is zero, variance is one); formerly named ndtri.
normaliseArray(double[], int[]) - Static method in class jhplot.stat.ProbabilityState
Takes an input vector and writes an output vector which is a normalised version of the input, and returns the maximum state.
normalize(double[]) - Static method in class jhplot.math.ArrayMathUtils
Renormalizes the array so that its L2 norm is 1 (up to computational errors).
normalize(String) - Static method in class org.apache.commons.io.FilenameUtils
Normalizes a path, removing double and single dot path steps.
normalize(String, boolean) - Static method in class org.apache.commons.io.FilenameUtils
Normalizes a path, removing double and single dot path steps.
normalize() - Method in class org.apache.commons.math3.complex.Quaternion
Computes the normalized quaternion (the versor of the instance).
normalize() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get a normalized vector aligned with the instance.
normalize() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get a normalized vector aligned with the instance.
normalize() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get a normalized vector aligned with the instance.
normalize() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get a normalized vector aligned with the instance.
normalize() - Method in interface org.apache.commons.math3.geometry.Vector
Get a normalized vector aligned with the instance.
normalize(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Normalize (standardize) the sample, so it is has a mean of 0 and a standard deviation of 1.
normalize(double) - Method in class org.jlab.groot.data.H1F
Normalizes the histogram data to the specified number
normalizeAngle(double, double) - Static method in class org.apache.commons.math3.util.MathUtils
Normalize an angle in a 2π wide interval around a center value.
normalizeArray(double[], double) - Static method in class org.apache.commons.math3.util.MathArrays
Normalizes an array to make it sum to a specified value.
normalized(H1F, H1F) - Static method in class org.jlab.groot.data.H1F
returns a new histogram with a content of h1 where the integral is normalized to histogram h2.
NormalizedMatrixSeries - Class in org.jfree.data.xy
Represents a dense normalized matrix M[i,j] where each Mij item of the matrix has a value (default is 0).
NormalizedMatrixSeries(String, int, int) - Constructor for class org.jfree.data.xy.NormalizedMatrixSeries
Constructor for NormalizedMatrixSeries.
NormalizedRandomGenerator - Interface in org.apache.commons.math3.random
This interface represent a normalized random generator for scalars.
normalizeMinusHalfPiHalfPi(double) - Static method in class net.jafama.FastMath
 
normalizeMinusHalfPiHalfPi(double) - Static method in class net.jafama.StrictFastMath
 
normalizeMinusHalfPiHalfPiFast(double) - Static method in class net.jafama.FastMath
Not accurate for large values.
normalizeMinusHalfPiHalfPiFast(double) - Static method in class net.jafama.StrictFastMath
Not accurate for large values.
normalizeMinusPiPi(double) - Static method in class net.jafama.FastMath
 
normalizeMinusPiPi(double) - Static method in class net.jafama.StrictFastMath
 
normalizeMinusPiPiFast(double) - Static method in class net.jafama.FastMath
Not accurate for large values.
normalizeMinusPiPiFast(double) - Static method in class net.jafama.StrictFastMath
Not accurate for large values.
normalizeNoEndSeparator(String) - Static method in class org.apache.commons.io.FilenameUtils
Normalizes a path, removing double and single dot path steps, and removing any final directory separator.
normalizeNoEndSeparator(String, boolean) - Static method in class org.apache.commons.io.FilenameUtils
Normalizes a path, removing double and single dot path steps, and removing any final directory separator.
normalizeZeroTwoPi(double) - Static method in class net.jafama.FastMath
 
normalizeZeroTwoPi(double) - Static method in class net.jafama.StrictFastMath
 
normalizeZeroTwoPiFast(double) - Static method in class net.jafama.FastMath
Not accurate for large values.
normalizeZeroTwoPiFast(double) - Static method in class net.jafama.StrictFastMath
Not accurate for large values.
NormalRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Normal distribution.
NormalRandomVariable() - Constructor for class jhplot.math.num.random.NormalRandomVariable
Default constructor.
NormalRandomVariable(double, double) - Constructor for class jhplot.math.num.random.NormalRandomVariable
Create a random variable with the given mean and standard deviation.
NormalRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.NormalRandomVariable
Create a random variable with the given parameters.
normF(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the Frobenius norm of matrix A, which is Sqrt(Sum(A[i,j]2)).
normF() - Method in class Jama.Matrix
Frobenius norm
normF() - Method in class jhplot.math.kalman.jama.Matrix
Frobenius norm
normF(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
normInf() - Method in class Jama.Matrix
Infinity norm
normInf() - Method in class jhplot.math.kalman.jama.Matrix
Infinity norm
normInf(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
normInfinity(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the infinity norm of vector x, which is Max(abs(x[i])).
normInfinity(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the infinity norm of matrix A, which is the maximum absolute row sum.
NORTH_LEFT - Static variable in class org.jfree.chart.plot.PolarAxisLocation
Axis left of north.
NORTH_RIGHT - Static variable in class org.jfree.chart.plot.PolarAxisLocation
Axis right of north.
NoSubSpaceException() - Constructor for exception org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D.NoSubSpaceException
Simple constructor.
NoSubSpaceException() - Constructor for exception org.apache.commons.math3.geometry.spherical.oned.Sphere1D.NoSubSpaceException
Simple constructor.
not() - Method in class cern.colt.bitvector.BitMatrix
Performs a logical NOT on the bits of the receiver.
not() - Method in class cern.colt.bitvector.BitVector
Performs a logical NOT on the bits of the receiver (A = ~A).
not - Static variable in class cern.jet.math.IntFunctions
Function that returns ~a.
NOT - Static variable in class org.lsmp.djep.rpe.RpEval
 
Not - Class in org.nfunk.jep.function
 
Not() - Constructor for class org.nfunk.jep.function.Not
 
NOT - Static variable in interface org.nfunk.jep.ParserConstants
 
NOT_EMPTY - Static variable in class org.apache.commons.io.filefilter.EmptyFileFilter
Singleton instance of not-empty filter
NOT_EQUAL - Static variable in class hep.lcio.util.ObjectComparator
 
NotANumberException - Exception in org.apache.commons.math3.exception
Exception to be thrown when a number is not a number.
NotANumberException() - Constructor for exception org.apache.commons.math3.exception.NotANumberException
Construct the exception.
NotARotationMatrixException - Exception in org.apache.commons.math3.geometry.euclidean.threed
This class represents exceptions thrown while building rotations from matrices.
NotARotationMatrixException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.geometry.euclidean.threed.NotARotationMatrixException
Simple constructor.
notEquals(SpacePoint) - Method in class hep.physics.vec.SpacePoint
Inequality
notEquals(SpacePoint) - Method in class hephysics.vec.SpacePoint
Inequality
NOTEQUALS - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
notFileFilter(IOFileFilter) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that NOTs the specified filter.
NotFileFilter - Class in org.apache.commons.io.filefilter
This filter produces a logical NOT of the filters specified.
NotFileFilter(IOFileFilter) - Constructor for class org.apache.commons.io.filefilter.NotFileFilter
Constructs a new file filter that NOTs the result of another filter.
NotFiniteNumberException - Exception in org.apache.commons.math3.exception
Exception to be thrown when a number is not finite.
NotFiniteNumberException(Number, Object...) - Constructor for exception org.apache.commons.math3.exception.NotFiniteNumberException
Construct the exception.
NotFiniteNumberException(Localizable, Number, Object...) - Constructor for exception org.apache.commons.math3.exception.NotFiniteNumberException
Construct the exception with a specific context.
notifyListeners(MarkerChangeEvent) - Method in class org.jfree.chart.plot.Marker
Notifies all registered listeners that the marker has been modified.
notifyListeners(PlotChangeEvent) - Method in class org.jfree.chart.plot.Plot
Notifies all registered listeners that the plot has been modified.
notifyListeners(RendererChangeEvent) - Method in class org.jfree.chart.renderer.AbstractRenderer
Notifies all registered listeners that the renderer has been modified.
NotOutlierException - Exception in org.jfree.chart.renderer
An exception that is generated by the Outlier, OutlierList and OutlierListCollection classes.
NotOutlierException(String) - Constructor for exception org.jfree.chart.renderer.NotOutlierException
Creates a new exception.
NotPositiveException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the argument is negative.
NotPositiveException(Number) - Constructor for exception org.apache.commons.math3.exception.NotPositiveException
Construct the exception.
NotPositiveException(Localizable, Number) - Constructor for exception org.apache.commons.math3.exception.NotPositiveException
Construct the exception with a specific context.
NotShow() - Method in class jminhep.clcontrol.SummaryPad
 
NotStrictlyPositiveException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the argument is not greater than 0.
NotStrictlyPositiveException(Number) - Constructor for exception org.apache.commons.math3.exception.NotStrictlyPositiveException
Construct the exception.
NotStrictlyPositiveException(Localizable, Number) - Constructor for exception org.apache.commons.math3.exception.NotStrictlyPositiveException
Construct the exception with a specific context.
nParticlesPerJet(int) - Method in class hep.physics.jet.AbstractJetFinder
 
nParticlesPerJet(int) - Method in class hep.physics.jet.FixNumberOfJetsFinder
 
nParticlesPerJet(int) - Method in interface hep.physics.jet.JetFinder
Find out many particles are in a particular jet
NPointCrossover<T> - Class in org.apache.commons.math3.genetics
N-point crossover policy.
NPointCrossover(int) - Constructor for class org.apache.commons.math3.genetics.NPointCrossover
Creates a new NPointCrossover policy using the given number of points.
nPoints - Static variable in class jminhep.clcontrol.Global
 
nr - Variable in class Jampack.Zmat
The number of rows
nreads() - Method in class hep.lcio.util.MergeFileParameters
Get the number of reads per event.
nrl - Variable in class Jampack.Zludpp
The number of rows in L
nRoot(ValueErr, int) - Method in class jhplot.math.ValueErr
Take nth root from the value (n is above 1)
nrow - Variable in class Jampack.Zhqrd
The number of rows in A
NRow - Static variable in class jminhep.gui.SetEnv
 
nrow() - Method in class org.freehep.math.minuit.MnUserCovariance
 
ns - Static variable in class cern.clhep.Units
 
NSELECTED_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
NSELECTED_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat
 
NSELECTED_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat
 
NSELECTED_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat
 
nthRoot(int) - Method in class org.apache.commons.math3.complex.Complex
Computes the n-th roots of this complex number.
ntran - Variable in class Jampack.Zhqrd
The number of Householder transformations
NTRIED_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
NTRIED_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat
 
NTRIED_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat
 
NTRIED_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat
 
NULL_OUTPUT_STREAM - Static variable in class org.apache.commons.io.output.NullOutputStream
A singleton.
NULL_PRINT_STREAM - Static variable in class org.apache.commons.io.output.NullPrintStream
The singleton instance.
NULL_WRITER - Static variable in class org.apache.commons.io.output.NullWriter
A singleton.
NullAppendable - Class in org.apache.commons.io.output
Appends all data to the famous /dev/null.
NullArgumentException - Exception in org.apache.commons.math3.exception
All conditions checks that fail due to a null argument must throw this exception.
NullArgumentException() - Constructor for exception org.apache.commons.math3.exception.NullArgumentException
Default constructor.
NullArgumentException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.NullArgumentException
 
NullInputStream - Class in org.apache.commons.io.input
A functional, light weight InputStream that emulates a stream of a specified size.
NullInputStream() - Constructor for class org.apache.commons.io.input.NullInputStream
Create an InputStream that emulates a size 0 stream which supports marking and does not throw EOFException.
NullInputStream(long) - Constructor for class org.apache.commons.io.input.NullInputStream
Create an InputStream that emulates a specified size which supports marking and does not throw EOFException.
NullInputStream(long, boolean, boolean) - Constructor for class org.apache.commons.io.input.NullInputStream
Create an InputStream that emulates a specified size with option settings.
nullNotPermitted(Object, String) - Static method in class org.jfree.chart.util.ParamChecks
Throws an IllegalArgumentException if the supplied param is null.
NullOutputStream - Class in org.apache.commons.io.output
Writes all data to the famous /dev/null.
NullOutputStream() - Constructor for class org.apache.commons.io.output.NullOutputStream
NullPrintStream - Class in org.apache.commons.io.output
Writes all data to the famous /dev/null.
NullPrintStream() - Constructor for class org.apache.commons.io.output.NullPrintStream
Constructs an instance.
NullReader - Class in org.apache.commons.io.input
A functional, light weight Reader that emulates a reader of a specified size.
NullReader() - Constructor for class org.apache.commons.io.input.NullReader
Creates a Reader that emulates a size 0 reader which supports marking and does not throw EOFException.
NullReader(long) - Constructor for class org.apache.commons.io.input.NullReader
Creates a Reader that emulates a specified size which supports marking and does not throw EOFException.
NullReader(long, boolean, boolean) - Constructor for class org.apache.commons.io.input.NullReader
Creates a Reader that emulates a specified size with option settings.
NullWriter - Class in org.apache.commons.io.output
Writes all data to the famous /dev/null.
NullWriter() - Constructor for class org.apache.commons.io.output.NullWriter
Constructs a new NullWriter.
numArgs() - Method in class org.lsmp.djep.xjep.XOperator
 
NUMBER - Static variable in class graph.ScanString
Flag a Number
NUMBER - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
number() - Method in class org.jlab.groot.math.StatNumber
 
NUMBER_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
NUMBER_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
NUMBER_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent.Event
 
NUMBER_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
NumberAxis - Class in org.jfree.chart.axis
An axis for displaying numerical data.
NumberAxis() - Constructor for class org.jfree.chart.axis.NumberAxis
Default constructor.
NumberAxis(String) - Constructor for class org.jfree.chart.axis.NumberAxis
Constructs a number axis, using default values where necessary.
NumberAxis3D - Class in org.jfree.chart.axis
A standard linear value axis with a 3D effect corresponding to the offset specified by some renderers.
NumberAxis3D() - Constructor for class org.jfree.chart.axis.NumberAxis3D
Default constructor.
NumberAxis3D(String) - Constructor for class org.jfree.chart.axis.NumberAxis3D
Constructs a new axis.
NumberFactory - Interface in org.nfunk.jep.type
This interface can be implemented to create numbers of any object type.
numberFormat - Static variable in class jplot.Utils
 
numberFormat - Static variable in class jplot3d.NumUtil
 
NumberIsTooLargeException - Exception in org.apache.commons.math3.exception
Exception to be thrown when a number is too large.
NumberIsTooLargeException(Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooLargeException
Construct the exception.
NumberIsTooLargeException(Localizable, Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooLargeException
Construct the exception with a specific context.
NumberIsTooSmallException - Exception in org.apache.commons.math3.exception
Exception to be thrown when a number is too small.
NumberIsTooSmallException(Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooSmallException
Construct the exception.
NumberIsTooSmallException(Localizable, Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooSmallException
Construct the exception with a specific context.
numberLabels() - Method in class jhplot.HPlot
No labels on the current plot.
numberLabels() - Method in class jplot.GraphSettings
No of labels
numberPrimitives() - Method in class jhplot.HPlot
No of primitives for the current plot.
numberPrimitives() - Method in class jplot.GraphSettings
No of primitives
NumbersUtils - Class in net.jafama
Class containing various basic utility methods to deal with numbers.
NumberTick - Class in org.jfree.chart.axis
A numerical tick.
NumberTick(Number, String, TextAnchor, TextAnchor, double) - Constructor for class org.jfree.chart.axis.NumberTick
Creates a new tick.
NumberTick(TickType, double, String, TextAnchor, TextAnchor, double) - Constructor for class org.jfree.chart.axis.NumberTick
Creates a new tick.
NumberTickUnit - Class in org.jfree.chart.axis
A numerical tick unit.
NumberTickUnit(double) - Constructor for class org.jfree.chart.axis.NumberTickUnit
Creates a new number tick unit.
NumberTickUnit(double, NumberFormat) - Constructor for class org.jfree.chart.axis.NumberTickUnit
Creates a new number tick unit.
NumberTickUnit(double, NumberFormat, int) - Constructor for class org.jfree.chart.axis.NumberTickUnit
Creates a new number tick unit.
NumberTickUnitSource - Class in org.jfree.chart.axis
A tick unit source implementation that returns NumberTickUnit instances that are multiples of 1, 2 or 5 times some power of 10.
NumberTickUnitSource() - Constructor for class org.jfree.chart.axis.NumberTickUnitSource
Creates a new instance.
NumberTickUnitSource(boolean) - Constructor for class org.jfree.chart.axis.NumberTickUnitSource
Creates a new instance.
NumberTickUnitSource(boolean, NumberFormat) - Constructor for class org.jfree.chart.axis.NumberTickUnitSource
Creates a new instance.
NumberToken - Class in jhplot.math.exp4j.tokenizer
Represents a number in the expression
NumberToken(double) - Constructor for class jhplot.math.exp4j.tokenizer.NumberToken
Create a new instance
NumberTransformer - Interface in org.apache.commons.math3.util
Subclasses implementing this interface can transform Objects to doubles.
numEles() - Method in class org.lsmp.djep.vectorJep.Dimensions
The total number of elements.
NUMERIC - Variable in class graph.LoadData
Flag used to specify the type of data to be loaded.
numeric() - Method in class jhplot.F1D
Perform some numeric substitutions.
numeric() - Method in class jhplot.F2D
Perform some numeric substitutions.
Numeric - Class in jhplot.math
Do some numerical calculations.
Numeric() - Constructor for class jhplot.math.Numeric
 
NumericException - Exception in jhplot.math.num
Generic numerical exception thrown by numerics4j.
NumericException(String) - Constructor for exception jhplot.math.num.NumericException
Create an execption with the given message.
numFracDigits(double) - Static method in class jplot.Utils
 
numFracDigits(double) - Static method in class jplot3d.NumUtil
 
NumJetsNotFoundException(String) - Constructor for exception hep.physics.jet.FixNumberOfJetsFinder.NumJetsNotFoundException
 
numOfCalls() - Method in class org.freehep.math.minuit.MnApplication
 
NumUtil - Class in jplot3d
 
NumUtil() - Constructor for class jplot3d.NumUtil
 
numVars() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Find the number of variables.
nval - Variable in class graph.ScanString
 
NwList(String[]) - Constructor for class jhepsim.FontChooser.NwList
 
NwList(String[]) - Constructor for class jminhep.gui.FontChooser.NwList
 
nz() - Static method in class Jampack.Rand
Generates a normal random complex number, i.e., a complex number whose real and imaginary parts are random.
nz1(int) - Static method in class Jampack.Rand
Generates a normal random Z1.
nzmat(int, int) - Static method in class Jampack.Rand
Generates a normal random Zmat.

O

o(Zmat, int[], int[]) - Static method in class Jampack.Block
This method takes a Zmat A and two arrays ii and jj of length m and n and produces an (m-1)x(n-1) block matrix Zmat[m-1][n-1], whose (i,j)-element is A.get(ii[i], ii[i+1]-1, jj[j], jj[j+1]-1).
o(int) - Static method in class Jampack.Eye
Generates an identity matrix of order n.
o(int, int) - Static method in class Jampack.Eye
Generates an mxn matrix whose diagonal elements are one and whose off diagonal elements are zero.
o(Zmat) - Static method in class Jampack.H
Returns the conjugate transpose of a Zmat.
o(Zdiagmat) - Static method in class Jampack.H
Returns the conjugate transpose of a Zdiagmat.
o(Zltmat) - Static method in class Jampack.Inv
Computes the inverse of a Zltmat.
o(Zutmat) - Static method in class Jampack.Inv
Computes the inverse of a Zutmat.
o(Zmat) - Static method in class Jampack.Inv
Computes the inverse of a square Zmat
o(Zpsdmat) - Static method in class Jampack.Inv
Computes the inverse of a Zpsdmat.
o(Zdiagmat) - Static method in class Jampack.Inv
Computes the inverse of a Zdiagmat.
o(Zmat[][]) - Static method in class Jampack.Merge
Merges the matrices in an array of Zmats
o(Zmat, Zmat) - Static method in class Jampack.Minus
Computes the difference of two Zmats.
o(Zmat) - Static method in class Jampack.Minus
Negates a Zmat
o(Zmat, Zdiagmat) - Static method in class Jampack.Minus
Computes the difference of a Zmat and a Zdiagmat.
o(Zdiagmat, Zmat) - Static method in class Jampack.Minus
Computes the difference of a Zdiagmat and a Zmat.
o(Zdiagmat, Zdiagmat) - Static method in class Jampack.Minus
Computes the difference of a two Zdiagmats.
o(Zdiagmat) - Static method in class Jampack.Minus
Negates a Zdiagmat.
o(Zmat, Zmat) - Static method in class Jampack.Plus
Computes the sum of two Zmats
o(Zmat, Zdiagmat) - Static method in class Jampack.Plus
Computes the sum of a Zmat and a Zdiagmat.
o(Zdiagmat, Zmat) - Static method in class Jampack.Plus
Computes the sum of a Zdiagmat and a Zmat.
o(Zdiagmat, Zdiagmat) - Static method in class Jampack.Plus
Computes the sum of a Zdiagmat and a Zdiagmat.
o(int) - Static method in class Jampack.Print
Prints an int in default format.
o(int, int) - Static method in class Jampack.Print
Prints and int in a field of width w.
o(int[]) - Static method in class Jampack.Print
Prints an integer array in default format.
o(int[], int) - Static method in class Jampack.Print
Prints an integer array in fields of width w.
o(double) - Static method in class Jampack.Print
Prints a double in default e format.
o(double, int, int) - Static method in class Jampack.Print
Prints a double in w.d e format.
o(double[]) - Static method in class Jampack.Print
Prints an array of doubles in default e format.
o(double[], int, int) - Static method in class Jampack.Print
Prints an array of doubles in w.d e format.
o(double[][]) - Static method in class Jampack.Print
Prints a 2-dimensional array of doubles in default e format.
o(double[][], int, int) - Static method in class Jampack.Print
Prints a 2-dimensional array of doubles in w.d e format.
o(Z) - Static method in class Jampack.Print
Prints a Z in default e format.
o(Z, int, int) - Static method in class Jampack.Print
Prints a Z in w.d e format.
o(Z[]) - Static method in class Jampack.Print
Prints an array of Z's in default e format.
o(Z[], int, int) - Static method in class Jampack.Print
Prints an array of Z's in w.d e format.
o(Z[][]) - Static method in class Jampack.Print
Prints a 2-dimensional array of Z in default e format.
o(Z[][], int, int) - Static method in class Jampack.Print
Prints a 2-dimensional array of Z in w.d e format.
o(Z1) - Static method in class Jampack.Print
Prints a Z1 in default format.
o(Z1, int, int) - Static method in class Jampack.Print
Prints a Z1 in w.d e format
o(Zmat) - Static method in class Jampack.Print
Prints a Zmat in default e format.
o(Zmat, int, int) - Static method in class Jampack.Print
Prints a Zmat in w.d e format.
o(Zdiagmat) - Static method in class Jampack.Print
Prints a Zdiagmat in default format.
o(Zdiagmat, int, int) - Static method in class Jampack.Print
Prints a Zdiagmat in w.d e format.
o(Z, Zmat) - Static method in class Jampack.Times
Computes the product of a Z and a Zmat.
o(Zmat, Zmat) - Static method in class Jampack.Times
Computes the product of two Zmats.
o(Z, Zdiagmat) - Static method in class Jampack.Times
Computes the product of a Z and a Zdiagmat.
o(Zdiagmat, Zdiagmat) - Static method in class Jampack.Times
Computes the product of two Zdiagmats.
o(Zdiagmat, Zmat) - Static method in class Jampack.Times
Computes the product of a Zdiagmat and a Zmat.
o(Zmat, Zdiagmat) - Static method in class Jampack.Times
Computes the product of a Zmat and a Zdiagmat.
o12(Zmat, Zmat) - Static method in class Jampack.Merge
Merges its arguments to create the Zmat
o13(Zmat, Zmat, Zmat) - Static method in class Jampack.Merge
Merges its arguments to create the Zmat
o21(Zmat, Zmat) - Static method in class Jampack.Merge
Merges its arguments to create the Zmat
o22(Zmat, Zmat, Zmat, Zmat) - Static method in class Jampack.Merge
Merges its arguments to create the matrix
o23(Zmat, Zmat, Zmat, Zmat, Zmat, Zmat) - Static method in class Jampack.Merge
Merges its arguments to create the Zmat
o31(Zmat, Zmat, Zmat) - Static method in class Jampack.Merge
Merges its arguments to create the Zmat
o32(Zmat, Zmat, Zmat, Zmat, Zmat, Zmat) - Static method in class Jampack.Merge
Merges its arguments to create the Zmat
o33(Zmat, Zmat, Zmat, Zmat, Zmat, Zmat, Zmat, Zmat, Zmat) - Static method in class Jampack.Merge
Merges its arguments to create the Zmat
OBJECT - Variable in class graph.LoadData
Flag used to specify the type of data to be loaded.
ObjectArrayList - Class in cern.colt.list
Resizable list holding Object elements; implemented with arrays.
ObjectArrayList() - Constructor for class cern.colt.list.ObjectArrayList
Constructs an empty list.
ObjectArrayList(Object[]) - Constructor for class cern.colt.list.ObjectArrayList
Constructs a list containing the specified elements.
ObjectArrayList(int) - Constructor for class cern.colt.list.ObjectArrayList
Constructs an empty list with the specified initial capacity.
ObjectBuffer - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target ObjectBufferConsumer to which data is automatically flushed upon buffer overflow.
ObjectBuffer(ObjectBufferConsumer, int) - Constructor for class cern.colt.buffer.ObjectBuffer
Constructs and returns a new buffer with the given target.
ObjectBufferConsumer - Interface in cern.colt.buffer
Target of a streaming ObjectBuffer into which data is flushed upon buffer overflow.
ObjectComparator - Class in hep.lcio.util
Object comparison code refactored out of tonyj's old hep.lcio.test.RandomEvent .
ObjectComparator() - Constructor for class hep.lcio.util.ObjectComparator
 
ObjectFactory1D - Class in cern.colt.matrix
Factory for convenient construction of 1-d matrices holding Object cells.
ObjectFactory2D - Class in cern.colt.matrix
Factory for convenient construction of 2-d matrices holding Object cells.
ObjectFactory3D - Class in cern.colt.matrix
Factory for convenient construction of 3-d matrices holding Object cells.
ObjectFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes a single argument and returns a single value.
ObjectiveFunction - Class in org.apache.commons.math3.optim.nonlinear.scalar
Scalar function to be optimized.
ObjectiveFunction(MultivariateFunction) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.ObjectiveFunction
 
ObjectiveFunctionGradient - Class in org.apache.commons.math3.optim.nonlinear.scalar
Gradient of the scalar function to be optimized.
ObjectiveFunctionGradient(MultivariateVectorFunction) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.ObjectiveFunctionGradient
 
ObjectListAdapter - Class in cern.colt.list.adapter
Adapter that permits an ObjectArrayList to be viewed and treated as a JDK 1.2 AbstractList.
ObjectListAdapter(ObjectArrayList) - Constructor for class cern.colt.list.adapter.ObjectListAdapter
Constructs a list backed by the specified content list.
ObjectMatrix1D - Class in cern.colt.matrix
Abstract base class for 1-d matrices (aka vectors) holding Object elements.
ObjectMatrix1DComparator - Interface in cern.colt.matrix.objectalgo
A comparison function which imposes a total ordering on some collection of elements.
ObjectMatrix1DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
ObjectMatrix2D - Class in cern.colt.matrix
Abstract base class for 2-d matrices holding Object elements.
ObjectMatrix2DComparator - Interface in cern.colt.matrix.objectalgo
A comparison function which imposes a total ordering on some collection of elements.
ObjectMatrix2DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
ObjectMatrix3D - Class in cern.colt.matrix
Abstract base class for 3-d matrices holding Object elements.
ObjectMatrix3DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
ObjectObjectFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes two arguments and returns a single value.
ObjectProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
oblateness() - Method in class hep.physics.jet.EventShape
Oblateness = Major Thrust - Minor Thrust
ObservableInputStream - Class in org.apache.commons.io.input
The ObservableInputStream allows, that an InputStream may be consumed by other receivers, apart from the thread, which is reading it.
ObservableInputStream(InputStream) - Constructor for class org.apache.commons.io.input.ObservableInputStream
Creates a new ObservableInputStream for the given InputStream.
ObservableInputStream.Observer - Class in org.apache.commons.io.input
Abstracts observer callback for ObservableInputStreams.
Observer() - Constructor for class org.apache.commons.io.input.ObservableInputStream.Observer
 
ObserverConsole - Class in org.lsmp.djepExamples
 
ObserverConsole() - Constructor for class org.lsmp.djepExamples.ObserverConsole
 
OCTAVE_FORMAT - Static variable in class org.apache.commons.math3.linear.MatrixUtils
A format for RealMatrix objects compatible with octave.
ODEIntegrator - Interface in org.apache.commons.math3.ode
This interface defines the common parts shared by integrators for first and second order differential equations.
offset() - Method in class cern.hep.aida.bin.AbstractBin
Returns offset(0).
offset(int) - Method in class cern.hep.aida.bin.AbstractBin
Returns the relative or absolute position for the center of the bin; override this method if necessary.
offset() - Method in class org.jlab.groot.data.H2F
 
offsetFromNewest(int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Returns the actual index to a time offset by "delta" from newestAt.
offsetFromOldest(int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
??
OHLC - Class in org.jfree.data.time.ohlc
A data record containing open-high-low-close data (immutable).
OHLC(double, double, double, double) - Constructor for class org.jfree.data.time.ohlc.OHLC
Creates a new instance of OHLC.
OHLCDataItem - Class in org.jfree.data.xy
Represents a single (open-high-low-close) data item in an DefaultOHLCDataset.
OHLCDataItem(Date, double, double, double, double, double) - Constructor for class org.jfree.data.xy.OHLCDataItem
Creates a new item.
OHLCDataset - Interface in org.jfree.data.xy
An interface that defines data in the form of (x, high, low, open, close) tuples.
OHLCItem - Class in org.jfree.data.time.ohlc
An item representing data in the form (time-period, open, high, low, close).
OHLCItem(RegularTimePeriod, double, double, double, double) - Constructor for class org.jfree.data.time.ohlc.OHLCItem
Creates a new instance of OHLCItem.
OHLCSeries - Class in org.jfree.data.time.ohlc
A list of (RegularTimePeriod, open, high, low, close) data items.
OHLCSeries(Comparable) - Constructor for class org.jfree.data.time.ohlc.OHLCSeries
Creates a new empty series.
OHLCSeriesCollection - Class in org.jfree.data.time.ohlc
A collection of OHLCSeries objects.
OHLCSeriesCollection() - Constructor for class org.jfree.data.time.ohlc.OHLCSeriesCollection
Creates a new instance of OHLCSeriesCollection.
ohm - Static variable in class cern.clhep.Units
 
OLSMultipleLinearRegression - Class in org.apache.commons.math3.stat.regression
Implements ordinary least squares (OLS) to estimate the parameters of a multiple linear regression model.
OLSMultipleLinearRegression() - Constructor for class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Create an empty OLSMultipleLinearRegression instance.
OLSMultipleLinearRegression(double) - Constructor for class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Create an empty OLSMultipleLinearRegression instance, using the given singularity threshold for the QR decomposition.
onDirectoryChange(File) - Method in interface org.apache.commons.io.monitor.FileAlterationListener
Directory changed Event.
onDirectoryChange(File) - Method in class org.apache.commons.io.monitor.FileAlterationListenerAdaptor
Directory changed Event.
onDirectoryCreate(File) - Method in interface org.apache.commons.io.monitor.FileAlterationListener
Directory created Event.
onDirectoryCreate(File) - Method in class org.apache.commons.io.monitor.FileAlterationListenerAdaptor
Directory created Event.
onDirectoryDelete(File) - Method in interface org.apache.commons.io.monitor.FileAlterationListener
Directory deleted Event.
onDirectoryDelete(File) - Method in class org.apache.commons.io.monitor.FileAlterationListenerAdaptor
Directory deleted Event.
ONE - Static variable in class Jampack.Z
Complex 1.
one(int, int) - Static method in class jhplot.math.DoubleArray
Deprecated.
use fill(int m, int n, 1.0) instead.
one(int, int, double) - Static method in class jhplot.math.DoubleArray
Deprecated.
use fill(int m, int n, double c) instead.
one(int) - Static method in class jhplot.math.DoubleArray
Deprecated.
use fill(int m, double c) instead.
one(int, double) - Static method in class jhplot.math.DoubleArray
Deprecated.
Use fill(int m, double c) instead.
ONE - Static variable in class org.apache.commons.math3.complex.Complex
A complex number representing "1.0 + 0.0i"
ONE - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "1".
ONE - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "1".
ONE - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Unit (coordinates: 1).
ONE - Static variable in class org.apache.commons.math3.util.BigReal
A big real representing 1.
ONE - Static variable in class org.apache.commons.math3.util.Decimal64
The constant value of 1d as a Decimal64.
ONE - Static variable in class org.lsmp.djep.vectorJep.Dimensions
 
ONE - Static variable in class org.nfunk.jep.type.DoubleNumberFactory
 
ONE_EB - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in an exabyte.
ONE_EB_BI - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in an exabyte.
ONE_FIFTH - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "1/5".
ONE_FIFTH - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "1/5".
ONE_GB - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a gigabyte.
ONE_GB_BI - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a gigabyte.
ONE_HALF - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "1/2".
ONE_HALF - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "1/2".
ONE_KB - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a kilobyte.
ONE_KB_BI - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a kilobyte.
ONE_MB - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a megabyte.
ONE_MB_BI - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a megabyte.
ONE_PB - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a petabyte.
ONE_PB_BI - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a petabyte.
ONE_QUARTER - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "1/4".
ONE_QUARTER - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "1/4".
ONE_TB - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a terabyte.
ONE_TB_BI - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a terabyte.
ONE_THIRD - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "1/3".
ONE_THIRD - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "1/3".
ONE_YB - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a yottabyte.
ONE_ZB - Static variable in class org.apache.commons.io.FileUtils
The number of bytes in a zettabyte.
oneDarray(int) - Method in class jhplot.math.ValueErr
Create a one dimensional array of ValueErr objects of length n.
oneDarray(int, ValueErr) - Method in class jhplot.math.ValueErr
Create a one dimensional array of ValueErr objects of length n and m
OnePointCrossover<T> - Class in org.apache.commons.math3.genetics
One point crossover policy.
OnePointCrossover() - Constructor for class org.apache.commons.math3.genetics.OnePointCrossover
 
OneWayAnova - Class in org.apache.commons.math3.stat.inference
Implements one-way ANOVA (analysis of variance) statistics.
OneWayAnova() - Constructor for class org.apache.commons.math3.stat.inference.OneWayAnova
Default constructor.
oneWayAnovaFValue(Collection<double[]>) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
oneWayAnovaPValue(Collection<double[]>) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
oneWayAnovaTest(Collection<double[]>, double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
onFileChange(File) - Method in interface org.apache.commons.io.monitor.FileAlterationListener
File changed Event.
onFileChange(File) - Method in class org.apache.commons.io.monitor.FileAlterationListenerAdaptor
File changed Event.
onFileCreate(File) - Method in interface org.apache.commons.io.monitor.FileAlterationListener
File created Event.
onFileCreate(File) - Method in class org.apache.commons.io.monitor.FileAlterationListenerAdaptor
File created Event.
onFileDelete(File) - Method in interface org.apache.commons.io.monitor.FileAlterationListener
File deleted Event.
onFileDelete(File) - Method in class org.apache.commons.io.monitor.FileAlterationListenerAdaptor
File deleted Event.
onStart(FileAlterationObserver) - Method in interface org.apache.commons.io.monitor.FileAlterationListener
File system observer started checking event.
onStart(FileAlterationObserver) - Method in class org.apache.commons.io.monitor.FileAlterationListenerAdaptor
File system observer started checking event.
onStop(FileAlterationObserver) - Method in interface org.apache.commons.io.monitor.FileAlterationListener
File system observer finished checking event.
onStop(FileAlterationObserver) - Method in class org.apache.commons.io.monitor.FileAlterationListenerAdaptor
File system observer finished checking event.
oof - Variable in class jhplot.io.HFileXML
 
oops(Frame, String) - Static method in class jplot.Utils
Oops message.
oos - Variable in class jhplot.io.HFileXML
 
OPAQUE - Static variable in class jplot3d.ColorModel
 
open(String) - Method in interface hep.lcio.io.LCReader
Opens a file for reading (read-only).
open(String[]) - Method in interface hep.lcio.io.LCReader
Opens a list of files for reading (read-only).
open(String) - Method in interface hep.lcio.io.LCWriter
Opens a file for writing.
open(String, int) - Method in interface hep.lcio.io.LCWriter
Opens a file for writing.
open() - Method in class hep.lcio.util.MergeFileParameters
Open the LCReader.
OpeN - Static variable in interface jminhep.gui.Constants
 
open(String) - Method in class jplot.XMLRead
Opens a specific context for finding elements.
open(String) - Method in class jplot.XMLWrite
Adds an opening tag to a string(buffer).
open() - Method in class jplot.XMLWrite
Shifts the text an indent to the right (open a new field).
openASCIIFile(String) - Method in class org.jlab.groot.studio.StudioUI
 
openDataFileChooser(Component) - Static method in class jhplot.gui.CommonGUI
File chooser to read data files.
OpenDoubleIntHashMap - Class in cern.colt.map
Hash map holding (key,value) associations of type (double-->int); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenDoubleIntHashMap() - Constructor for class cern.colt.map.OpenDoubleIntHashMap
Constructs an empty map with default capacity and default load factors.
OpenDoubleIntHashMap(int) - Constructor for class cern.colt.map.OpenDoubleIntHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenDoubleIntHashMap(int, double, double) - Constructor for class cern.colt.map.OpenDoubleIntHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
openFile(String) - Method in class hep.lcio.util.LCIOConcat
 
openFile() - Method in class jplot.SimpleEditor
Saves the text after an edit to a new file.
openFile(String) - Method in class org.jlab.groot.io.TextFileReader
Open a text file for reading.
openFile(String) - Method in class org.jlab.groot.matrix.GridStudio
 
openFile(String) - Method in class org.jlab.groot.tree.TreeFile
 
openFile() - Method in class org.jlab.groot.tree.TreeTextFile
 
openHipoFile(String) - Method in class org.jlab.groot.studio.StudioUI
 
openImageFileChooser(Component) - Static method in class jhplot.gui.CommonGUI
File chooser images.
openInputStream(File) - Static method in class org.apache.commons.io.FileUtils
Opens a FileInputStream for the specified file, providing better error messages than simply calling new FileInputStream(file).
OpenIntDoubleHashMap - Class in cern.colt.map
Hash map holding (key,value) associations of type (int-->double); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenIntDoubleHashMap() - Constructor for class cern.colt.map.OpenIntDoubleHashMap
Constructs an empty map with default capacity and default load factors.
OpenIntDoubleHashMap(int) - Constructor for class cern.colt.map.OpenIntDoubleHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenIntDoubleHashMap(int, double, double) - Constructor for class cern.colt.map.OpenIntDoubleHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntIntHashMap - Class in cern.colt.map
Hash map holding (key,value) associations of type (int-->int); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenIntIntHashMap() - Constructor for class cern.colt.map.OpenIntIntHashMap
Constructs an empty map with default capacity and default load factors.
OpenIntIntHashMap(int) - Constructor for class cern.colt.map.OpenIntIntHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenIntIntHashMap(int, double, double) - Constructor for class cern.colt.map.OpenIntIntHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntObjectHashMap - Class in cern.colt.map
Hash map holding (key,value) associations of type (int-->Object); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenIntObjectHashMap() - Constructor for class cern.colt.map.OpenIntObjectHashMap
Constructs an empty map with default capacity and default load factors.
OpenIntObjectHashMap(int) - Constructor for class cern.colt.map.OpenIntObjectHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenIntObjectHashMap(int, double, double) - Constructor for class cern.colt.map.OpenIntObjectHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntToDoubleHashMap - Class in org.apache.commons.math3.util
Open addressed map from int to double.
OpenIntToDoubleHashMap() - Constructor for class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Build an empty map with default size and using NaN for missing entries.
OpenIntToDoubleHashMap(double) - Constructor for class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Build an empty map with default size
OpenIntToDoubleHashMap(int) - Constructor for class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Build an empty map with specified size and using NaN for missing entries.
OpenIntToDoubleHashMap(int, double) - Constructor for class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Build an empty map with specified size.
OpenIntToDoubleHashMap(OpenIntToDoubleHashMap) - Constructor for class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Copy constructor.
OpenIntToDoubleHashMap.Iterator - Class in org.apache.commons.math3.util
Iterator class for the map.
OpenIntToFieldHashMap<T extends FieldElement<T>> - Class in org.apache.commons.math3.util
Open addressed map from int to FieldElement.
OpenIntToFieldHashMap(Field<T>) - Constructor for class org.apache.commons.math3.util.OpenIntToFieldHashMap
Build an empty map with default size and using zero for missing entries.
OpenIntToFieldHashMap(Field<T>, T) - Constructor for class org.apache.commons.math3.util.OpenIntToFieldHashMap
Build an empty map with default size
OpenIntToFieldHashMap(Field<T>, int) - Constructor for class org.apache.commons.math3.util.OpenIntToFieldHashMap
Build an empty map with specified size and using zero for missing entries.
OpenIntToFieldHashMap(Field<T>, int, T) - Constructor for class org.apache.commons.math3.util.OpenIntToFieldHashMap
Build an empty map with specified size.
OpenIntToFieldHashMap(OpenIntToFieldHashMap<T>) - Constructor for class org.apache.commons.math3.util.OpenIntToFieldHashMap
Copy constructor.
OpenIntToFieldHashMap.Iterator - Class in org.apache.commons.math3.util
Iterator class for the map.
OpenLongObjectHashMap - Class in cern.colt.map
Hash map holding (key,value) associations of type (long-->Object); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenLongObjectHashMap() - Constructor for class cern.colt.map.OpenLongObjectHashMap
Constructs an empty map with default capacity and default load factors.
OpenLongObjectHashMap(int) - Constructor for class cern.colt.map.OpenLongObjectHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenLongObjectHashMap(int, double, double) - Constructor for class cern.colt.map.OpenLongObjectHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenMapRealMatrix - Class in org.apache.commons.math3.linear
Sparse matrix implementation based on an open addressed map.
OpenMapRealMatrix(int, int) - Constructor for class org.apache.commons.math3.linear.OpenMapRealMatrix
Build a sparse matrix with the supplied row and column dimensions.
OpenMapRealMatrix(OpenMapRealMatrix) - Constructor for class org.apache.commons.math3.linear.OpenMapRealMatrix
Build a matrix by copying another one.
OpenMapRealVector - Class in org.apache.commons.math3.linear
This class implements the RealVector interface with a OpenIntToDoubleHashMap backing store.
OpenMapRealVector() - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Build a 0-length vector.
OpenMapRealVector(int) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Construct a vector of zeroes.
OpenMapRealVector(int, double) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Construct a vector of zeroes, specifying zero tolerance.
OpenMapRealVector(int, int) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Build a vector with known the sparseness (for advanced use only).
OpenMapRealVector(int, int, double) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Build a vector with known the sparseness and zero tolerance setting (for advanced use only).
OpenMapRealVector(double[]) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Create from an array.
OpenMapRealVector(double[], double) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Create from an array, specifying zero tolerance.
OpenMapRealVector(Double[]) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Create from an array.
OpenMapRealVector(Double[], double) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Create from an array.
OpenMapRealVector(OpenMapRealVector) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Copy constructor.
OpenMapRealVector(RealVector) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Generic copy constructor.
openOutputStream(File) - Static method in class org.apache.commons.io.FileUtils
Opens a FileOutputStream for the specified file, checking and creating the parent directory if it does not exist.
openOutputStream(File, boolean) - Static method in class org.apache.commons.io.FileUtils
Opens a FileOutputStream for the specified file, checking and creating the parent directory if it does not exist.
openWriter(String) - Method in class hep.lcio.util.LCIOConcat
 
oper(H1D, String) - Method in class jhplot.H1D
Various manipulations with histograms (+,-,*,/).
oper(H1D, String, String) - Method in class jhplot.H1D
Various manipulations with histograms (+,-,*,/).
oper(H2D, String, String) - Method in class jhplot.H2D
Various manipulations with histograms (+,-,*,/).
oper(P0D, String) - Method in class jhplot.P0D
Operations on P0D containers: add, subtract, multiply, divide.
oper(P0D, String, String) - Method in class jhplot.P0D
Operations on P0D containers: add, subtract, multiply, divide.
oper(P0I, String) - Method in class jhplot.P0I
Operations on P0I containers: add, subtract, multiply, divide.
oper(P0I, String, String) - Method in class jhplot.P0I
Operations on P0I containers: add, subtract, multiply, divide.
oper(P1D, String) - Method in class jhplot.P1D
Operations on P1D container: add, subtract, multiply, divide.
oper(P1D, String, String) - Method in class jhplot.P1D
Operations on P1D containers: add, subtract, multiply, divide.
oper(P1D, String, String, String, P1D) - Method in class jhplot.P1D
Operations on P1D containers: add, subtract, multiply, divide.
oper(PND, String) - Method in class jhplot.PND
Operations on PND containers: add, subtract, multiply, divide.
oper(PND, String, String) - Method in class jhplot.PND
Operations on PND containers: add, subtract, multiply, divide.
oper(PNI, String) - Method in class jhplot.PNI
Operations on PNI containers: add, subtract, multiply, divide.
oper(PNI, String, String) - Method in class jhplot.PNI
Operations on PNI containers: add, subtract, multiply, divide.
operate(T[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the result of multiplying this by the vector v.
operate(FieldVector<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of multiplying this by the vector v.
operate(RealVector) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of multiplying this by the vector x.
operate(T[]) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns the result of multiplying this by the vector v.
operate(T[]) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the result of multiplying this by the vector v.
operate(T[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the result of multiplying this by the vector v.
operate(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the result of multiplying this by the vector v.
operate(RealVector) - Method in class org.apache.commons.math3.linear.JacobiPreconditioner
Returns the result of multiplying this by the vector x.
operate(RealVector) - Method in class org.apache.commons.math3.linear.RealLinearOperator
Returns the result of multiplying this by the vector x.
operate(double[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of multiplying this by the vector v.
operate(RealVector) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of multiplying this by the vector v.
operateTranspose(RealVector) - Method in class org.apache.commons.math3.linear.RealLinearOperator
Returns the result of multiplying the transpose of this operator by the vector x (optional operation).
operator(Operator) - Method in class jhplot.math.exp4j.ExpressionBuilder
Add an Operator which should be available for use in the expression
operator(Operator...) - Method in class jhplot.math.exp4j.ExpressionBuilder
Add multiple Operator implementations which should be available for use in the expression
operator(List<Operator>) - Method in class jhplot.math.exp4j.ExpressionBuilder
Add multiple Operator implementations which should be available for use in the expression
Operator - Class in jhplot.math.exp4j.operator
Class representing operators that can be used in an expression
Operator(String, int, boolean, int) - Constructor for class jhplot.math.exp4j.operator.Operator
Create a new operator for use in expressions
OPERATOR - Static variable in class org.apache.commons.math3.linear.ConjugateGradient
Key for the exception context.
Operator - Class in org.nfunk.jep
A class containing information about an operator.
Operator(String, PostfixMathCommandI) - Constructor for class org.nfunk.jep.Operator
construct a new operator.
Operator(String, String, PostfixMathCommandI) - Constructor for class org.nfunk.jep.Operator
construct a new operator, with a different name and symbol
Operators - Class in jhplot.math.exp4j.operator
 
Operators() - Constructor for class jhplot.math.exp4j.operator.Operators
 
OperatorSet - Class in org.nfunk.jep
The standard set of operators used in JEP.
OperatorSet() - Constructor for class org.nfunk.jep.OperatorSet
 
OperatorToken - Class in jhplot.math.exp4j.tokenizer
Represents an operator used in expressions
OperatorToken(Operator) - Constructor for class jhplot.math.exp4j.tokenizer.OperatorToken
Create a new instance
operErrSys(String, int, P1D, P1D) - Method in class jhplot.P1D
Obtain a new P1D with 2nd-level errors on X or Y obtained from two P1D objects, one represents left on X (or lower on Y) error and the other represents the right on X (or upper on Y) error.
operPlusY(P1D) - Method in class jhplot.P1D
Add all Y-values from another P1D.
operScale(String, double) - Method in class jhplot.H1D
Scale the histogram and return scaled object.
operScale(String, double) - Method in class jhplot.H2D
Scale the histogram and return scaled object.
operScale(double) - Method in class jhplot.P0D
Scale P0D with a factor scale.
operScale(double) - Method in class jhplot.P0I
Scale P0I with a factor scale.
operScale(int, double) - Method in class jhplot.P1D
Scale X-values (axis=0) or Y values (axis=1) and their errors with a scale factor.
operScale(double) - Method in class jhplot.PND
Scale each element of data
operScale(double) - Method in class jhplot.PNI
Scale each element of data
operScaleErr(int, double) - Method in class jhplot.P1D
Scale 1st level errors with a scale factor.
operScaleErrSys(int, double) - Method in class jhplot.P1D
Scale 2nd level errors with a scale factor.
operShift(double) - Method in class jhplot.P0D
Shift all values in the array by a constant.
operShift(double) - Method in class jhplot.P0I
Shift all values in the array by a constant.
operShiftAndScale(double, double) - Method in class jhplot.P0D
Shift all values by a constant "shift", then scale it.
operShiftAndScale(double, double) - Method in class jhplot.P0I
Shift all values by a constant "shift", then scale it.
operSmooth(boolean, int) - Method in class jhplot.H1D
Smooth the histogram.
operSmooth(boolean, int) - Method in class jhplot.HProf1D
Smooth the histogram.
operSmooth(int, boolean, int) - Method in class jhplot.P1D
Smooth P1D data points in either X or Y.
operSmoothGauss(double) - Method in class jhplot.H1D
Computes a Gaussian smoothed version of the histogram.
operSmoothGauss(double) - Method in class jhplot.HProf1D
Computes a Gaussian smoothed version of the histogram.
operSmoothGauss(int, double) - Method in class jhplot.P1D
Computes a Gaussian smoothed version of P1D.
oppositeRelationship() - Method in enum org.apache.commons.math3.optim.linear.Relationship
Gets the relationship obtained when multiplying all coefficients by -1.
oppositeRelationship() - Method in enum org.apache.commons.math3.optimization.linear.Relationship
Deprecated.
Get the relationship obtained when multiplying all coefficients by -1.
OptimizationData - Interface in org.apache.commons.math3.optim
Marker interface.
OptimizationData - Interface in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
OptimizationProblem<PAIR> - Interface in org.apache.commons.math3.optim
Common settings for all optimization problems.
optimize(LeastSquaresProblem) - Method in class org.apache.commons.math3.fitting.leastsquares.GaussNewtonOptimizer
Solve the non-linear least squares problem.
optimize(LeastSquaresProblem) - Method in interface org.apache.commons.math3.fitting.leastsquares.LeastSquaresOptimizer
Solve the non-linear least squares problem.
optimize(LeastSquaresProblem) - Method in class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
Solve the non-linear least squares problem.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.BaseMultiStartMultivariateOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.BaseMultivariateOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.BaseOptimizer
Stores data and performs the optimization.
optimize() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.linear.LinearOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.linear.SimplexSolver
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.GradientMultivariateOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.SimplexOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Deprecated.
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.vector.JacobianMultivariateVectorOptimizer
Deprecated.
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultivariateVectorOptimizer
Deprecated.
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.univariate.MultiStartUnivariateOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
Stores data and performs the optimization.
optimize(int, FUNC, GoalType, double[]) - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
Deprecated.
Optimize an objective function.
optimize(int, FUNC, GoalType, double[]) - Method in interface org.apache.commons.math3.optimization.BaseMultivariateOptimizer
Deprecated.
As of 3.1. In 4.0, it will be replaced by the declaration corresponding to this method.
optimize(int, FUNC, GoalType, double[], double[], double[]) - Method in interface org.apache.commons.math3.optimization.BaseMultivariateSimpleBoundsOptimizer
Deprecated.
Optimize an objective function.
optimize(int, FUNC, double[], double[], double[]) - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
Deprecated.
Optimize an objective function.
optimize(int, FUNC, double[], double[], double[]) - Method in interface org.apache.commons.math3.optimization.BaseMultivariateVectorOptimizer
Deprecated.
As of 3.1. In 4.0, this will be replaced by the declaration corresponding to this method.
optimize(int, FUNC, GoalType, double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
optimize(int, FUNC, GoalType, OptimizationData...) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.
Optimize an objective function.
optimize(int, FUNC, GoalType, double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateSimpleBoundsOptimizer
Deprecated.
Optimize an objective function.
optimize(int, FUNC, GoalType, double[], double[], double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateSimpleBoundsOptimizer
Deprecated.
Optimize an objective function.
optimize(int, FUNC, double[], double[], double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
optimize(int, DifferentiableMultivariateVectorFunction, double[], double[], double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
optimize(int, MultivariateDifferentiableVectorFunction, double[], double[], double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
optimize(int, MultivariateDifferentiableFunction, GoalType, double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractScalarDifferentiableOptimizer
Deprecated.
Optimize an objective function.
optimize(LinearObjectiveFunction, Collection<LinearConstraint>, GoalType, boolean) - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated.
Optimizes an objective function.
optimize(LinearObjectiveFunction, Collection<LinearConstraint>, GoalType, boolean) - Method in interface org.apache.commons.math3.optimization.linear.LinearOptimizer
Deprecated.
Optimizes an objective function.
optimize(int, UnivariateFunction, GoalType, double, double, double) - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.
Find an optimum in the given interval, start at startValue.
optimize(int, UnivariateFunction, GoalType, double, double) - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.
Find an optimum in the given interval.
optimize(int, FUNC, GoalType, double, double) - Method in interface org.apache.commons.math3.optimization.univariate.BaseUnivariateOptimizer
Deprecated.
Find an optimum in the given interval.
optimize(int, FUNC, GoalType, double, double, double) - Method in interface org.apache.commons.math3.optimization.univariate.BaseUnivariateOptimizer
Deprecated.
Find an optimum in the given interval, start at startValue.
optimize(int, FUNC, GoalType, double, double) - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated.
Find an optimum in the given interval.
optimize(int, FUNC, GoalType, double, double, double) - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated.
Find an optimum in the given interval, start at startValue.
Options - Class in jhepsim
Static singleton class to provide and persistently store program options.
Options() - Constructor for class jhepsim.Options
 
OptionsDialog - Class in jplot3d
 
OptionsDialog(JSurfacePanel) - Constructor for class jplot3d.OptionsDialog
 
OptionsPanel - Class in org.jlab.groot.ui
 
OptionsPanel(EmbeddedCanvas, int) - Constructor for class org.jlab.groot.ui.OptionsPanel
 
optStat - Variable in class org.jlab.groot.base.DatasetAttributes
 
or(BitMatrix) - Method in class cern.colt.bitvector.BitMatrix
Performs a logical OR of the receiver with another bit matrix.
or(BitVector) - Method in class cern.colt.bitvector.BitVector
Performs a logical OR of the receiver with another bit vector (A = A | B).
or - Static variable in class cern.jet.math.IntFunctions
Function that returns a | b.
or(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a | b.
or(IOFileFilter...) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that ORs the specified filters.
OR - Static variable in class org.lsmp.djep.rpe.RpEval
 
OR - Static variable in class org.nfunk.jep.function.Logical
 
OR - Static variable in interface org.nfunk.jep.ParserConstants
 
OrderedCrossover<T> - Class in org.apache.commons.math3.genetics
Order 1 Crossover [OX1] builds offspring from ordered chromosomes by copying a consecutive slice from one parent, and filling up the remaining genes from the other parent as they appear.
OrderedCrossover() - Constructor for class org.apache.commons.math3.genetics.OrderedCrossover
 
OrderedSetI - Interface in org.lsmp.djep.groupJep.interfaces
Groups which have a total ordering, i.e <, >= make sense.
OrderedTuple - Class in org.apache.commons.math3.geometry.partitioning.utilities
Deprecated.
as of 3.4, this class is not used anymore and considered to be out of scope of Apache Commons Math
OrderedTuple(double...) - Constructor for class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
Deprecated.
Build an ordered T-uple from its components.
OrExpression() - Method in class org.nfunk.jep.Parser
 
orFileFilter(IOFileFilter, IOFileFilter) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
OrFileFilter - Class in org.apache.commons.io.filefilter
A FileFilter providing conditional OR logic across a list of file filters.
OrFileFilter() - Constructor for class org.apache.commons.io.filefilter.OrFileFilter
Constructs a new instance of OrFileFilter.
OrFileFilter(List<IOFileFilter>) - Constructor for class org.apache.commons.io.filefilter.OrFileFilter
Constructs a new instance of OrFileFilter with the specified filters.
OrFileFilter(IOFileFilter, IOFileFilter) - Constructor for class org.apache.commons.io.filefilter.OrFileFilter
Constructs a new file filter that ORs the result of two other filters.
org.apache.commons.io - package org.apache.commons.io
This package defines utility classes for working with streams, readers, writers and files.
org.apache.commons.io.comparator - package org.apache.commons.io.comparator
This package provides various Comparator implementations for Files.
org.apache.commons.io.file - package org.apache.commons.io.file
This package provides extensions in the realm of java.nio.file.
org.apache.commons.io.filefilter - package org.apache.commons.io.filefilter
This package defines an interface (IOFileFilter) that combines both FileFilter and FilenameFilter.
org.apache.commons.io.function - package org.apache.commons.io.function
This package defines IO-only related functional interfaces for lambda expressions and method references.
org.apache.commons.io.input - package org.apache.commons.io.input
This package provides implementations of input classes, such as InputStream and Reader.
org.apache.commons.io.input.buffer - package org.apache.commons.io.input.buffer
This package provides implementations of buffered input classes, such as CircularBufferInputStream and PeekableInputStream.
org.apache.commons.io.monitor - package org.apache.commons.io.monitor
This package provides a component for monitoring file system events (directory and file create, update and delete events).
org.apache.commons.io.output - package org.apache.commons.io.output
This package provides implementations of output classes, such as OutputStream and Writer.
org.apache.commons.io.serialization - package org.apache.commons.io.serialization
This package provides a framework for controlling the deserialization of classes.
org.apache.commons.math3 - package org.apache.commons.math3
Common classes used throughout the commons-math library.
org.apache.commons.math3.analysis - package org.apache.commons.math3.analysis
Parent package for common numerical analysis procedures, including root finding, function interpolation and integration.
org.apache.commons.math3.analysis.differentiation - package org.apache.commons.math3.analysis.differentiation
This package holds the main interfaces and basic building block classes dealing with differentiation.
org.apache.commons.math3.analysis.function - package org.apache.commons.math3.analysis.function
The function package contains function objects that wrap the methods contained in Math, as well as common mathematical functions such as the gaussian and sinc functions.
org.apache.commons.math3.analysis.integration - package org.apache.commons.math3.analysis.integration
Numerical integration (quadrature) algorithms for univariate real functions.
org.apache.commons.math3.analysis.integration.gauss - package org.apache.commons.math3.analysis.integration.gauss
Gauss family of quadrature schemes.
org.apache.commons.math3.analysis.interpolation - package org.apache.commons.math3.analysis.interpolation
Univariate real functions interpolation algorithms.
org.apache.commons.math3.analysis.polynomials - package org.apache.commons.math3.analysis.polynomials
Univariate real polynomials implementations, seen as differentiable univariate real functions.
org.apache.commons.math3.analysis.solvers - package org.apache.commons.math3.analysis.solvers
Root finding algorithms, for univariate real functions.
org.apache.commons.math3.complex - package org.apache.commons.math3.complex
Complex number type and implementations of complex transcendental functions.
org.apache.commons.math3.dfp - package org.apache.commons.math3.dfp
Decimal floating point library for Java
org.apache.commons.math3.distribution - package org.apache.commons.math3.distribution
Implementations of common discrete and continuous distributions.
org.apache.commons.math3.distribution.fitting - package org.apache.commons.math3.distribution.fitting
Fitting of parameters against distributions.
org.apache.commons.math3.exception - package org.apache.commons.math3.exception
Specialized exceptions for algorithms errors.
org.apache.commons.math3.exception.util - package org.apache.commons.math3.exception.util
Classes supporting exception localization.
org.apache.commons.math3.filter - package org.apache.commons.math3.filter
Implementations of common discrete-time linear filters.
org.apache.commons.math3.fitting - package org.apache.commons.math3.fitting
Classes to perform curve fitting.
org.apache.commons.math3.fitting.leastsquares - package org.apache.commons.math3.fitting.leastsquares
This package provides algorithms that minimize the residuals between observations and model values.
org.apache.commons.math3.fraction - package org.apache.commons.math3.fraction
Fraction number type and fraction number formatting.
org.apache.commons.math3.genetics - package org.apache.commons.math3.genetics
This package provides Genetic Algorithms components and implementations.
org.apache.commons.math3.geometry - package org.apache.commons.math3.geometry
This package is the top level package for geometry.
org.apache.commons.math3.geometry.enclosing - package org.apache.commons.math3.geometry.enclosing
This package provides interfaces and classes related to the smallest enclosing ball problem.
org.apache.commons.math3.geometry.euclidean.oned - package org.apache.commons.math3.geometry.euclidean.oned
This package provides basic 1D geometry components.
org.apache.commons.math3.geometry.euclidean.threed - package org.apache.commons.math3.geometry.euclidean.threed
This package provides basic 3D geometry components.
org.apache.commons.math3.geometry.euclidean.twod - package org.apache.commons.math3.geometry.euclidean.twod
This package provides basic 2D geometry components.
org.apache.commons.math3.geometry.euclidean.twod.hull - package org.apache.commons.math3.geometry.euclidean.twod.hull
This package provides algorithms to generate the convex hull for a set of points in an two-dimensional euclidean space.
org.apache.commons.math3.geometry.hull - package org.apache.commons.math3.geometry.hull
This package provides interfaces and classes related to the convex hull problem.
org.apache.commons.math3.geometry.partitioning - package org.apache.commons.math3.geometry.partitioning
This package provides classes to implement Binary Space Partition trees.
org.apache.commons.math3.geometry.partitioning.utilities - package org.apache.commons.math3.geometry.partitioning.utilities
This package provides multidimensional ordering features for partitioning.
org.apache.commons.math3.geometry.spherical.oned - package org.apache.commons.math3.geometry.spherical.oned
This package provides basic geometry components on the 1-sphere.
org.apache.commons.math3.geometry.spherical.twod - package org.apache.commons.math3.geometry.spherical.twod
This package provides basic geometry components on the 2-sphere.
org.apache.commons.math3.linear - package org.apache.commons.math3.linear
Linear algebra support.
org.apache.commons.math3.ml - package org.apache.commons.math3.ml
Base package for machine learning algorithms.
org.apache.commons.math3.ml.clustering - package org.apache.commons.math3.ml.clustering
Clustering algorithms.
org.apache.commons.math3.ml.clustering.evaluation - package org.apache.commons.math3.ml.clustering.evaluation
Cluster evaluation methods.
org.apache.commons.math3.ml.distance - package org.apache.commons.math3.ml.distance
Common distance measures.
org.apache.commons.math3.ml.neuralnet - package org.apache.commons.math3.ml.neuralnet
Neural networks.
org.apache.commons.math3.ml.neuralnet.oned - package org.apache.commons.math3.ml.neuralnet.oned
One-dimensional neural networks.
org.apache.commons.math3.ml.neuralnet.sofm - package org.apache.commons.math3.ml.neuralnet.sofm
Self Organizing Feature Map.
org.apache.commons.math3.ml.neuralnet.sofm.util - package org.apache.commons.math3.ml.neuralnet.sofm.util
Miscellaneous utilities.
org.apache.commons.math3.ml.neuralnet.twod - package org.apache.commons.math3.ml.neuralnet.twod
Two-dimensional neural networks.
org.apache.commons.math3.ml.neuralnet.twod.util - package org.apache.commons.math3.ml.neuralnet.twod.util
Utilities to visualize two-dimensional neural networks.
org.apache.commons.math3.ode - package org.apache.commons.math3.ode
This package provides classes to solve Ordinary Differential Equations problems.
org.apache.commons.math3.ode.events - package org.apache.commons.math3.ode.events
This package provides classes to handle discrete events occurring during Ordinary Differential Equations integration.
org.apache.commons.math3.ode.nonstiff - package org.apache.commons.math3.ode.nonstiff
This package provides classes to solve non-stiff Ordinary Differential Equations problems.
org.apache.commons.math3.ode.sampling - package org.apache.commons.math3.ode.sampling
This package provides classes to handle sampling steps during Ordinary Differential Equations integration.
org.apache.commons.math3.optim - package org.apache.commons.math3.optim
Generally, optimizers are algorithms that will either minimize or maximize a scalar function, called the objective function.
org.apache.commons.math3.optim.linear - package org.apache.commons.math3.optim.linear
Optimization algorithms for linear constrained problems.
org.apache.commons.math3.optim.nonlinear.scalar - package org.apache.commons.math3.optim.nonlinear.scalar
Algorithms for optimizing a scalar function.
org.apache.commons.math3.optim.nonlinear.scalar.gradient - package org.apache.commons.math3.optim.nonlinear.scalar.gradient
This package provides optimization algorithms that require derivatives.
org.apache.commons.math3.optim.nonlinear.scalar.noderiv - package org.apache.commons.math3.optim.nonlinear.scalar.noderiv
This package provides optimization algorithms that do not require derivatives.
org.apache.commons.math3.optim.nonlinear.vector - package org.apache.commons.math3.optim.nonlinear.vector
Algorithms for optimizing a vector function.
org.apache.commons.math3.optim.nonlinear.vector.jacobian - package org.apache.commons.math3.optim.nonlinear.vector.jacobian
This package provides optimization algorithms that require derivatives.
org.apache.commons.math3.optim.univariate - package org.apache.commons.math3.optim.univariate
One-dimensional optimization algorithms.
org.apache.commons.math3.optimization - package org.apache.commons.math3.optimization
All classes and sub-packages of this package are deprecated.
org.apache.commons.math3.optimization.direct - package org.apache.commons.math3.optimization.direct
This package provides optimization algorithms that don't require derivatives.
org.apache.commons.math3.optimization.fitting - package org.apache.commons.math3.optimization.fitting
This package provides classes to perform curve fitting.
org.apache.commons.math3.optimization.general - package org.apache.commons.math3.optimization.general
This package provides optimization algorithms that require derivatives.
org.apache.commons.math3.optimization.linear - package org.apache.commons.math3.optimization.linear
This package provides optimization algorithms for linear constrained problems.
org.apache.commons.math3.optimization.univariate - package org.apache.commons.math3.optimization.univariate
Univariate real functions minimum finding algorithms.
org.apache.commons.math3.primes - package org.apache.commons.math3.primes
Methods related to prime numbers like primality test, factor decomposition.
org.apache.commons.math3.random - package org.apache.commons.math3.random
Random number and random data generators.
org.apache.commons.math3.special - package org.apache.commons.math3.special
Implementations of special functions such as Beta and Gamma.
org.apache.commons.math3.stat - package org.apache.commons.math3.stat
Data storage, manipulation and summary routines.
org.apache.commons.math3.stat.clustering - package org.apache.commons.math3.stat.clustering
All classes and sub-packages of this package are deprecated.
org.apache.commons.math3.stat.correlation - package org.apache.commons.math3.stat.correlation
Correlations/Covariance computations.
org.apache.commons.math3.stat.descriptive - package org.apache.commons.math3.stat.descriptive
Generic univariate summary statistic objects.
org.apache.commons.math3.stat.descriptive.moment - package org.apache.commons.math3.stat.descriptive.moment
Summary statistics based on moments.
org.apache.commons.math3.stat.descriptive.rank - package org.apache.commons.math3.stat.descriptive.rank
Summary statistics based on ranks.
org.apache.commons.math3.stat.descriptive.summary - package org.apache.commons.math3.stat.descriptive.summary
Other summary statistics.
org.apache.commons.math3.stat.inference - package org.apache.commons.math3.stat.inference
Classes providing hypothesis testing.
org.apache.commons.math3.stat.interval - package org.apache.commons.math3.stat.interval
Classes providing binomial proportion confidence interval construction.
org.apache.commons.math3.stat.ranking - package org.apache.commons.math3.stat.ranking
Classes providing rank transformations.
org.apache.commons.math3.stat.regression - package org.apache.commons.math3.stat.regression
Statistical routines involving multivariate data.
org.apache.commons.math3.transform - package org.apache.commons.math3.transform
Implementations of transform methods, including Fast Fourier transforms.
org.apache.commons.math3.util - package org.apache.commons.math3.util
Convenience routines and common data structures used throughout the commons-math library.
org.freehep.math.minuit - package org.freehep.math.minuit
User API for the JMinuit package.
org.jfree.chart - package org.jfree.chart
Core classes, including JFreeChart and ChartPanel.
org.jfree.chart.annotations - package org.jfree.chart.annotations
A framework for adding annotations to charts.
org.jfree.chart.axis - package org.jfree.chart.axis
Axis classes and interfaces.
org.jfree.chart.block - package org.jfree.chart.block
Blocks and layout classes used extensively by the LegendTitle class.
org.jfree.chart.demo - package org.jfree.chart.demo
Some basic demos to get you started.
org.jfree.chart.editor - package org.jfree.chart.editor
Provides a simple (but so far incomplete) framework for editing chart properties.
org.jfree.chart.encoders - package org.jfree.chart.encoders
Classes related to the encoding of charts to different image formats.
org.jfree.chart.entity - package org.jfree.chart.entity
Classes representing components of (or entities in) a chart.
org.jfree.chart.event - package org.jfree.chart.event
Event classes and listener interfaces, used to provide a change notification mechanism so that charts are automatically redrawn whenever changes are made to any chart component.
org.jfree.chart.fx - package org.jfree.chart.fx
Core classes that provide JavaFX support for JFreeChart.
org.jfree.chart.fx.demo - package org.jfree.chart.fx.demo
Basic demo applications showing the use of JFreeChart in JavaFX.
org.jfree.chart.fx.interaction - package org.jfree.chart.fx.interaction
Contains classes that implement most of the interactivity for the ChartViewer and ChartCanvas components.
org.jfree.chart.imagemap - package org.jfree.chart.imagemap
Classes, including ImageMapUtilities, for creating HTML image maps.
org.jfree.chart.labels - package org.jfree.chart.labels
Generators and other classes used for the display of item labels and tooltips.
org.jfree.chart.needle - package org.jfree.chart.needle
A range of objects that can be used to represent the needle on a CompassPlot.
org.jfree.chart.panel - package org.jfree.chart.panel
Classes related to the ChartPanel class.
org.jfree.chart.plot - package org.jfree.chart.plot
Plot classes and related interfaces.
org.jfree.chart.plot.dial - package org.jfree.chart.plot.dial
Classes for creating dial plots.
org.jfree.chart.renderer - package org.jfree.chart.renderer
Core support for the plug-in renderers used by the CategoryPlot and XYPlot classes.
org.jfree.chart.renderer.category - package org.jfree.chart.renderer.category
Plug-in renderers for the CategoryPlot class.
org.jfree.chart.renderer.xy - package org.jfree.chart.renderer.xy
Plug-in renderers for the XYPlot class.
org.jfree.chart.resources - package org.jfree.chart.resources
Localised resources for the JFreeChart class library.
org.jfree.chart.servlet - package org.jfree.chart.servlet
Classes for providing useful servlet and JSP functionality.
org.jfree.chart.title - package org.jfree.chart.title
Classes used to display chart titles and subtitles.
org.jfree.chart.urls - package org.jfree.chart.urls
Classes for adding URLS to charts for HTML image map generation.
org.jfree.chart.util - package org.jfree.chart.util
Utility classes used by JFreeChart.
org.jfree.data - package org.jfree.data
The base package for classes that represent various types of data.
org.jfree.data.category - package org.jfree.data.category
A package containing the CategoryDataset interface and related classes.
org.jfree.data.contour - package org.jfree.data.contour
Datasets used by the ContourPlot class.
org.jfree.data.function - package org.jfree.data.function
Representation for simple functions.
org.jfree.data.gantt - package org.jfree.data.gantt
Data interfaces and classes for Gantt charts.
org.jfree.data.general - package org.jfree.data.general
Data interfaces and classes.
org.jfree.data.io - package org.jfree.data.io
Miscellaneous support for input/output of data.
org.jfree.data.jdbc - package org.jfree.data.jdbc
Dataset classes that fetch data from a database via JDBC.
org.jfree.data.resources - package org.jfree.data.resources
Resource bundles for items that require localisation.
org.jfree.data.statistics - package org.jfree.data.statistics
Classes for representing statistical data.
org.jfree.data.time - package org.jfree.data.time
Interfaces and classes for time-related data.
org.jfree.data.time.ohlc - package org.jfree.data.time.ohlc
Classes for representing financial data in open-high-low-close form.
org.jfree.data.xml - package org.jfree.data.xml
Support for reading datasets from XML files.
org.jfree.data.xy - package org.jfree.data.xy
A package containing the XYDataset interface and related classes.
org.jlab.groot.base - package org.jlab.groot.base
 
org.jlab.groot.data - package org.jlab.groot.data
 
org.jlab.groot.demo - package org.jlab.groot.demo
 
org.jlab.groot.fitter - package org.jlab.groot.fitter
 
org.jlab.groot.graphics - package org.jlab.groot.graphics
 
org.jlab.groot.group - package org.jlab.groot.group
 
org.jlab.groot.io - package org.jlab.groot.io
 
org.jlab.groot.math - package org.jlab.groot.math
 
org.jlab.groot.matrix - package org.jlab.groot.matrix
 
org.jlab.groot.studio - package org.jlab.groot.studio
 
org.jlab.groot.tree - package org.jlab.groot.tree
 
org.jlab.groot.ui - package org.jlab.groot.ui
 
org.lsmp.djep.djep - package org.lsmp.djep.djep
Classes to perform differentiation of equations and various utility classes.
org.lsmp.djep.djep.diffRules - package org.lsmp.djep.djep.diffRules
Rules specifying how to differentiate functions.
org.lsmp.djep.groupJep - package org.lsmp.djep.groupJep
A version of JEP which can work over an arbitary group.
org.lsmp.djep.groupJep.function - package org.lsmp.djep.groupJep.function
PostfixMathCommands which implement the group operations.
org.lsmp.djep.groupJep.groups - package org.lsmp.djep.groupJep.groups
Some predefined groups.
org.lsmp.djep.groupJep.interfaces - package org.lsmp.djep.groupJep.interfaces
Interfaces defining behavious a group implements.
org.lsmp.djep.groupJep.values - package org.lsmp.djep.groupJep.values
Objects representing the elements of a group.
org.lsmp.djep.jama - package org.lsmp.djep.jama
Wrapper for JAMA matrix operations for use in vectorJep and matrixJep.
org.lsmp.djep.matrixJep - package org.lsmp.djep.matrixJep
Advanced vector and matrix handeling.
org.lsmp.djep.matrixJep.function - package org.lsmp.djep.matrixJep.function
A few functions necessary for advanced matrix operations.
org.lsmp.djep.matrixJep.nodeTypes - package org.lsmp.djep.matrixJep.nodeTypes
Subclasses the AST nodes to work with vectors and matricies.
org.lsmp.djep.mrpe - package org.lsmp.djep.mrpe
Experimental fast evaluation routines for vectors and matrices.
org.lsmp.djep.rewrite - package org.lsmp.djep.rewrite
Experimental functions for tree manipulation, package may be dropped.
org.lsmp.djep.rpe - package org.lsmp.djep.rpe
Experimental fast evaluation routines.
org.lsmp.djep.sjep - package org.lsmp.djep.sjep
An advanced simplification/expansion/comparison algorithm.
org.lsmp.djep.vectorJep - package org.lsmp.djep.vectorJep
Basic handeling of Vectors and Matricies.
org.lsmp.djep.vectorJep.function - package org.lsmp.djep.vectorJep.function
Functions and operators for working with vectors and matricies.
org.lsmp.djep.vectorJep.values - package org.lsmp.djep.vectorJep.values
Objects representing the values of Scalers, Vectors, Matricies and Tensors.
org.lsmp.djep.xjep - package org.lsmp.djep.xjep
Simplification, deep copying, printing and various utilities.
org.lsmp.djep.xjep.function - package org.lsmp.djep.xjep.function
Functions for use in XJep.
org.lsmp.djepExamples - package org.lsmp.djepExamples
Various example applications illustrating the use of most features.
org.lsmp.djepJUnit - package org.lsmp.djepJUnit
JUnit tests to check that everything works correctly.
org.nfunk.jep - package org.nfunk.jep
Provides the main parsing classes including JEP and Parser as well as related classes such as node classes.
org.nfunk.jep.evaluation - package org.nfunk.jep.evaluation
An experimental fast evaluator which "compiles" an expression into a set of CommandElement objects rather than traversing the parse tree.
org.nfunk.jep.function - package org.nfunk.jep.function
Provides function and operator classes.
org.nfunk.jep.type - package org.nfunk.jep.type
Provides number factories and special type classes.
org.nfunk.jepexamples - package org.nfunk.jepexamples
A set of examples using JEP.
org.nfunk.jeptesting - package org.nfunk.jeptesting
Testing classes using the junit unit testing component.
OrientedPoint - Class in org.apache.commons.math3.geometry.euclidean.oned
This class represents a 1D oriented hyperplane.
OrientedPoint(Vector1D, boolean, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Simple constructor.
OrientedPoint(Vector1D, boolean) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Deprecated.
orthogonal() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get a vector orthogonal to the instance.
orthogonal() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get a vector orthogonal to the instance.
OSsys - Static variable in class jhepsim.SetEnv
 
OSsys - Static variable in class jminhep.gui.SetEnv
 
OTHER - Static variable in class jplot.GraphLabel
 
outerProduct(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the outer product.
outerProduct(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the outer product.
outerProduct(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Compute the outer product.
outerProduct(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Compute the outer product.
outerProduct(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Compute the outer product.
outerProduct(SparseFieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Optimized method to compute outer product when both vectors are sparse.
outerProduct(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Compute the outer product.
Outlier - Class in org.jfree.chart.renderer
Represents one outlier in the box and whisker plot.
Outlier(double, double, double) - Constructor for class org.jfree.chart.renderer.Outlier
Constructs an outlier item consisting of a point and the radius of the outlier ellipse
OutlierList - Class in org.jfree.chart.renderer
A collection of outliers for a single entity in a box and whisker plot.
OutlierList(Outlier) - Constructor for class org.jfree.chart.renderer.OutlierList
Creates a new list containing a single outlier.
OutlierListCollection - Class in org.jfree.chart.renderer
A collection of outlier lists for a box and whisker plot.
OutlierListCollection() - Constructor for class org.jfree.chart.renderer.OutlierListCollection
Creates a new empty collection.
OutlineExtractor - Class in org.apache.commons.math3.geometry.euclidean.threed
Extractor for polyhedrons sets outlines.
OutlineExtractor(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.OutlineExtractor
Build an extractor for a specific projection plane.
OUTOFRANGE_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
OutOfRangeException - Exception in org.apache.commons.math3.exception
Exception to be thrown when some argument is out of range.
OutOfRangeException(Number, Number, Number) - Constructor for exception org.apache.commons.math3.exception.OutOfRangeException
Construct an exception from the mismatched dimensions.
OutOfRangeException(Localizable, Number, Number, Number) - Constructor for exception org.apache.commons.math3.exception.OutOfRangeException
Construct an exception from the mismatched dimensions with a specific context information.
outputString - Static variable in class jhepsim.SetEnv
 
OUTSIDE1 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE1.
OUTSIDE10 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE10.
OUTSIDE11 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE11.
OUTSIDE12 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE12.
OUTSIDE2 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE2.
OUTSIDE3 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE3.
OUTSIDE4 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE4.
OUTSIDE5 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE5.
OUTSIDE6 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE6.
OUTSIDE7 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE7.
OUTSIDE8 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE8.
OUTSIDE9 - Static variable in class org.jfree.chart.labels.ItemLabelAnchor
OUTSIDE9.
OVERFLOW - Static variable in interface colt.hep.aida.IHistogram
Constant specifying the overflow bin (can be passed to any method expecting a bin number).
OVERFLOW_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
overlaps(Outlier) - Method in class org.jfree.chart.renderer.Outlier
Returns a true if outlier is overlapped and false if it is not.
overlapsWith(SimpleHistogramBin) - Method in class org.jfree.data.statistics.SimpleHistogramBin
Returns true if this bin overlaps with the specified bin, and false otherwise.
Overlay - Interface in org.jfree.chart.panel
Defines the interface for an overlay that can be added to a ChartPanel.
overlayChanged(OverlayChangeEvent) - Method in class org.jfree.chart.ChartPanel
Handles a change to an overlay by repainting the panel.
overlayChanged(OverlayChangeEvent) - Method in interface org.jfree.chart.event.OverlayChangeListener
This method is called to notify a listener of a change event.
OverlayChangeEvent - Class in org.jfree.chart.event
A change event for an Overlay.
OverlayChangeEvent(Object) - Constructor for class org.jfree.chart.event.OverlayChangeEvent
Creates a new change event.
OverlayChangeListener - Interface in org.jfree.chart.event
A listener for changes to an Overlay.
OverLIBToolTipTagFragmentGenerator - Class in org.jfree.chart.imagemap
Generates tooltips using the OverLIB library (http://www.bosrup.com/web/overlib/).
OverLIBToolTipTagFragmentGenerator() - Constructor for class org.jfree.chart.imagemap.OverLIBToolTipTagFragmentGenerator
Creates a new instance.
overrideReadOnly(DeleteOption[]) - Static method in enum org.apache.commons.io.file.StandardDeleteOption
Returns true if the given options contain StandardDeleteOption.OVERRIDE_READ_ONLY.

P

p() - Method in class j4np.physics.LorentzVector
 
P0 - Class in jhplot.fit
Polynomial 0-order (p0)
P0() - Constructor for class jhplot.fit.P0
 
P0(String) - Constructor for class jhplot.fit.P0
 
P0(String[], String[]) - Constructor for class jhplot.fit.P0
 
P0D - Class in jhplot
A container to hold data points in one dimension.
P0D(String) - Constructor for class jhplot.P0D
Construct an empty container with a title
P0D(double[]) - Constructor for class jhplot.P0D
Construct P0D from array;
P0D(String, double[]) - Constructor for class jhplot.P0D
Create P0D from an array.
P0D(String, P0D) - Constructor for class jhplot.P0D
Construct a copy from a P0D.
P0D() - Constructor for class jhplot.P0D
Construct an empty container with a title
P0D(String, String) - Constructor for class jhplot.P0D
Construct a P0D from a file.
P0D_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
P0I - Class in jhplot
A container to hold integer data points in one dimension.
P0I(String) - Constructor for class jhplot.P0I
Construct an empty container with a title
P0I(int[]) - Constructor for class jhplot.P0I
Construct P0I from array;
P0I(String, int[]) - Constructor for class jhplot.P0I
Create P0I from an array.
P0I(String, P0I) - Constructor for class jhplot.P0I
Construct a copy from a P0I.
P0I() - Constructor for class jhplot.P0I
Construct an empty container with a title
P0I(String, String) - Constructor for class jhplot.P0I
Construct a P0I from a file.
P0I_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
P1 - Class in jhplot.fit
Polynomial 1-order (p0+p1*x)
P1() - Constructor for class jhplot.fit.P1
 
P1(String) - Constructor for class jhplot.fit.P1
 
P1(String[], String[]) - Constructor for class jhplot.fit.P1
 
P1D - Class in jhplot
A container to hold data points with 1st and 2nd level errors.
P1D() - Constructor for class jhplot.P1D
Construct an empty container
P1D(String) - Constructor for class jhplot.P1D
Construct an empty container with a title.
P1D(String, DoubleArrayList, DoubleArrayList) - Constructor for class jhplot.P1D
Construct an empty container with a title.
P1D(String, int) - Constructor for class jhplot.P1D
Construct an empty container with a title
P1D(String, Color) - Constructor for class jhplot.P1D
Construct an empty container with a title and color for points
P1D(String, Color, int) - Constructor for class jhplot.P1D
Construct an empty container with a title and color and symbol style for points
P1D(P0D, P0D) - Constructor for class jhplot.P1D
Construct a container from pairs of P0D (one for X, second for Y)
P1D(String, P0D, P0D) - Constructor for class jhplot.P1D
Construct a container from pairs of P0D (one for X, second for Y)
P1D(Cloud2D) - Constructor for class jhplot.P1D
Construct P1D from a Cloud2D
P1D(String, double[], double[]) - Constructor for class jhplot.P1D
Construct a container from pairs X and Y
P1D(String, P1D) - Constructor for class jhplot.P1D
Construct a new copy of the data container.
P1D(DataHolder, String, int, int) - Constructor for class jhplot.P1D
Create P1D data holder from multidimensional data holder.
P1D(DataHolder, int, int) - Constructor for class jhplot.P1D
Create P1D data holder from multidimensional data holder.
P1D(String, String) - Constructor for class jhplot.P1D
Construct a P1D from a file.
P1D(IDataPointSet) - Constructor for class jhplot.P1D
Create a P1D container from IDataPointSet.
P1D(String, H1D, boolean, boolean) - Constructor for class jhplot.P1D
Create a P1D container from a histogram
P1D(H1D, boolean, boolean) - Constructor for class jhplot.P1D
Create a P1D container from a histogram.
P1D(String, H1D, boolean) - Constructor for class jhplot.P1D
Create a P1D container from a histogram.
P1D(H1D, boolean) - Constructor for class jhplot.P1D
Create a P1D container from a histogram.
P1D(H1D) - Constructor for class jhplot.P1D
Create a P1D container from a histogram.
P1D(String, H1D) - Constructor for class jhplot.P1D
Create a P1D container from a histogram.
P1D(String, URL) - Constructor for class jhplot.P1D
Construct a P1D from a file on the we web.
P1D(URL) - Constructor for class jhplot.P1D
Construct a P1D from a file on the we web.
P1D - Static variable in class jplot.LinePars
 
P1D_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
p1evl(double, double[], int) - Static method in class cern.jet.math.Polynomial
Evaluates the given polynomial of degree N at x, assuming coefficient of N is 1.0.
p1evl(double, double[], int) - Static method in class jhplot.stat.Statistics
Evaluates the given polynomial of degree N at x.
P2 - Class in jhplot.fit
Polynomial 2-order (p0+p1*x+p2*x*x)
P2() - Constructor for class jhplot.fit.P2
 
P2(String) - Constructor for class jhplot.fit.P2
 
P2(String[], String[]) - Constructor for class jhplot.fit.P2
 
P2D - Class in jhplot
A container to hold data points in X,Y,Z.
P2D() - Constructor for class jhplot.P2D
Construct an empty container
P2D(String) - Constructor for class jhplot.P2D
Construct an empty container with a title
P2D(String, String) - Constructor for class jhplot.P2D
Construct a P2D from a file.
P3 - Class in jhplot.fit
Polynomial 3rd-order.
P3() - Constructor for class jhplot.fit.P3
 
P3(String) - Constructor for class jhplot.fit.P3
 
P3(String[], String[]) - Constructor for class jhplot.fit.P3
 
P3D - Class in jhplot
A container to hold data points in X,Y,Z and their extensions dX,dY,dZ.
P3D() - Constructor for class jhplot.P3D
Construct an empty container
P3D(String) - Constructor for class jhplot.P3D
Construct an empty container with a title
P3D(String, String) - Constructor for class jhplot.P3D
Construct a P3D from a file.
P4 - Class in jhplot.fit
Polynomial 4th-order.
P4() - Constructor for class jhplot.fit.P4
 
P4(String) - Constructor for class jhplot.fit.P4
 
P4(String[], String[]) - Constructor for class jhplot.fit.P4
 
P5 - Class in jhplot.fit
Polynomial 5th-order.
P5() - Constructor for class jhplot.fit.P5
 
P5(String) - Constructor for class jhplot.fit.P5
 
P5(String[], String[]) - Constructor for class jhplot.fit.P5
 
P6 - Class in jhplot.fit
Polynomial 6th-order.
P6() - Constructor for class jhplot.fit.P6
 
P6(String) - Constructor for class jhplot.fit.P6
 
P6(String[], String[]) - Constructor for class jhplot.fit.P6
 
pa(Rot, Zmat, int, int, int, int) - Static method in class Jampack.Rot
Multiplies rows (ii1,jj1:jj2) and (ii2,jj1:jj2) of a Zmat (altered) by a plane rotation.
pad - Variable in class jminhep.clcontrol.SummaryPad
 
PadAttributes - Class in org.jlab.groot.base
 
PadAttributes() - Constructor for class org.jlab.groot.base.PadAttributes
 
PadAttributes.PadAttributesPane - Class in org.jlab.groot.base
 
PadAttributesPane() - Constructor for class org.jlab.groot.base.PadAttributes.PadAttributesPane
 
padding(int, int, double[]) - Static method in class jhplot.math.ArrayMathUtils
Fills in with zero to get to the desired length; original array with be at the specified position.
padding(int, int, int[]) - Static method in class jhplot.math.ArrayMathUtils
Fills in with zeroes to get to the specified length; original array with be at the specified position
PadMargins - Class in org.jlab.groot.base
 
PadMargins() - Constructor for class org.jlab.groot.base.PadMargins
 
paint(Graphics) - Method in class graph.Graph2D
This paints the entire plot.
paint(Graphics) - Method in class org.jlab.groot.base.GraphicsTests
 
paint(Graphics) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
painting all components on the Graphics2D object.
paint(Graphics) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
paint(Graphics) - Method in class org.jlab.groot.graphics.GraphicsAxisTests
 
paint(Graphics) - Method in class org.nfunk.jepexamples.FractalCanvas
 
paint(Graphics) - Method in class org.nfunk.jepexamples.GraphCanvas
Draws the graph to the Graphics object.
paintAll - Variable in class graph.Graph2D
If set true (the default) everything associated with the plot will be drawn when the update method or paint method are called.
PaintAlpha - Class in org.jfree.chart.util
This class contains static methods for the manipulation of objects of type Paint
PaintAlpha() - Constructor for class org.jfree.chart.util.PaintAlpha
 
paintBar(Graphics2D, BarRenderer, int, int, RectangularShape, RectangleEdge) - Method in interface org.jfree.chart.renderer.category.BarPainter
Paints a single bar on behalf of a renderer.
paintBar(Graphics2D, BarRenderer, int, int, RectangularShape, RectangleEdge) - Method in class org.jfree.chart.renderer.category.GradientBarPainter
Paints a single bar instance.
paintBar(Graphics2D, BarRenderer, int, int, RectangularShape, RectangleEdge) - Method in class org.jfree.chart.renderer.category.StandardBarPainter
Paints a single bar instance.
paintBar(Graphics2D, XYBarRenderer, int, int, RectangularShape, RectangleEdge) - Method in class org.jfree.chart.renderer.xy.GradientXYBarPainter
Paints a single bar instance.
paintBar(Graphics2D, XYBarRenderer, int, int, RectangularShape, RectangleEdge) - Method in class org.jfree.chart.renderer.xy.StandardXYBarPainter
Paints a single bar instance.
paintBar(Graphics2D, XYBarRenderer, int, int, RectangularShape, RectangleEdge) - Method in interface org.jfree.chart.renderer.xy.XYBarPainter
Paints a single bar on behalf of a renderer.
paintBarShadow(Graphics2D, BarRenderer, int, int, RectangularShape, RectangleEdge, boolean) - Method in interface org.jfree.chart.renderer.category.BarPainter
Paints the shadow for a single bar on behalf of a renderer.
paintBarShadow(Graphics2D, BarRenderer, int, int, RectangularShape, RectangleEdge, boolean) - Method in class org.jfree.chart.renderer.category.GradientBarPainter
Paints a single bar instance.
paintBarShadow(Graphics2D, BarRenderer, int, int, RectangularShape, RectangleEdge, boolean) - Method in class org.jfree.chart.renderer.category.StandardBarPainter
Paints a single bar instance.
paintBarShadow(Graphics2D, XYBarRenderer, int, int, RectangularShape, RectangleEdge, boolean) - Method in class org.jfree.chart.renderer.xy.GradientXYBarPainter
Paints a single bar instance.
paintBarShadow(Graphics2D, XYBarRenderer, int, int, RectangularShape, RectangleEdge, boolean) - Method in class org.jfree.chart.renderer.xy.StandardXYBarPainter
Paints a single bar instance.
paintBarShadow(Graphics2D, XYBarRenderer, int, int, RectangularShape, RectangleEdge, boolean) - Method in interface org.jfree.chart.renderer.xy.XYBarPainter
Paints the shadow for a single bar on behalf of a renderer.
paintBeforeData(Graphics, Rectangle) - Method in class graph.Graph2D
A hook into the Graph2D.paint method.
paintComponent(Graphics) - Method in class jhplot.utils.DrawingPanel
 
paintComponent(Graphics) - Method in class jplot.GraphGeneral
Overloaded paintComponent, is called at each repaint.
paintComponent(Graphics) - Method in class jplot.LineStyle
 
paintComponent(Graphics) - Method in class jplot.LineStyleButton
 
paintComponent(Graphics) - Method in class jplot.panels.ColorPreview
 
paintComponent(Graphics) - Method in class jplot.SmallColorPreview
Color the canvas and add some decoration (shadow).
paintComponent(Graphics) - Method in class jplot3d.JColor
 
paintComponent(Graphics) - Method in class jplot3d.JSurface
Paints surface.
paintComponent(Graphics) - Method in class org.jfree.chart.ChartPanel
Paints the component by drawing the chart to fill the entire component, but allowing for the insets (which will be non-zero if a border has been set for this component).
paintComponent(Graphics) - Method in class org.jfree.chart.editor.PaletteSample
Deprecated.
Draws the sample.
paintFirst(Graphics, Rectangle) - Method in class graph.Contour
 
paintFirst(Graphics, Rectangle) - Method in class graph.Graph2D
A hook into the Graph2D.paint method.
paintLast(Graphics, Rectangle) - Method in class graph.Contour
 
paintLast(Graphics, Rectangle) - Method in class graph.Graph2D
A hook into the Graph2D.paint method.
PaintMap - Class in org.jfree.chart
A storage structure that maps Comparable instances with Paint instances.
PaintMap() - Constructor for class org.jfree.chart.PaintMap
Creates a new (empty) map.
paintOverlay(Graphics2D, ChartPanel) - Method in class org.jfree.chart.panel.CrosshairOverlay
Paints the crosshairs in the layer.
paintOverlay(Graphics2D, ChartPanel) - Method in interface org.jfree.chart.panel.Overlay
Paints the crosshairs in the layer.
PaintScale - Interface in org.jfree.chart.renderer
A source for Paint instances, used by the XYBlockRenderer.
PaintScaleLegend - Class in org.jfree.chart.title
A legend that shows a range of values and their associated colors, driven by an underlying PaintScale implementation.
PaintScaleLegend(PaintScale, ValueAxis) - Constructor for class org.jfree.chart.title.PaintScaleLegend
Creates a new instance.
paintTo(Graphics) - Method in class net.java.dev.colorchooser.Palette
Paint this palette to a graphics context.
paintToGrphics(Graphics, int, int) - Method in class jplot3dp.ModelView
 
Pair<K,V> - Class in org.apache.commons.math3.util
Generic pair.
Pair(K, V) - Constructor for class org.apache.commons.math3.util.Pair
Create an entry representing a mapping from the specified key to the specified value.
Pair(Pair<? extends K, ? extends V>) - Constructor for class org.apache.commons.math3.util.Pair
Create an entry representing the same mapping as the specified entry.
pairedT(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
pairedT(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a paired, 2-sample t-statistic based on the data in the input arrays.
pairedTTest(double[], double[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
pairedTTest(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
pairedTTest(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a paired, two-sample, two-tailed t-test based on the data in the input arrays.
pairedTTest(double[], double[], double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a paired t-test evaluating the null hypothesis that the mean of the paired differences between sample1 and sample2 is 0 in favor of the two-sided alternative that the mean paired difference is not equal to 0, with significance level alpha.
pairsMatching(DoubleIntProcedure, DoubleArrayList, IntArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntDoubleProcedure, IntArrayList, DoubleArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntIntProcedure, IntArrayList, IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntObjectProcedure, IntArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongObjectProcedure, LongArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(DoubleIntProcedure, DoubleArrayList, IntArrayList) - Method in class cern.colt.map.OpenDoubleIntHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntDoubleProcedure, IntArrayList, DoubleArrayList) - Method in class cern.colt.map.OpenIntDoubleHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntIntProcedure, IntArrayList, IntArrayList) - Method in class cern.colt.map.OpenIntIntHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntObjectProcedure, IntArrayList, ObjectArrayList) - Method in class cern.colt.map.OpenIntObjectHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongObjectProcedure, LongArrayList, ObjectArrayList) - Method in class cern.colt.map.OpenLongObjectHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsSortedByKey(DoubleArrayList, IntArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(IntArrayList, DoubleArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(IntArrayList, IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(IntArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(LongArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByValue(DoubleArrayList, IntArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(IntArrayList, DoubleArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(IntArrayList, IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(IntArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all keys and values sorted ascending by value according to natural ordering into the specified lists.
pairsSortedByValue(LongArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all keys and values sorted ascending by value according to natural ordering into the specified lists.
Palette - Class in net.java.dev.colorchooser
Model for a palette that can be painted, and from which colors may be selected.
Palette() - Constructor for class net.java.dev.colorchooser.Palette
 
PaletteSample - Class in org.jfree.chart.editor
Deprecated.
This class is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
PaletteSample(ColorPalette) - Constructor for class org.jfree.chart.editor.PaletteSample
Deprecated.
Creates a new sample.
pan(double) - Method in class org.jfree.chart.axis.LogAxis
Slides the axis range by the specified percentage.
pan(double) - Method in class org.jfree.chart.axis.ValueAxis
Slides the axis range by the specified percentage.
panDomainAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CategoryPlot
Pans the domain axes by the specified percentage.
panDomainAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Pans all domain axes by the specified percentage.
panDomainAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.FastScatterPlot
Pans the domain axes by the specified percentage.
panDomainAxes(double, PlotRenderingInfo, Point2D) - Method in interface org.jfree.chart.plot.Pannable
Pans the domain axes by the specified percentage.
panDomainAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.XYPlot
Pans the domain axes by the specified percentage.
PanelAxes - Class in jplot.panels
Builds a panel with Tabs, containing optional parameters for labels, legends, colors, etc.
PanelAxes(JPlot, GraphSettings) - Constructor for class jplot.panels.PanelAxes
 
PanelAxes.AxesOptions - Class in jplot.panels
 
PanelAxes.BoxOptions - Class in jplot.panels
 
PanelAxes.GridOptions - Class in jplot.panels
 
PanelColor - Class in jplot.panels
Builds a panel with a color panel from which defined colors can be selected.
PanelColor(Frame) - Constructor for class jplot.panels.PanelColor
Constructor, builds the panel from a ColorSwatchPanel and a handle to Swing's ColorChooser.
PanelColor(Frame, Color) - Constructor for class jplot.panels.PanelColor
Constructor, initializes the panel with a color.
PanelDash - Class in jplot.panels
Builds a line-type (dash strokes) chooser panel, using a number of pre-defined strokes.
PanelDash(LinePars) - Constructor for class jplot.panels.PanelDash
 
PanelFonts - Class in jplot.panels
Creates a panel with options to set Fonts for text.
PanelFonts(JPlot, Font, Color) - Constructor for class jplot.panels.PanelFonts
Principal constructor.
PanelFonts(JPlot, Font) - Constructor for class jplot.panels.PanelFonts
Another constructor.
PanelFonts(JPlot) - Constructor for class jplot.panels.PanelFonts
Builds the panel with default values.
PanelGrid - Class in jplot.panels
Creates a panel with options to set or use grid lines in the graph.
PanelGrid(JPlot, GraphSettings) - Constructor for class jplot.panels.PanelGrid
Principal constructor.
PanelGridUI - Class in jplot.panels
 
PanelGridUI() - Constructor for class jplot.panels.PanelGridUI
 
PanelGridUI(Insets) - Constructor for class jplot.panels.PanelGridUI
 
PanelLabel - Class in jplot.panels
Create a panel with options to set labels (X-, Y-axis labels, a title, random labels or text in general).
PanelLabel(JPlot, GraphSettings) - Constructor for class jplot.panels.PanelLabel
Principal constructor.
PanelLegend - Class in jplot.panels
LegendPanel creates a panel which allows a user to modify the parameters used to set the legend, such as position, color, font etc.
PanelLegend(JPlot, GraphSettings) - Constructor for class jplot.panels.PanelLegend
Principal constructor.
PanelPlot - Class in jplot.panels
Builds the panel with item lists, to select columns, styles etc.
PanelPlot(JPlot, DataFile, GraphSettings) - Constructor for class jplot.panels.PanelPlot
Principal constructor.
PanelPlot.ButtonEditor - Class in jplot.panels
 
PanelPlot.LineStyleButtonRenderer - Class in jplot.panels
Renders the linestyle in a button.
PanelPoint - Class in jplot.panels
Builds a point-types panel from a number of predefined points, all drawn by the Graph class.
PanelPoint(LinePars) - Constructor for class jplot.panels.PanelPoint
Constructor.
PanelSave - Class in jplot.panels
SavePanel build a panel used to save the graph to some format (JPEG for the time being, waiting for a decent EPS/PS decoder).
PanelSave(GraphGeneral) - Constructor for class jplot.panels.PanelSave
Principal constructor, builds the panel.
PanelScaling - Class in jplot.panels
ScalingPanel creates a panel which allows a user to modify the way the graph is scaled on the axes.
PanelScaling(JPlot, GraphSettings) - Constructor for class jplot.panels.PanelScaling
Principal constructor.
PanHandlerFX - Class in org.jfree.chart.fx.interaction
Handles panning of charts on a ChartCanvas.
PanHandlerFX(String) - Constructor for class org.jfree.chart.fx.interaction.PanHandlerFX
Creates a new instance that requires no modifier keys.
PanHandlerFX(String, boolean, boolean, boolean, boolean) - Constructor for class org.jfree.chart.fx.interaction.PanHandlerFX
Creates a new instance that will be activated using the specified combination of modifier keys.
Pannable - Interface in org.jfree.chart.plot
An interface that the ChartPanel class uses to communicate with plots that support panning.
panRangeAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CategoryPlot
Pans the range axes by the specified percentage.
panRangeAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Pans all range axes by the specified percentage.
panRangeAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.FastScatterPlot
Pans the range axes by the specified percentage.
panRangeAxes(double, PlotRenderingInfo, Point2D) - Method in interface org.jfree.chart.plot.Pannable
Pans the range axes by the specified percentage.
panRangeAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.XYPlot
Pans the range axes by the specified percentage.
ParallelSliceFitter - Class in org.jlab.groot.fitter
 
ParallelSliceFitter() - Constructor for class org.jlab.groot.fitter.ParallelSliceFitter
 
ParallelSliceFitter(H2F) - Constructor for class org.jlab.groot.fitter.ParallelSliceFitter
 
ParallelSliceFitter.ResultSetter - Interface in org.jlab.groot.fitter
 
ParamChecks - Class in org.jfree.chart.util
A utility class for checking parameters.
ParamChecks() - Constructor for class org.jfree.chart.util.ParamChecks
 
parameter() - Method in class org.freehep.math.minuit.MinosError
 
parameter(int) - Method in class org.jlab.groot.math.Func1D
 
ParameterGuesser(Collection<WeightedObservedPoint>) - Constructor for class org.apache.commons.math3.fitting.GaussianCurveFitter.ParameterGuesser
Constructs instance with the specified observed points.
ParameterGuesser(WeightedObservedPoint[]) - Constructor for class org.apache.commons.math3.fitting.GaussianFitter.ParameterGuesser
Deprecated.
Constructs instance with the specified observed points.
ParameterGuesser(Collection<WeightedObservedPoint>) - Constructor for class org.apache.commons.math3.fitting.HarmonicCurveFitter.ParameterGuesser
Simple constructor.
ParameterGuesser(WeightedObservedPoint[]) - Constructor for class org.apache.commons.math3.fitting.HarmonicFitter.ParameterGuesser
Deprecated.
Simple constructor.
ParameterGuesser(WeightedObservedPoint[]) - Constructor for class org.apache.commons.math3.optimization.fitting.GaussianFitter.ParameterGuesser
Deprecated.
Constructs instance with the specified observed points.
ParameterGuesser(WeightedObservedPoint[]) - Constructor for class org.apache.commons.math3.optimization.fitting.HarmonicFitter.ParameterGuesser
Deprecated.
Simple constructor.
Parameterizable - Interface in org.apache.commons.math3.ode
This interface enables to process any parameterizable object.
ParameterizedODE - Interface in org.apache.commons.math3.ode
Interface to compute by finite difference Jacobian matrix for some parameter when computing partial derivatives equations.
ParameterJacobianProvider - Interface in org.apache.commons.math3.ode
Interface to compute exactly Jacobian matrix for some parameter when computing partial derivatives equations.
ParameterPanel - Class in org.jlab.groot.ui
 
ParameterPanel(EmbeddedCanvas, int, Func1D) - Constructor for class org.jlab.groot.ui.ParameterPanel
 
Parameters - Class in Jampack
Parameter is a class containing global parameters for Jampack.
Parameters() - Constructor for class Jampack.Parameters
 
parameters() - Method in class org.freehep.math.minuit.MnApplication
 
parameterValidator(ParameterValidator) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the validator of the model parameters.
ParameterValidator - Interface in org.apache.commons.math3.fitting.leastsquares
Interface for validating a set of model parameters.
Parametric() - Constructor for class org.apache.commons.math3.analysis.function.Gaussian.Parametric
 
Parametric() - Constructor for class org.apache.commons.math3.analysis.function.HarmonicOscillator.Parametric
 
Parametric() - Constructor for class org.apache.commons.math3.analysis.function.Logistic.Parametric
 
Parametric() - Constructor for class org.apache.commons.math3.analysis.function.Logit.Parametric
 
Parametric() - Constructor for class org.apache.commons.math3.analysis.function.Sigmoid.Parametric
 
Parametric() - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunction.Parametric
 
ParametricUnivariateFunction - Interface in org.apache.commons.math3.analysis
An interface representing a real function that depends on one independent variable plus some extra parameters.
params() - Method in class org.freehep.math.minuit.MnApplication
access to parameters and errors in column-wise representation
params() - Method in class org.freehep.math.minuit.MnUserParameterState
access to parameters and errors in column-wise representation
ParetoDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Pareto distribution.
ParetoDistribution() - Constructor for class org.apache.commons.math3.distribution.ParetoDistribution
Create a Pareto distribution with a scale of 1 and a shape of 1.
ParetoDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.ParetoDistribution
Create a Pareto distribution using the specified scale and shape.
ParetoDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.ParetoDistribution
Create a Pareto distribution using the specified scale, shape and inverse cumulative distribution accuracy.
ParetoDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.ParetoDistribution
Creates a Pareto distribution.
ParetoDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.ParetoDistribution
Creates a Pareto distribution.
parse() - Method in class graph.BuildGraph
This is THE method that parses the input file and constructs the plot.
parse(String) - Method in class graph.ParseFunction
Parse the string.
parse() - Method in class graph.ParseFunction
Parse the previously set string
parse(String[]) - Method in class hep.lcio.util.CommandHandler
Parse this command's options from the command line.
parse(String[]) - Method in class hep.lcio.util.CommandLineTool
Parse the argv for global options.
parse(String[]) - Method in class hep.lcio.util.CompareCommandHandler
Parse the command line options for the compare command using apache CLI.
parse(String[]) - Method in class hep.lcio.util.ConcatenateCommandHandler
Parse the arguments for concat options.
parse(String[]) - Method in class hep.lcio.util.HeaderCountCommandHandler
Parse the command line for the count command.
parse(String[]) - Method in class hep.lcio.util.MergeCommandHandler
Parse the command line options for the merge command using apache CLI.
parse(String[]) - Method in class hep.lcio.util.PrintCommandHandler
 
parse(String[]) - Method in class hep.lcio.util.RandomEventCommandHandler
Parse the raw options for the random command.
parse(String[]) - Method in class hep.lcio.util.RunCommandHandler
 
parse(String[]) - Method in class hep.lcio.util.SelectCommandHandler
 
parse(String[]) - Method in class hep.lcio.util.SIODumpCommandHandler
Parse the arguments for siodump options.
parse(String[]) - Method in class hep.lcio.util.SizeCommandHandler
 
parse(String[]) - Method in class hep.lcio.util.SplitCommandHandler
Parse the argv for split command options.
parse(String[]) - Method in class hep.lcio.util.StdhepConvertCommandHandler
 
parse(String[]) - Method in class hep.lcio.util.ValidateCommandHandler
Parse the commandline options for the validate command.
parse() - Method in class jhplot.F1D
Parse the function.
parse() - Method in class jhplot.F2D
Parse the function.
parse() - Method in class jhplot.F3D
Parse the function.
parse(File) - Method in class jplot.DataArray
Get data from a file
parse(BufferedReader) - Method in class jplot.DataArray
Read DataArray from BufferedReader
parse(File) - Method in class jplot.DataArray2D
Get data from a file
parse(BufferedReader) - Method in class jplot.DataArray2D
Read DataArray from BufferedReader
parse(File) - Method in class jplot.DataArray3D
Get data from a file
parse(BufferedReader) - Method in class jplot.DataArray3D
Read DataArray from BufferedReader
parse(File, String) - Method in class jplot.XMLRead
Reads a (part of a) file and stores the XML stuff in a vector.
parse(BufferedReader, String) - Method in class jplot.XMLRead
Reads a (part of a) file and stores the XML stuff in a vector.
parse(File) - Method in class jplot.XMLRead
 
parse(String) - Method in class org.apache.commons.math3.complex.ComplexFormat
Parses a string to produce a Complex object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.complex.ComplexFormat
Parses a string to produce a Complex object.
parse(String) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
Parses a string to produce a BigFraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
Parses a string to produce a BigFraction object.
parse(String) - Method in class org.apache.commons.math3.fraction.FractionFormat
Parses a string to produce a Fraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.FractionFormat
Parses a string to produce a Fraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.ProperBigFractionFormat
Parses a string to produce a BigFraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.ProperFractionFormat
Parses a string to produce a Fraction object.
parse(String) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Parses a string to produce a Vector object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Parses a string to produce a Vector object.
parse(String) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Parses a string to produce a Vector3D object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Parses a string to produce a Vector3D object.
parse(String) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Parses a string to produce a Vector object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Parses a string to produce a Vector object.
parse(String) - Method in class org.apache.commons.math3.geometry.VectorFormat
Parses a string to produce a Vector object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.VectorFormat
Parses a string to produce a Vector object.
parse(String) - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Parse a string to produce a RealMatrix object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Parse a string to produce a RealMatrix object.
parse(String) - Method in class org.apache.commons.math3.linear.RealVectorFormat
Parse a string to produce a RealVector object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.linear.RealVectorFormat
Parse a string to produce a RealVector object.
parse(String, ParsePosition) - Method in class org.jfree.chart.axis.CompassFormat
This method returns null for all inputs.
parse(String, ParsePosition) - Method in class org.jfree.chart.axis.MonthDateFormat
Parses the given string (not implemented).
parse(String, ParsePosition) - Method in class org.jfree.chart.axis.QuarterDateFormat
Parses the given string (not implemented).
parse(String, ParsePosition) - Method in class org.jfree.chart.util.HexNumberFormat
Parsing is not implemented, so this method always returns null.
parse(String, ParsePosition) - Method in class org.jfree.chart.util.HMSNumberFormat
Parsing is not implemented, so this method always returns null.
parse(String, ParsePosition) - Method in class org.jfree.chart.util.LogFormat
Parsing is not implemented, so this method always returns null.
parse(String, ParsePosition) - Method in class org.jfree.chart.util.RelativeDateFormat
Parses the given string (not implemented).
parse(String[], int) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
parse(String[]) - Method in class org.jlab.groot.io.ArgumentParser
 
parse(String) - Method in class org.jlab.groot.math.F1D
 
parse(String, ParsePosition) - Method in class org.lsmp.djep.xjep.BaseFormat
Not implemented
parse(String) - Method in class org.nfunk.jep.JEP
Parses an expression.
parseAndIgnoreWhitespace(String, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
Parses source until a non-whitespace character is found.
parseArgs(String[]) - Method in class hep.lcio.util.LCIOConcat
 
parseByteOrder(String) - Static method in class org.apache.commons.io.ByteOrderParser
Parses the String argument as a ByteOrder.
parseDay(String) - Static method in class org.jfree.data.time.Day
Parses the string argument as a day.
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMC.ProMCEvent
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent
 
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
parseDelimitedFrom(InputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.F1D
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.F1D
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.F2D
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.F2D
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.FND
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.FND
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.FPR
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.FPR
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.H1D
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.H1D
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.H2D
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.H2D
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.P0D
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P0D
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.P0I
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P0I
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.P1D
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P1D
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.PND
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PND
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.PNI
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PNI
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.PXY
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PXY
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PBufFile.Record.PXYZ
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PXYZ
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PEventFile.HEvent.Entry
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent.Entry
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PEventFile.HEvent.Group
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent.Group
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.PEventFile.HEvent
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.ProMC.ProMCEvent.Event
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent.Event
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.ProMC.ProMCEvent
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.ProMCStatFile.ProMCStat
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCStatFile.ProMCStat
 
parseDelimitedFrom(InputStream) - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
parseDelimitedFrom(InputStream) - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
parseDelimitedFrom(InputStream) - Static method in class pronlo.io.ProMC.ProMCEvent
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent
 
parseDelimitedFrom(InputStream) - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
parseDelimitedFrom(InputStream) - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
parseDelimitedFrom(InputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseDelimitedFrom(InputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseDelimitedFrom(InputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
parseDelimitedFrom(InputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseDelimitedFrom(InputStream) - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
parseDelimitedFrom(InputStream) - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
parseDelimitedFrom(InputStream) - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
parseDelimitedFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
parseDouble(double) - Method in class graph.TextLine
Parse a double value.
parseDouble(double, int) - Method in class graph.TextLine
Parse a double value.
parseDouble(double, int, int, int) - Method in class graph.TextLine
Parse a double value
ParseException - Exception in jplot3dp.MathParser
This exception is thrown when parse errors are encountered.
ParseException(Token, int[][], String[]) - Constructor for exception jplot3dp.MathParser.ParseException
This constructor is used by the method "generateParseException" in the generated parser.
ParseException() - Constructor for exception jplot3dp.MathParser.ParseException
The following constructors are for use by you for whatever purpose you can think of.
ParseException(String) - Constructor for exception jplot3dp.MathParser.ParseException
 
ParseException - Exception in org.nfunk.jep
This exception is thrown when parse errors are encountered.
ParseException(Token, int[][], String[]) - Constructor for exception org.nfunk.jep.ParseException
This constructor is used by the method "generateParseException" in the generated parser.
ParseException() - Constructor for exception org.nfunk.jep.ParseException
The following constructors are for use by you for whatever purpose you can think of.
ParseException(String) - Constructor for exception org.nfunk.jep.ParseException
 
parseExpression(String) - Method in class jplot3dp.MathParser.MathParser
 
parseExpression(String) - Method in class org.nfunk.jep.JEP
Parses the expression.
parseFixedstring(String, String, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
Parse source for an expected fixed string.
parseFrom(ByteString) - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
parseFrom(byte[]) - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
parseFrom(InputStream) - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent.Event
 
parseFrom(ByteString) - Static method in class proeic.io.ProMC.ProMCEvent
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent
 
parseFrom(byte[]) - Static method in class proeic.io.ProMC.ProMCEvent
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent
 
parseFrom(InputStream) - Static method in class proeic.io.ProMC.ProMCEvent
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMC.ProMCEvent
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent
 
parseFrom(ByteString) - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
parseFrom(byte[]) - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
parseFrom(InputStream) - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMC.ProMCEvent.Particles
 
parseFrom(ByteString) - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(byte[]) - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(InputStream) - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(ByteString) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(byte[]) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(InputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(ByteString) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(byte[]) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(InputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(ByteString) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(byte[]) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(InputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(ByteString) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(byte[]) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(InputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(ByteString) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
parseFrom(byte[]) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
parseFrom(InputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
parseFrom(ByteString) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
parseFrom(byte[]) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
parseFrom(InputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
parseFrom(ByteString) - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
parseFrom(byte[]) - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
parseFrom(InputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat
 
parseFrom(ByteString) - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(byte[]) - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(InputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(CodedInputStream) - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.F1D
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.F1D
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.F1D
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.F1D
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.F1D
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.F1D
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.F1D
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.F1D
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.F2D
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.F2D
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.F2D
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.F2D
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.F2D
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.F2D
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.F2D
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.F2D
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.FND
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.FND
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.FND
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.FND
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.FND
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.FND
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.FND
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.FND
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.FPR
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.FPR
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.FPR
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.FPR
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.FPR
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.FPR
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.FPR
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.FPR
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.H1D
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.H1D
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.H1D
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.H1D
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.H1D
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.H1D
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.H1D
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.H1D
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.H2D
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.H2D
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.H2D
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.H2D
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.H2D
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.H2D
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.H2D
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.H2D
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.P0D
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P0D
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.P0D
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P0D
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.P0D
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P0D
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.P0D
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P0D
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.P0I
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P0I
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.P0I
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P0I
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.P0I
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P0I
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.P0I
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P0I
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.P1D
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P1D
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.P1D
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P1D
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.P1D
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P1D
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.P1D
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.P1D
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.PND
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PND
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.PND
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PND
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.PND
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PND
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.PND
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PND
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.PNI
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PNI
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.PNI
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PNI
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.PNI
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PNI
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.PNI
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PNI
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.PXY
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PXY
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.PXY
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PXY
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.PXY
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PXY
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.PXY
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PXY
 
parseFrom(ByteString) - Static method in class promc.io.PBufFile.Record.PXYZ
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PXYZ
 
parseFrom(byte[]) - Static method in class promc.io.PBufFile.Record.PXYZ
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PXYZ
 
parseFrom(InputStream) - Static method in class promc.io.PBufFile.Record.PXYZ
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PXYZ
 
parseFrom(CodedInputStream) - Static method in class promc.io.PBufFile.Record.PXYZ
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PBufFile.Record.PXYZ
 
parseFrom(ByteString) - Static method in class promc.io.PEventFile.HEvent.Entry
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent.Entry
 
parseFrom(byte[]) - Static method in class promc.io.PEventFile.HEvent.Entry
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent.Entry
 
parseFrom(InputStream) - Static method in class promc.io.PEventFile.HEvent.Entry
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent.Entry
 
parseFrom(CodedInputStream) - Static method in class promc.io.PEventFile.HEvent.Entry
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent.Entry
 
parseFrom(ByteString) - Static method in class promc.io.PEventFile.HEvent.Group
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent.Group
 
parseFrom(byte[]) - Static method in class promc.io.PEventFile.HEvent.Group
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent.Group
 
parseFrom(InputStream) - Static method in class promc.io.PEventFile.HEvent.Group
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent.Group
 
parseFrom(CodedInputStream) - Static method in class promc.io.PEventFile.HEvent.Group
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent.Group
 
parseFrom(ByteString) - Static method in class promc.io.PEventFile.HEvent
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent
 
parseFrom(byte[]) - Static method in class promc.io.PEventFile.HEvent
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent
 
parseFrom(InputStream) - Static method in class promc.io.PEventFile.HEvent
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent
 
parseFrom(CodedInputStream) - Static method in class promc.io.PEventFile.HEvent
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.PEventFile.HEvent
 
parseFrom(ByteString) - Static method in class promc.io.ProMC.ProMCEvent.Event
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent.Event
 
parseFrom(byte[]) - Static method in class promc.io.ProMC.ProMCEvent.Event
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent.Event
 
parseFrom(InputStream) - Static method in class promc.io.ProMC.ProMCEvent.Event
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent.Event
 
parseFrom(CodedInputStream) - Static method in class promc.io.ProMC.ProMCEvent.Event
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent.Event
 
parseFrom(ByteString) - Static method in class promc.io.ProMC.ProMCEvent
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent
 
parseFrom(byte[]) - Static method in class promc.io.ProMC.ProMCEvent
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent
 
parseFrom(InputStream) - Static method in class promc.io.ProMC.ProMCEvent
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent
 
parseFrom(CodedInputStream) - Static method in class promc.io.ProMC.ProMCEvent
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent
 
parseFrom(ByteString) - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
parseFrom(byte[]) - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
parseFrom(InputStream) - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
parseFrom(CodedInputStream) - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMC.ProMCEvent.Particles
 
parseFrom(ByteString) - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(byte[]) - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(InputStream) - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(CodedInputStream) - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(ByteString) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(byte[]) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(InputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(CodedInputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(ByteString) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(byte[]) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(InputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(CodedInputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(ByteString) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(byte[]) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(InputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(CodedInputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(ByteString) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(byte[]) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(InputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(CodedInputStream) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(ByteString) - Static method in class promc.io.ProMCStatFile.ProMCStat
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.ProMCStatFile.ProMCStat
 
parseFrom(byte[]) - Static method in class promc.io.ProMCStatFile.ProMCStat
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.ProMCStatFile.ProMCStat
 
parseFrom(InputStream) - Static method in class promc.io.ProMCStatFile.ProMCStat
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCStatFile.ProMCStat
 
parseFrom(CodedInputStream) - Static method in class promc.io.ProMCStatFile.ProMCStat
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCStatFile.ProMCStat
 
parseFrom(ByteString) - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(byte[]) - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(InputStream) - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(CodedInputStream) - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(ByteString) - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
parseFrom(byte[]) - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
parseFrom(InputStream) - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
parseFrom(CodedInputStream) - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent.Event
 
parseFrom(ByteString) - Static method in class pronlo.io.ProMC.ProMCEvent
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent
 
parseFrom(byte[]) - Static method in class pronlo.io.ProMC.ProMCEvent
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent
 
parseFrom(InputStream) - Static method in class pronlo.io.ProMC.ProMCEvent
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent
 
parseFrom(CodedInputStream) - Static method in class pronlo.io.ProMC.ProMCEvent
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent
 
parseFrom(ByteString) - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
parseFrom(byte[]) - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
parseFrom(InputStream) - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
parseFrom(CodedInputStream) - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMC.ProMCEvent.Particles
 
parseFrom(ByteString) - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(byte[]) - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(InputStream) - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(CodedInputStream) - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(ByteString) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(byte[]) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(InputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(CodedInputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(ByteString) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(byte[]) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(InputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(CodedInputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(ByteString) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(byte[]) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(InputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(CodedInputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(ByteString) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(byte[]) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(InputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(CodedInputStream) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(ByteString) - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
parseFrom(byte[]) - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
parseFrom(InputStream) - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
parseFrom(CodedInputStream) - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCStatFile.ProMCStat
 
parseFrom(ByteString) - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(byte[]) - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(InputStream) - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(CodedInputStream) - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(ByteString) - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
parseFrom(byte[]) - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
parseFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.BLJets
 
parseFrom(ByteString) - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
parseFrom(byte[]) - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
parseFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Electrons
 
parseFrom(ByteString) - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
parseFrom(byte[]) - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
parseFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Event
 
parseFrom(ByteString) - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
parseFrom(byte[]) - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
parseFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.GenJets
 
parseFrom(ByteString) - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
parseFrom(byte[]) - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
parseFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Jets
 
parseFrom(ByteString) - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
parseFrom(byte[]) - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
parseFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.MissingET
 
parseFrom(ByteString) - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
parseFrom(byte[]) - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
parseFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Muons
 
parseFrom(ByteString) - Static method in class proreco.io.ProMC.ProMCEvent
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent
 
parseFrom(byte[]) - Static method in class proreco.io.ProMC.ProMCEvent
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent
 
parseFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMC.ProMCEvent
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent
 
parseFrom(ByteString) - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
parseFrom(byte[]) - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
parseFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Particles
 
parseFrom(ByteString) - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
parseFrom(byte[]) - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
parseFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Photons
 
parseFrom(ByteString) - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
parseFrom(byte[]) - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
parseFrom(InputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMC.ProMCEvent.Tracks
 
parseFrom(ByteString) - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(byte[]) - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(InputStream) - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
parseFrom(ByteString) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(byte[]) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(InputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
parseFrom(ByteString) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(byte[]) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(InputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
parseFrom(ByteString) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(byte[]) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(InputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
parseFrom(ByteString) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(byte[]) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(InputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
parseFrom(ByteString) - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
parseFrom(byte[]) - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
parseFrom(InputStream) - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCStatFile.ProMCStat
 
parseFrom(ByteString) - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(ByteString, ExtensionRegistryLite) - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(byte[]) - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(byte[], ExtensionRegistryLite) - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(InputStream) - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(InputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(CodedInputStream) - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
parseFrom(CodedInputStream, ExtensionRegistryLite) - Static method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
ParseFunction - Class in graph
This class will parse a function definition and solve it returning the value.
ParseFunction() - Constructor for class graph.ParseFunction
Instantiate the class
ParseFunction(String) - Constructor for class graph.ParseFunction
Instantiate the class and define the string to parse.
parseFunction() - Method in class jplot3dp.ModelView.ModelFunction
 
parseHour(String) - Static method in class org.jfree.data.time.Hour
Creates an Hour instance by parsing a string.
ParseLevel1() - Method in class jplot3dp.MathParser.MathParser
 
ParseLevel2() - Method in class jplot3dp.MathParser.MathParser
 
ParseLevel3() - Method in class jplot3dp.MathParser.MathParser
 
parseMinute(String) - Static method in class org.jfree.data.time.Minute
Creates a Minute instance by parsing a string.
parseMonth(String) - Static method in class org.jfree.data.time.Month
Parses the string argument as a month.
parseNextCharacter(String, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
Parses source until a non-whitespace character is found.
parseNumber(String, NumberFormat, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
Parses source for a number.
parsePreprocSimp(String) - Method in class org.lsmp.djepJUnit.XJepTest
 
parseProcSimpEval(String, Object) - Method in class org.lsmp.djepJUnit.XJepTest
 
parseQuarter(String) - Static method in class org.jfree.data.time.Quarter
Parses the string argument as a quarter.
Parser - Class in org.nfunk.jep
 
Parser(InputStream) - Constructor for class org.nfunk.jep.Parser
 
Parser(Reader) - Constructor for class org.nfunk.jep.Parser
 
Parser(ParserTokenManager) - Constructor for class org.nfunk.jep.Parser
 
PARSER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
PARSER - Static variable in class proeic.io.ProMC.ProMCEvent
 
PARSER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
PARSER - Static variable in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
PARSER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
PARSER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
PARSER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
PARSER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
PARSER - Static variable in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
PARSER - Static variable in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
PARSER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
PARSER - Static variable in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
PARSER - Static variable in class promc.io.PBufFile.Record.F1D
 
PARSER - Static variable in class promc.io.PBufFile.Record.F2D
 
PARSER - Static variable in class promc.io.PBufFile.Record.FND
 
PARSER - Static variable in class promc.io.PBufFile.Record.FPR
 
PARSER - Static variable in class promc.io.PBufFile.Record.H1D
 
PARSER - Static variable in class promc.io.PBufFile.Record.H2D
 
PARSER - Static variable in class promc.io.PBufFile.Record.P0D
 
PARSER - Static variable in class promc.io.PBufFile.Record.P0I
 
PARSER - Static variable in class promc.io.PBufFile.Record.P1D
 
PARSER - Static variable in class promc.io.PBufFile.Record
 
PARSER - Static variable in class promc.io.PBufFile.Record.PND
 
PARSER - Static variable in class promc.io.PBufFile.Record.PNI
 
PARSER - Static variable in class promc.io.PBufFile.Record.PXY
 
PARSER - Static variable in class promc.io.PBufFile.Record.PXYZ
 
PARSER - Static variable in class promc.io.PEventFile.HEvent.Entry
 
PARSER - Static variable in class promc.io.PEventFile.HEvent.Group
 
PARSER - Static variable in class promc.io.PEventFile.HEvent
 
PARSER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
PARSER - Static variable in class promc.io.ProMC.ProMCEvent
 
PARSER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
PARSER - Static variable in class promc.io.ProMCDescriptionFile.ProMCDescription
 
PARSER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
PARSER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
PARSER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
PARSER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
PARSER - Static variable in class promc.io.ProMCStatFile.ProMCStat
 
PARSER - Static variable in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
PARSER - Static variable in class pronlo.io.ProMC.ProMCEvent.Event
 
PARSER - Static variable in class pronlo.io.ProMC.ProMCEvent
 
PARSER - Static variable in class pronlo.io.ProMC.ProMCEvent.Particles
 
PARSER - Static variable in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
PARSER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
PARSER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
PARSER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
PARSER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
PARSER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat
 
PARSER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
PARSER - Static variable in class proreco.io.ProMC.ProMCEvent.BLJets
 
PARSER - Static variable in class proreco.io.ProMC.ProMCEvent.Electrons
 
PARSER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
PARSER - Static variable in class proreco.io.ProMC.ProMCEvent.GenJets
 
PARSER - Static variable in class proreco.io.ProMC.ProMCEvent.Jets
 
PARSER - Static variable in class proreco.io.ProMC.ProMCEvent.MissingET
 
PARSER - Static variable in class proreco.io.ProMC.ProMCEvent.Muons
 
PARSER - Static variable in class proreco.io.ProMC.ProMCEvent
 
PARSER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
PARSER - Static variable in class proreco.io.ProMC.ProMCEvent.Photons
 
PARSER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
PARSER - Static variable in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
PARSER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
PARSER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
PARSER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
PARSER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
PARSER - Static variable in class proreco.io.ProMCStatFile.ProMCStat
 
PARSER - Static variable in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
ParserConstants - Interface in org.nfunk.jep
 
ParserDumpVisitor - Class in org.nfunk.jep
 
ParserDumpVisitor() - Constructor for class org.nfunk.jep.ParserDumpVisitor
 
ParserTokenManager - Class in org.nfunk.jep
 
ParserTokenManager(JavaCharStream) - Constructor for class org.nfunk.jep.ParserTokenManager
 
ParserTokenManager(JavaCharStream, int) - Constructor for class org.nfunk.jep.ParserTokenManager
 
ParserTreeConstants - Interface in org.nfunk.jep
 
ParserVisitor - Interface in org.nfunk.jep
 
parseSecond(String) - Static method in class org.jfree.data.time.Second
Creates a new instance by parsing a string.
parseStream(Reader, JEP) - Method in class org.nfunk.jep.Parser
 
parseText(Graphics) - Method in class graph.TextLine
parse the text.
parseWeek(String) - Static method in class org.jfree.data.time.Week
Parses the string argument as a week.
parseYear(String) - Static method in class org.jfree.data.time.Year
Parses the string argument as a year.
part(int, int, int, int) - Method in class cern.colt.bitvector.BitMatrix
Constructs and returns a new matrix with width columns and height rows which is a copy of the contents of the given box.
partFromTo(int, int) - Method in class cern.colt.bitvector.BitVector
Constructs and returns a new bit vector which is a copy of the given range.
partFromTo(int, int) - Method in class cern.colt.list.AbstractBooleanList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractByteList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractCharList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractDoubleList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractFloatList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractIntList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractLongList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractShortList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.ByteArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.CharArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.DoubleArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.FloatArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.IntArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.LongArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int, BitVector, int, long[], int) - Method in class cern.colt.list.MinMaxNumberList
Copies all elements between index from (inclusive) and to (inclusive) into part, starting at index partFrom within part.
partFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.ShortArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partialDerivative(int) - Method in interface org.apache.commons.math3.analysis.DifferentiableMultivariateFunction
Deprecated.
Returns the partial derivative of the function with respect to a point coordinate.
PartialDerivative - Class in org.lsmp.djep.djep
Contains infomation about a PartialDerivative of a variable.
partialDerivativeX(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
Deprecated.
 
partialDerivativeXX(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
Deprecated.
 
partialDerivativeXY(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
Deprecated.
 
partialDerivativeY(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
Deprecated.
 
partialDerivativeYY(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
Deprecated.
 
Particle - Interface in hep.physics.particle
Description of a particle equivalent to HEPevt description
ParticleD - Class in hephysics.jet
A class representing a jet or particle with pre-computed px,py,pz,e (double precision).
ParticleD() - Constructor for class hephysics.jet.ParticleD
Initialize pseudoparticle.
ParticleD(double, double, double, double) - Constructor for class hephysics.jet.ParticleD
Initialize from 4-momenta.
PARTICLEDATA_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
PARTICLEDATA_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
PARTICLEDATA_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
PARTICLEDATA_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
ParticleF - Class in hephysics.jet
A class representing a jet or particle with pre-computed et, et2, phi, eta (float values).
ParticleF(LParticle) - Constructor for class hephysics.jet.ParticleF
Initialize pseudoparticle.
ParticleF() - Constructor for class hephysics.jet.ParticleF
Initialize pseudoparticle.
ParticleF(float, float, float, float) - Constructor for class hephysics.jet.ParticleF
Initialize fast particle from 4-momenta.
PARTICLEID - Static variable in interface hep.lcio.event.LCIO
 
ParticleID - Interface in hep.lcio.event
Persistent interface for LCIO ParticleIDs.
ParticlePropertyManager - Class in hep.physics.particle.properties
This class represents the collected particle properties.
ParticlePropertyManager() - Constructor for class hep.physics.particle.properties.ParticlePropertyManager
 
ParticlePropertyProvider - Interface in hep.physics.particle.properties
 
PARTICLES_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent
 
PARTICLES_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent
 
PARTICLES_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent
 
PARTICLES_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent
 
particlesInJet(int) - Method in class hep.physics.jet.AbstractJetFinder
 
particlesInJet(int) - Method in class hep.physics.jet.FixNumberOfJetsFinder
 
particlesInJet(int) - Method in interface hep.physics.jet.JetFinder
Find out which particles are in a paricular jet
ParticleType - Interface in hep.physics.particle.properties
Describes physics properties of a particular type of particle
ParticleUtilities - Class in hep.physics.particle
 
partition(DoubleMatrix2D, int[], int, int, int, double[], int, int, int[]) - Static method in class cern.colt.matrix.doublealgo.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(DoubleMatrix2D, int, double[], int[]) - Static method in class cern.colt.matrix.doublealgo.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(ObjectMatrix2D, int[], int, int, int, Object[], int, int, int[]) - Static method in class cern.colt.matrix.objectalgo.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(ObjectMatrix2D, int, Object[], int[]) - Static method in class cern.colt.matrix.objectalgo.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(double[], int, int, double[], int, int, int[]) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it partitions double[] rather than int[] arrays.
partition(double[], int, int, double) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int) except that it partitions double[] rather than int[] arrays.
partition(int[], int, int, int[], int, int, int[]) - Static method in class cern.colt.Partitioning
Partitions (partially sorts) the given list such that all elements falling into some intervals are placed next to each other.
partition(int[], int, int, int) - Static method in class cern.colt.Partitioning
Partitions (partially sorts) the given list such that all elements falling into the given interval are placed next to each other.
partition(Object[], int, int, Object[], int, int, int[], Comparator) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it partitions Object[] rather than int[] arrays.
partition(Object[], int, int, Object, Comparator) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int) except that it synchronously partitions the objects of the given list by the order of the given comparator.
partition(DoubleArrayList, int, int, DoubleArrayList, IntArrayList) - Static method in class cern.colt.Partitioning
Equivalent to partition(list.elements(), from, to, splitters.elements(), 0, splitters.size()-1, splitIndexes.elements()).
partition(IntArrayList, int, int, IntArrayList, IntArrayList) - Static method in class cern.colt.Partitioning
Equivalent to partition(list.elements(), from, to, splitters.elements(), 0, splitters.size()-1, splitIndexes.elements()).
Partition - Class in jminhep.cluster
Interface class to all clustering algorithms.
Partition(DataHolder) - Constructor for class jminhep.cluster.Partition
 
PartitionCoefficient - Static variable in class jminhep.clcontrol.Global
 
Partitioning - Class in cern.colt.matrix.doublealgo
Given some interval boundaries, partitions matrices such that cell values falling into an interval are placed next to each other.
Partitioning - Class in cern.colt.matrix.objectalgo
Given some interval boundaries, partitions matrices such that cell values falling into an interval are placed next to each other.
Partitioning - Class in cern.colt
Given some interval boundaries, partitions arrays such that all elements falling into an interval are placed next to each other.
pascal - Static variable in class cern.clhep.Units
 
PascalDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Pascal distribution.
PascalDistribution(int, double) - Constructor for class org.apache.commons.math3.distribution.PascalDistribution
Create a Pascal distribution with the given number of successes and probability of success.
PascalDistribution(RandomGenerator, int, double) - Constructor for class org.apache.commons.math3.distribution.PascalDistribution
Create a Pascal distribution with the given number of successes and probability of success.
PassThroughDiffRule - Class in org.lsmp.djep.djep.diffRules
Rules like Sum where diff(sum(a,b,c),x) -> sum(da/dx,db/dx,dc/dx) are instance of this class.
PassThroughDiffRule(DJep, String) - Constructor for class org.lsmp.djep.djep.diffRules.PassThroughDiffRule
 
PassThroughDiffRule(String, PostfixMathCommandI) - Constructor for class org.lsmp.djep.djep.diffRules.PassThroughDiffRule
 
path - Variable in class org.jlab.groot.graphics.HistogramPlotter
 
PATH_COMPARATOR - Static variable in class org.apache.commons.io.comparator.PathFileComparator
Case-sensitive path comparator instance (see IOCase.SENSITIVE)
PATH_INSENSITIVE_COMPARATOR - Static variable in class org.apache.commons.io.comparator.PathFileComparator
Case-insensitive path comparator instance (see IOCase.INSENSITIVE)
PATH_INSENSITIVE_REVERSE - Static variable in class org.apache.commons.io.comparator.PathFileComparator
Reverse case-insensitive path comparator instance (see IOCase.INSENSITIVE)
PATH_REVERSE - Static variable in class org.apache.commons.io.comparator.PathFileComparator
Reverse case-sensitive path comparator instance (see IOCase.SENSITIVE)
PATH_SYSTEM_COMPARATOR - Static variable in class org.apache.commons.io.comparator.PathFileComparator
System sensitive path comparator instance (see IOCase.SYSTEM)
PATH_SYSTEM_REVERSE - Static variable in class org.apache.commons.io.comparator.PathFileComparator
Reverse system sensitive path comparator instance (see IOCase.SYSTEM)
PathFileComparator - Class in org.apache.commons.io.comparator
Compare the path of two files for order (see File.getPath()).
PathFileComparator() - Constructor for class org.apache.commons.io.comparator.PathFileComparator
Construct a case sensitive file path comparator instance.
PathFileComparator(IOCase) - Constructor for class org.apache.commons.io.comparator.PathFileComparator
Construct a file path comparator instance with the specified case-sensitivity.
pathNameOfPath(String) - Static method in class jhepsim.Util
 
pathNameOfPath(String) - Static method in class jhplot.utils.Util
 
pathNameOfPath(String) - Static method in class jminhep.utils.Util
 
PathUtils - Class in org.apache.commons.io.file
NIO Path utilities.
PaveText - Class in org.jlab.groot.ui
 
PaveText(int) - Constructor for class org.jlab.groot.ui.PaveText
 
PBufFile - Class in promc.io
 
PBufFile.Record - Class in promc.io
Protobuf type promc.Record
PBufFile.Record.Builder - Class in promc.io
Protobuf type promc.Record
PBufFile.Record.F1D - Class in promc.io
Protobuf type promc.Record.F1D
PBufFile.Record.F1D.Builder - Class in promc.io
Protobuf type promc.Record.F1D
PBufFile.Record.F1DOrBuilder - Interface in promc.io
 
PBufFile.Record.F2D - Class in promc.io
Protobuf type promc.Record.F2D
PBufFile.Record.F2D.Builder - Class in promc.io
Protobuf type promc.Record.F2D
PBufFile.Record.F2DOrBuilder - Interface in promc.io
 
PBufFile.Record.FND - Class in promc.io
Protobuf type promc.Record.FND
PBufFile.Record.FND.Builder - Class in promc.io
Protobuf type promc.Record.FND
PBufFile.Record.FNDOrBuilder - Interface in promc.io
 
PBufFile.Record.FPR - Class in promc.io
Protobuf type promc.Record.FPR
PBufFile.Record.FPR.Builder - Class in promc.io
Protobuf type promc.Record.FPR
PBufFile.Record.FPROrBuilder - Interface in promc.io
 
PBufFile.Record.H1D - Class in promc.io
Protobuf type promc.Record.H1D
PBufFile.Record.H1D.Builder - Class in promc.io
Protobuf type promc.Record.H1D
PBufFile.Record.H1DOrBuilder - Interface in promc.io
 
PBufFile.Record.H2D - Class in promc.io
Protobuf type promc.Record.H2D
PBufFile.Record.H2D.Builder - Class in promc.io
Protobuf type promc.Record.H2D
PBufFile.Record.H2DOrBuilder - Interface in promc.io
 
PBufFile.Record.P0D - Class in promc.io
Protobuf type promc.Record.P0D
PBufFile.Record.P0D.Builder - Class in promc.io
Protobuf type promc.Record.P0D
PBufFile.Record.P0DOrBuilder - Interface in promc.io
 
PBufFile.Record.P0I - Class in promc.io
Protobuf type promc.Record.P0I
PBufFile.Record.P0I.Builder - Class in promc.io
Protobuf type promc.Record.P0I
PBufFile.Record.P0IOrBuilder - Interface in promc.io
 
PBufFile.Record.P1D - Class in promc.io
Protobuf type promc.Record.P1D
PBufFile.Record.P1D.Builder - Class in promc.io
Protobuf type promc.Record.P1D
PBufFile.Record.P1DOrBuilder - Interface in promc.io
 
PBufFile.Record.PND - Class in promc.io
Protobuf type promc.Record.PND
PBufFile.Record.PND.Builder - Class in promc.io
Protobuf type promc.Record.PND
PBufFile.Record.PNDOrBuilder - Interface in promc.io
 
PBufFile.Record.PNI - Class in promc.io
Protobuf type promc.Record.PNI
PBufFile.Record.PNI.Builder - Class in promc.io
Protobuf type promc.Record.PNI
PBufFile.Record.PNIOrBuilder - Interface in promc.io
 
PBufFile.Record.PXY - Class in promc.io
Protobuf type promc.Record.PXY
PBufFile.Record.PXY.Builder - Class in promc.io
Protobuf type promc.Record.PXY
PBufFile.Record.PXYOrBuilder - Interface in promc.io
 
PBufFile.Record.PXYZ - Class in promc.io
Protobuf type promc.Record.PXYZ
PBufFile.Record.PXYZ.Builder - Class in promc.io
Protobuf type promc.Record.PXYZ
PBufFile.Record.PXYZOrBuilder - Interface in promc.io
 
PBufFile.RecordOrBuilder - Interface in promc.io
 
PCA - Class in jhplot.math.pca
The class responsible mainly for preparing the PCA transformation parameters based on training data and executing the actual transformation on test data.
PCA(Matrix) - Constructor for class jhplot.math.pca.PCA
Create the PCA transformation.
PCA(Matrix, boolean) - Constructor for class jhplot.math.pca.PCA
Create the PCA transformation.
PCA(Matrix, CovarianceMatrixEVDCalculator) - Constructor for class jhplot.math.pca.PCA
Create the PCA transformation.
PCA(Matrix, CovarianceMatrixEVDCalculator, boolean) - Constructor for class jhplot.math.pca.PCA
Create the PCA transformation
PCA - Class in jhplot.stat
Perform a principle component analysis
PCA(double[][]) - Constructor for class jhplot.stat.PCA
Initialize 2D PCA analysis
PCA(P1D) - Constructor for class jhplot.stat.PCA
Perform PCA analysis using P1D object (in 2D).
PCA.TransformationType - Enum in jhplot.math.pca
Type of the possible data transformation.
PConstant - Class in org.lsmp.djep.sjep
Represents a constant.
PConstant(PolynomialCreator, Object) - Constructor for class org.lsmp.djep.sjep.PConstant
 
pdf(double) - Method in class cern.jet.random.Beta
Returns the cumulative distribution function.
pdf(int) - Method in class cern.jet.random.Binomial
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.ChiSquare
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.Empirical
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.Empirical
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.EmpiricalWalker
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.Exponential
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.Gamma
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.HyperGeometric
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.NegativeBinomial
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.Normal
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.Poisson
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.StudentT
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.Uniform
Returns the probability distribution function (assuming a continous uniform distribution).
PDF1_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
PDF1_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
PDF1_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
PDF1_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
PDF1_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
PDF1_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
PDF1_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
PDF2_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
PDF2_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
PDF2_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
PDF2_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
PDF2_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
PDF2_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
PDF2_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
PDF_ID1_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
PDF_ID1_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
PDF_ID1_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
PDF_ID1_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
PDF_ID2_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
PDF_ID2_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
PDF_ID2_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
PDF_ID2_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
PDG_ID_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
PDG_ID_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
PDG_ID_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent.Particles
 
PDG_ID_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
PDGDatabase - Class in j4np.physics
PDG database class.
PDGDatabase() - Constructor for class j4np.physics.PDGDatabase
 
PDGParticle - Class in j4np.physics
 
PDGParticle(String, int, double) - Constructor for class j4np.physics.PDGParticle
 
PDGParticle(String, int, double, int) - Constructor for class j4np.physics.PDGParticle
 
PDGParticle(String, int, int, double, int) - Constructor for class j4np.physics.PDGParticle
 
PDGParticle(String, int, double, int, double) - Constructor for class j4np.physics.PDGParticle
 
PearsonsCorrelation - Class in org.apache.commons.math3.stat.correlation
Computes Pearson's product-moment correlation coefficients for pairs of arrays or columns of a matrix.
PearsonsCorrelation() - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation instance without data.
PearsonsCorrelation(double[][]) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a rectangular array whose columns represent values of variables to be correlated.
PearsonsCorrelation(RealMatrix) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a RealMatrix whose columns represent variables to be correlated.
PearsonsCorrelation(Covariance) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a Covariance.
PearsonsCorrelation(RealMatrix, int) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a covariance matrix.
peek(byte[], int, int) - Method in class org.apache.commons.io.input.buffer.CircularByteBuffer
Returns, whether the next bytes in the buffer are exactly those, given by sourceBuffer, offset, and length.
peek(byte[]) - Method in class org.apache.commons.io.input.buffer.PeekableInputStream
Returns, whether the next bytes in the buffer are as given by sourceBuffer.
peek(byte[], int, int) - Method in class org.apache.commons.io.input.buffer.PeekableInputStream
Returns, whether the next bytes in the buffer are as given by sourceBuffer, {code offset}, and length.
PeekableInputStream - Class in org.apache.commons.io.input.buffer
Implementation of a buffered input stream, which allows to peek into the buffers first bytes.
PeekableInputStream(InputStream, int) - Constructor for class org.apache.commons.io.input.buffer.PeekableInputStream
Creates a new instance, which filters the given input stream, and uses the given buffer size.
PeekableInputStream(InputStream) - Constructor for class org.apache.commons.io.input.buffer.PeekableInputStream
Creates a new instance, which filters the given input stream, and uses a reasonable default buffer size (8192).
peg(Calendar) - Method in class org.jfree.data.time.Day
Recalculates the start date/time and end date/time for this time period relative to the supplied calendar (which incorporates a time zone).
peg(Calendar) - Method in class org.jfree.data.time.FixedMillisecond
This method is overridden to do nothing.
peg(Calendar) - Method in class org.jfree.data.time.Hour
Recalculates the start date/time and end date/time for this time period relative to the supplied calendar (which incorporates a time zone).
peg(Calendar) - Method in class org.jfree.data.time.Millisecond
Recalculates the start date/time and end date/time for this time period relative to the supplied calendar (which incorporates a time zone).
peg(Calendar) - Method in class org.jfree.data.time.Minute
Recalculates the start date/time and end date/time for this time period relative to the supplied calendar (which incorporates a time zone).
peg(Calendar) - Method in class org.jfree.data.time.Month
Recalculates the start date/time and end date/time for this time period relative to the supplied calendar (which incorporates a time zone).
peg(Calendar) - Method in class org.jfree.data.time.Quarter
Recalculates the start date/time and end date/time for this time period relative to the supplied calendar (which incorporates a time zone).
peg(Calendar) - Method in class org.jfree.data.time.RegularTimePeriod
Recalculates the start date/time and end date/time for this time period relative to the supplied calendar (which incorporates a time zone).
peg(Calendar) - Method in class org.jfree.data.time.Second
Recalculates the start date/time and end date/time for this time period relative to the supplied calendar (which incorporates a time zone).
peg(Calendar) - Method in class org.jfree.data.time.Week
Recalculates the start date/time and end date/time for this time period relative to the supplied calendar (which incorporates a time zone).
peg(Calendar) - Method in class org.jfree.data.time.Year
Recalculates the start date/time and end date/time for this time period relative to the supplied calendar (which incorporates a time zone).
PegasusSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Pegasus method for root-finding (approximating a zero of a univariate real function).
PegasusSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
Construct a solver with default accuracy (1e-6).
PegasusSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
Construct a solver.
PegasusSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
Construct a solver.
PegasusSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
Construct a solver.
pelzGood(double, int) - Method in class org.apache.commons.math3.stat.inference.KolmogorovSmirnovTest
Computes the Pelz-Good approximation for \(P(D_n < d)\) as described in [2] in the class javadoc.
perCent - Static variable in class cern.clhep.Units
 
percentageValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction percentage as a double.
percentageValue() - Method in class org.apache.commons.math3.fraction.Fraction
Gets the fraction percentage as a double.
percentFromTo(float, float) - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns the percentage of elements in the range (from,to].
percentile(double[], double) - Static method in class jhplot.math.ArrayMathUtils
Gives the percentile of an array
percentile(int[], double) - Static method in class jhplot.math.ArrayMathUtils
Gives the percentile of an array.
Percentile - Class in org.apache.commons.math3.stat.descriptive.rank
Provides percentile computation.
Percentile() - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Percentile
Constructs a Percentile with the following defaults.
Percentile(double) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Percentile
Constructs a Percentile with the specific quantile value and the following default method type: Percentile.EstimationType.LEGACY default NaN strategy: NaNStrategy.REMOVED a Kth Selector : KthSelector
Percentile(Percentile) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Percentile
Copy constructor, creates a new Percentile identical to the original
percentile(double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns an estimate of the pth percentile of the values in the values array.
percentile(double[], int, int, double) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns an estimate of the pth percentile of the values in the values array, starting with the element in (0-based) position begin in the array and including length values.
Percentile.EstimationType - Enum in org.apache.commons.math3.stat.descriptive.rank
An enum for various estimation strategies of a percentile referred in wikipedia on quantile with the names of enum matching those of types mentioned in wikipedia.
PeriodAxis - Class in org.jfree.chart.axis
An axis that displays a date scale based on a RegularTimePeriod.
PeriodAxis(String) - Constructor for class org.jfree.chart.axis.PeriodAxis
Creates a new axis.
PeriodAxis(String, RegularTimePeriod, RegularTimePeriod) - Constructor for class org.jfree.chart.axis.PeriodAxis
Creates a new axis.
PeriodAxis(String, RegularTimePeriod, RegularTimePeriod, TimeZone) - Constructor for class org.jfree.chart.axis.PeriodAxis
Deprecated.
As of version 1.0.13, you should use the constructor that specifies a Locale also.
PeriodAxis(String, RegularTimePeriod, RegularTimePeriod, TimeZone, Locale) - Constructor for class org.jfree.chart.axis.PeriodAxis
Creates a new axis.
PeriodAxisLabelInfo - Class in org.jfree.chart.axis
A record that contains information for one "band" of date labels in a PeriodAxis.
PeriodAxisLabelInfo(Class, DateFormat) - Constructor for class org.jfree.chart.axis.PeriodAxisLabelInfo
Creates a new instance.
PeriodAxisLabelInfo(Class, DateFormat, RectangleInsets, Font, Paint, boolean, Stroke, Paint) - Constructor for class org.jfree.chart.axis.PeriodAxisLabelInfo
Creates a new instance.
perMillion - Static variable in class cern.clhep.Units
 
permutation(long, int) - Static method in class cern.colt.GenericPermuting
Returns the p-th permutation of the sequence [0,1,...,N-1].
Permutation - Class in org.lsmp.djep.groupJep.values
 
Permutation(GroupI, Integer[]) - Constructor for class org.lsmp.djep.groupJep.values.Permutation
 
PermutationChromosome<T> - Interface in org.apache.commons.math3.genetics
Interface indicating that the chromosome represents a permutation of objects.
PermutationGroup - Class in org.lsmp.djep.groupJep.groups
The group of permutations.
PermutationGroup(int) - Constructor for class org.lsmp.djep.groupJep.groups.PermutationGroup
 
permute(int[], int[]) - Static method in class cern.colt.GenericPermuting
A non-generic variant of reordering, specialized for int[], same semantics.
permute(int[], Swapper, int[]) - Static method in class cern.colt.GenericPermuting
Deprecated. 
permute(int[], Swapper, int[], int[]) - Static method in class cern.colt.GenericPermuting
Generically reorders arbitrary shaped generic data g such that g[i] == g[indexes[i]].
permute(Object[], int[]) - Static method in class cern.colt.GenericPermuting
A non-generic variant of reordering, specialized for Object[], same semantics.
permute(DoubleMatrix1D, int[], double[]) - Method in class cern.colt.matrix.linalg.Algebra
Modifies the given vector A such that it is permuted as specified; Useful for pivoting.
permute(DoubleMatrix2D, int[], int[]) - Method in class cern.colt.matrix.linalg.Algebra
Constructs and returns a new row and column permuted selection view of matrix A; equivalent to DoubleMatrix2D.viewSelection(int[],int[]).
permute(int[], Object[], boolean) - Static method in class jhplot.math.SortUtils
Rearrange the specified data according to the specified permutation.
permuteColumns(DoubleMatrix2D, int[], int[]) - Method in class cern.colt.matrix.linalg.Algebra
Modifies the given matrix A such that it's columns are permuted as specified; Useful for pivoting.
permuteRows(DoubleMatrix2D, int[], int[]) - Method in class cern.colt.matrix.linalg.Algebra
Modifies the given matrix A such that it's rows are permuted as specified; Useful for pivoting.
perp() - Method in class hephysics.jet.ParticleD
Compute transverse momentum (pT).
perp() - Method in class hephysics.jet.ParticleF
Same as getEt().
perp() - Method in class hephysics.vec.Hep3Vector
Transverse
perp() - Method in class hephysics.vec.HepLorentzVector
Transverse momentum.
perp2() - Method in class hephysics.jet.ParticleD
Compute pT**2.
perp2() - Method in class hephysics.vec.Hep3Vector
Transverse
perp2() - Method in class hephysics.vec.HepLorentzVector
Transverse momentum squared
PersistentObject - Class in cern.colt
This empty class is the common root for all persistent capable classes.
perThousand - Static variable in class cern.clhep.Units
 
petaelectronvolt - Static variable in class cern.clhep.Units
 
PeV - Static variable in class cern.clhep.Units
 
PEventFile - Class in promc.io
 
PEventFile.HEvent - Class in promc.io
Protobuf type promc.HEvent
PEventFile.HEvent.Builder - Class in promc.io
Protobuf type promc.HEvent
PEventFile.HEvent.Entry - Class in promc.io
Protobuf type promc.HEvent.Entry
PEventFile.HEvent.Entry.Builder - Class in promc.io
Protobuf type promc.HEvent.Entry
PEventFile.HEvent.EntryOrBuilder - Interface in promc.io
 
PEventFile.HEvent.Group - Class in promc.io
Protobuf type promc.HEvent.Group
PEventFile.HEvent.Group.Builder - Class in promc.io
Protobuf type promc.HEvent.Group
PEventFile.HEvent.GroupOrBuilder - Interface in promc.io
 
PEventFile.HEventOrBuilder - Interface in promc.io
 
PFile - Class in jhplot.io
Write or read objects in sequential order using Google's Prototype Buffer scheme.
PFile(String, String, boolean) - Constructor for class jhplot.io.PFile
Open a file to write/read objects to/from a file in sequential order.
PFile(String) - Constructor for class jhplot.io.PFile
Open file for reading objects from a serialized file in sequential order.
PFile(String, String) - Constructor for class jhplot.io.PFile
Open file for reading objects from a serialized file in sequential order.
PFunction - Class in org.lsmp.djep.sjep
Represents a function.
PFunction(PolynomialCreator, String, PostfixMathCommandI, PNodeI[]) - Constructor for class org.lsmp.djep.sjep.PFunction
 
pha(Rot, Zmat, int, int, int, int) - Static method in class Jampack.Rot
Multiplies rows (ii1,jj1:jj2) and (ii2,jj1:jj2) of a Zmat (altered) by the conjugate transpose of a plane rotation.
phi(double) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Returns how many percent of the elements contained in the receiver are <= element.
phi(float) - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns how many percent of the elements contained in the receiver are <= element.
phi() - Method in class hep.physics.vec.SpacePoint
Cylindrical phi
phi(Hep3Vector) - Static method in class hep.physics.vec.VecOp
 
phi() - Method in class hephysics.jet.ParticleD
Compute Phi
phi() - Method in class hephysics.vec.Hep3Vector
Phi
phi() - Method in class hephysics.vec.HepLorentzVector
Phi
phi() - Method in class hephysics.vec.SpacePoint
Cylindrical phi
phi(Hep3Vector) - Static method in class hephysics.vec.VecOp
 
phi() - Method in class j4np.physics.LorentzVector
 
phi() - Method in class j4np.physics.Vector3
 
Phi(double) - Static method in class org.jlab.groot.math.ErrorFunction
 
PHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.BLJets
 
PHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Electrons
 
PHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.GenJets
 
PHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Jets
 
PHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.MissingET
 
PHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Muons
 
PHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
PHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Photons
 
PHI_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
PHIOUTER_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
PHOTONS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent
 
PhysicalConstants - Class in cern.clhep
High Energy Physics coherent Physical Constants.
physicalConstants - Static variable in class cern.clhep.PhysicalConstants
Little trick to allow for "aliasing", that is, renaming this class.
pi - Static variable in class cern.clhep.PhysicalConstants
 
PI - Static variable in class org.apache.commons.math3.util.FastMath
Archimede's constant PI, ratio of circle circumference to diameter.
pi2 - Static variable in class cern.clhep.PhysicalConstants
 
PI_2 - Static variable in interface jhplot.math.num.Constants
2 π.
PI_OVER_2 - Static variable in class org.jlab.groot.math.FunctionFactory
 
PI_SQUARED - Static variable in class org.apache.commons.math3.util.MathUtils
\(\pi^2\)
picobarn - Static variable in class cern.clhep.Units
 
picofarad - Static variable in class cern.clhep.Units
 
picosecond - Static variable in class cern.clhep.Units
 
Picture - Class in jhplot.shapes
Insert a picture in the PNG or GIF format.
Picture(double, double, String) - Constructor for class jhplot.shapes.Picture
Create a picture object in the USER coordinates
Picture(double, double, Image) - Constructor for class jhplot.shapes.Picture
Create a picture object in the USER coordinates
pid() - Method in class j4np.physics.PDGParticle
 
PIE - Static variable in class org.jfree.chart.plot.DialShape
Pie.
PiecewiseBicubicSplineInterpolatingFunction - Class in org.apache.commons.math3.analysis.interpolation
Function that implements the bicubic spline interpolation.
PiecewiseBicubicSplineInterpolatingFunction(double[], double[], double[][]) - Constructor for class org.apache.commons.math3.analysis.interpolation.PiecewiseBicubicSplineInterpolatingFunction
 
PiecewiseBicubicSplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Generates a piecewise-bicubic interpolating function.
PiecewiseBicubicSplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.PiecewiseBicubicSplineInterpolator
 
PieChartDemo1 - Class in org.jfree.chart.demo
A simple demonstration application showing how to create a pie chart using data from a DefaultPieDataset.
PieChartDemo1(String) - Constructor for class org.jfree.chart.demo.PieChartDemo1
Default constructor.
PieChartFXDemo1 - Class in org.jfree.chart.fx.demo
A pie chart demo in JavaFX.
PieChartFXDemo1() - Constructor for class org.jfree.chart.fx.demo.PieChartFXDemo1
 
PieDataset - Interface in org.jfree.data.general
A general purpose dataset where values are associated with keys.
PIEDATASET_TAG - Static variable in interface org.jfree.data.xml.DatasetTags
The 'PieDataset' element name.
PieDatasetHandler - Class in org.jfree.data.xml
A SAX handler for reading a PieDataset from an XML file.
PieDatasetHandler() - Constructor for class org.jfree.data.xml.PieDatasetHandler
Default constructor.
PieLabelDistributor - Class in org.jfree.chart.plot
This class distributes the section labels for one side of a pie chart so that they do not overlap.
PieLabelDistributor(int) - Constructor for class org.jfree.chart.plot.PieLabelDistributor
Creates a new distributor.
PieLabelLinkStyle - Class in org.jfree.chart.plot
Used to indicate the style for the lines linking pie sections to their corresponding labels.
PieLabelRecord - Class in org.jfree.chart.plot
A structure that retains information about the label for a section in a pie chart.
PieLabelRecord(Comparable, double, double, TextBox, double, double, double) - Constructor for class org.jfree.chart.plot.PieLabelRecord
Creates a new record.
PiePlot - Class in org.jfree.chart.plot
A plot that displays data in the form of a pie chart, using data from any class that implements the PieDataset interface.
PiePlot() - Constructor for class org.jfree.chart.plot.PiePlot
Creates a new plot.
PiePlot(PieDataset) - Constructor for class org.jfree.chart.plot.PiePlot
Creates a plot that will draw a pie chart for the specified dataset.
PiePlot3D - Class in org.jfree.chart.plot
A plot that displays data in the form of a 3D pie chart, using data from any class that implements the PieDataset interface.
PiePlot3D() - Constructor for class org.jfree.chart.plot.PiePlot3D
Creates a new instance with no dataset.
PiePlot3D(PieDataset) - Constructor for class org.jfree.chart.plot.PiePlot3D
Creates a pie chart with a three dimensional effect using the specified dataset.
PiePlotState - Class in org.jfree.chart.plot
A renderer state.
PiePlotState(PlotRenderingInfo) - Constructor for class org.jfree.chart.plot.PiePlotState
Creates a new object for recording temporary state information for a renderer.
PieSectionEntity - Class in org.jfree.chart.entity
A chart entity that represents one section within a pie plot.
PieSectionEntity(Shape, PieDataset, int, int, Comparable, String, String) - Constructor for class org.jfree.chart.entity.PieSectionEntity
Creates a new pie section entity.
PieSectionLabelGenerator - Interface in org.jfree.chart.labels
Interface for a label generator for plots that use data from a PieDataset.
PieToolTipGenerator - Interface in org.jfree.chart.labels
A tool tip generator that is used by the PiePlot class.
PieURLGenerator - Interface in org.jfree.chart.urls
Interface for a URL generator for plots that use data from a PieDataset.
Pin() - Constructor for class org.jfree.chart.plot.dial.DialPointer.Pin
Creates a new instance.
Pin(int) - Constructor for class org.jfree.chart.plot.dial.DialPointer.Pin
Creates a new instance.
PinNeedle - Class in org.jfree.chart.needle
A needle that is drawn as a pin shape.
PinNeedle() - Constructor for class org.jfree.chart.needle.PinNeedle
 
PIPER_X1 - Static variable in class jplot.GraphLabel
 
PIPER_X2 - Static variable in class jplot.GraphLabel
 
PIPER_Y1 - Static variable in class jplot.GraphLabel
 
PIPER_Y2 - Static variable in class jplot.GraphLabel
 
PIPER_Y3 - Static variable in class jplot.GraphLabel
 
PIPER_Y4 - Static variable in class jplot.GraphLabel
 
PiperOptions - Class in jplot
Here we create a panel which allows a user to modify several parameters specific to piper diagrams.
PiperOptions(JPlot, GraphSettings) - Constructor for class jplot.PiperOptions
Principal constructor.
Pivot - Class in Jampack
Pivot applys a sequence of pivot operations to the rows of a matrix.
Pivot() - Constructor for class Jampack.Pivot
 
pivotIndex(double[], int, int) - Method in class org.apache.commons.math3.util.CentralPivotingStrategy
Find pivot index of the array so that partition and Kth element selection can be made
pivotIndex(double[], int, int) - Method in class org.apache.commons.math3.util.MedianOf3PivotingStrategy
Find pivot index of the array so that partition and Kth element selection can be made
pivotIndex(double[], int, int) - Method in interface org.apache.commons.math3.util.PivotingStrategyInterface
Find pivot index of the array so that partition and Kth element selection can be made
pivotIndex(double[], int, int) - Method in class org.apache.commons.math3.util.RandomPivotingStrategy
Find pivot index of the array so that partition and Kth element selection can be made
PivotingStrategyInterface - Interface in org.apache.commons.math3.util
A strategy to pick a pivoting index of an array for doing partitioning.
PivotSelectionRule - Enum in org.apache.commons.math3.optim.linear
Pivot selection rule to the use for a Simplex solver.
PLANCK - Static variable in class graph.SpecialFunction
Planck constant.
Plane - Class in org.apache.commons.math3.geometry.euclidean.threed
The class represent planes in a three dimensional space.
Plane(Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a plane normal to a given direction and containing the origin.
Plane(Vector3D, Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a plane from a point and a normal.
Plane(Vector3D, Vector3D, Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a plane from three points.
Plane(Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Deprecated.
as of 3.3, replaced with Plane.Plane(Vector3D, double)
Plane(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Deprecated.
Plane(Vector3D, Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Deprecated.
Plane(Plane) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Copy constructor.
PLOT - Static variable in class jminhep.gui.SetEnv
 
plot(List<Point>) - Method in class org.freehep.math.minuit.MnPlot
 
plot(double, double, List<Point>) - Method in class org.freehep.math.minuit.MnPlot
 
Plot - Class in org.jfree.chart.plot
The base class for all plots in JFreeChart.
PLOT_COLOR_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
PLOT_FUNCTION_1_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
PLOT_FUNCTION_2_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
plot_type - Variable in class jplot3d.JSurface
 
PLOT_TYPE_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
plotArea(int, int, int, int, int, int) - Method in class jplot3d.JSurface
Plots an area of group of planes
plotboth - Variable in class jplot3d.JSurface
 
plotChanged(PlotChangeEvent) - Method in interface org.jfree.chart.event.PlotChangeListener
Receives notification of a plot change event.
plotChanged(PlotChangeEvent) - Method in class org.jfree.chart.JFreeChart
Receives notification that the plot has changed, and passes this on to registered listeners.
plotChanged(PlotChangeEvent) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Receives a PlotChangeEvent and responds by notifying all listeners.
plotChanged(PlotChangeEvent) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Receives a PlotChangeEvent and responds by notifying all listeners.
plotChanged(PlotChangeEvent) - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Receives a PlotChangeEvent and responds by notifying all listeners.
plotChanged(PlotChangeEvent) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Receives a PlotChangeEvent and responds by notifying all listeners.
PlotChangeEvent - Class in org.jfree.chart.event
An event that can be forwarded to any PlotChangeListener to signal a change to a plot.
PlotChangeEvent(Plot) - Constructor for class org.jfree.chart.event.PlotChangeEvent
Creates a new PlotChangeEvent.
PlotChangeListener - Interface in org.jfree.chart.event
The interface that must be supported by classes that wish to receive notification of changes to a plot.
PlotEntity - Class in org.jfree.chart.entity
A class that captures information about a plot.
PlotEntity(Shape, Plot) - Constructor for class org.jfree.chart.entity.PlotEntity
Creates a new plot entity.
PlotEntity(Shape, Plot, String) - Constructor for class org.jfree.chart.entity.PlotEntity
Creates a new plot entity.
PlotEntity(Shape, Plot, String, String) - Constructor for class org.jfree.chart.entity.PlotEntity
Creates a new plot entity.
plotFrame - Variable in class jplot.JPlot
 
plotfunc1 - Variable in class jplot3d.JSurface
 
plotfunc2 - Variable in class jplot3d.JSurface
 
PlotOrientation - Class in org.jfree.chart.plot
Used to indicate the orientation (horizontal or vertical) of a 2D plot.
plotPanels - Variable in class jplot.JPlot
 
PlotPoint - Class in jplot
The PlotPoint defines a plot point in terms of it's X- and Y value.
PlotPoint() - Constructor for class jplot.PlotPoint
Default constructor, does nothing.
PlotPoint(double, double) - Constructor for class jplot.PlotPoint
Default constructor, initializes the class x- and y values.
PlotPoint(double, double, double, double) - Constructor for class jplot.PlotPoint
Default constructor, initializes the class x- and y values.
PlotPoint(double, double, double, double, double, double) - Constructor for class jplot.PlotPoint
Default constructor, initializes the class x- and y values, including stat error.
PlotPoint(double, double, double, double, double, double, double, double, double, double) - Constructor for class jplot.PlotPoint
Default constructor, initializes the class x- and y values, including stat and sys errors alos includes errors
PlotPoint(double, double, boolean) - Constructor for class jplot.PlotPoint
Initializes the class x- and y values and sets the lift attribute.
PlotPoint(PlotPoint) - Constructor for class jplot.PlotPoint
Another constructor, initializes the class x- and y values.
PlotPoint2D - Class in jplot
The PlotPoint2D defines a plot point in terms of it's X , Y and Z value.
PlotPoint2D() - Constructor for class jplot.PlotPoint2D
Default constructor, does nothing.
PlotPoint2D(double, double, double) - Constructor for class jplot.PlotPoint2D
Default constructor, initializes the class x- and y values.
PlotPoint2D(PlotPoint2D) - Constructor for class jplot.PlotPoint2D
Another constructor, initializes the class x- and y values.
PlotPoint3D - Class in jplot
The PlotPoint3D defines a plot point in terms of it's X , Y and Z value, and also sets extension in each direction.
PlotPoint3D() - Constructor for class jplot.PlotPoint3D
Default constructor, does nothing.
PlotPoint3D(double, double, double, double, double, double) - Constructor for class jplot.PlotPoint3D
Default constructor, initializes the class x,y,z and extension in 3D.
PlotPoint3D(PlotPoint3D) - Constructor for class jplot.PlotPoint3D
Another constructor, initializes the class x- and y values.
PlotRenderingInfo - Class in org.jfree.chart.plot
Stores information about the dimensions of a plot and its subplots.
PlotRenderingInfo(ChartRenderingInfo) - Constructor for class org.jfree.chart.plot.PlotRenderingInfo
Creates a new instance.
PlotState - Class in org.jfree.chart.plot
Records information about the state of a plot during the drawing process.
PlotState() - Constructor for class org.jfree.chart.plot.PlotState
Creates a new state object.
Plottable - Class in jhplot
All objects which can be plottable should implement this class.
Plottable() - Constructor for class jhplot.Plottable
Sets drawing options
Plotter - Class in jminhep.gui
Interface to JFreeChart
Plotter() - Constructor for class jminhep.gui.Plotter
 
PlotterImpl() - Constructor for class jplot3d.SurfaceModelCanvas.PlotterImpl
Main constructor
PlotUtilities - Class in org.jfree.chart.plot
Some utility methods related to the plot classes.
PlotUtilities() - Constructor for class org.jfree.chart.plot.PlotUtilities
 
plotValue(float, float, float, int, int, boolean, int) - Static method in class jplot.Axis
lower level method to determine a screen location where a given value should be plotted given range, type, and screen information.
PlumNeedle - Class in org.jfree.chart.needle
A needle for use with the CompassPlot class.
PlumNeedle() - Constructor for class org.jfree.chart.needle.PlumNeedle
 
plus(DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A + s <=> A[i] = A[i] + s.
plus(DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A + B <=> A[i] = A[i] + B[i].
plus(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A + s <=> A[row,col] = A[row,col] + s.
plus(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A + B <=> A[row,col] = A[row,col] + B[row,col].
plus(Timer) - Method in class cern.colt.Timer
T = this + other; Constructs and returns a new timer which is the sum of the receiver and the other timer.
plus - Static variable in class cern.jet.math.Functions
Function that returns a + b.
plus(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a + b.
plus - Static variable in class cern.jet.math.IntFunctions
Function that returns a + b.
plus(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a + b.
plus(Matrix) - Method in class Jama.Matrix
C = A + B
Plus - Class in Jampack
Plus Computes the sum of two matrices.
Plus() - Constructor for class Jampack.Plus
 
Plus(Z, Z) - Method in class Jampack.Z
Computes the sum of two Z's.
plus(Complex) - Method in class jhplot.math.Complex
Addition of Complex numbers (doesn't change this Complex number).
plus(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
C = A + B
plus(double[]...) - Static method in class jhplot.math.LinearAlgebra
Element-wise sum of any number of arrays.
plus(double[], double) - Static method in class jhplot.math.LinearAlgebra
Add a scalar value to each element of an array.
plus(double[][], double[][]) - Static method in class jhplot.math.LinearAlgebra
Element-wise sum of two matrices
plus(double[][], double) - Static method in class jhplot.math.LinearAlgebra
Add a scalar to each element of a matrix.
plus(ValueErr, double) - Method in class jhplot.math.ValueErr
Add 2 values with correlation
plus(ValueErr, ValueErr, double) - Method in class jhplot.math.ValueErr
Adding 2 values with correlation
plus(ValueErr) - Method in class jhplot.math.ValueErr
Add a ValueErr number to this ValueErr number without correlaton
plus(ValueErr, ValueErr) - Method in class jhplot.math.ValueErr
Add two ValueErr numbers with no correlation
plus(double) - Method in class jhplot.math.ValueErr
Add an error free double number to this ValueErr number
plus(double, ValueErr) - Method in class jhplot.math.ValueErr
Add a ValueErr number to an error free double
plus(double, double) - Method in class jhplot.math.ValueErr
Add an error free double number to an error free double and return sum
PLUS - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
PLUS - Static variable in interface org.nfunk.jep.ParserConstants
 
plus2PI(double) - Static method in class net.jafama.NumbersUtils
 
plus2PI_strict(double) - Static method in class net.jafama.NumbersUtils
Strict version.
PLUS_I - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
First canonical vector (coordinates: 1, 0, 0).
PLUS_I - Static variable in class org.apache.commons.math3.geometry.spherical.twod.S2Point
+I (coordinates: \( \theta = 0, \varphi = \pi/2 \)).
PLUS_J - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Second canonical vector (coordinates: 0, 1, 0).
PLUS_J - Static variable in class org.apache.commons.math3.geometry.spherical.twod.S2Point
+J (coordinates: \( \theta = \pi/2, \varphi = \pi/2 \))).
PLUS_K - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Third canonical vector (coordinates: 0, 0, 1).
PLUS_K - Static variable in class org.apache.commons.math3.geometry.spherical.twod.S2Point
+K (coordinates: \( \theta = any angle, \varphi = 0 \)).
plusAbs - Static variable in class cern.jet.math.Functions
Function that returns Math.abs(a) + Math.abs(b).
plusBounded(int, int) - Static method in class net.jafama.NumbersUtils
 
plusBounded(long, long) - Static method in class net.jafama.NumbersUtils
 
plusDiv(double) - Static method in class cern.jet.math.PlusMult
a + b/constant.
plusEquals(Matrix) - Method in class Jama.Matrix
A = A + B
plusEquals(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
A = A + B
plusEquals(ValueErr, double) - Method in class jhplot.math.ValueErr
Add a ValueErr number to this ValueErr number and replace this with the sum using a correlation
plusEquals(ValueErr) - Method in class jhplot.math.ValueErr
Add a ValueErr number to this ValueErr number and replace this with the sum without correlation
plusEquals(double) - Method in class jhplot.math.ValueErr
Add double number to this ValueErr number and replace this with the sum
plusExact(int, int) - Static method in class net.jafama.NumbersUtils
 
plusExact(long, long) - Static method in class net.jafama.NumbersUtils
 
plusMult(DoubleMatrix1D, DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A + B*s<=> A[i] = A[i] + B[i]*s.
plusMult(DoubleMatrix2D, DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = A + B*s <=> A[row,col] = A[row,col] + B[row,col]*s.
plusMult(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a + b*constant.
PlusMult - Class in cern.jet.math
Only for performance tuning of compute intensive linear algebraic computations.
plusMult(double) - Static method in class cern.jet.math.PlusMult
a + b*constant.
plusPI(double) - Static method in class net.jafama.NumbersUtils
 
plusPI_strict(double) - Static method in class net.jafama.NumbersUtils
Strict version.
plusPIO2(double) - Static method in class net.jafama.NumbersUtils
 
plusPIO2_strict(double) - Static method in class net.jafama.NumbersUtils
Strict version.
PMASS - Static variable in class graph.SpecialFunction
Proton Mass.
PND - Class in jhplot
Data holder in 2D for double values.
PND(String) - Constructor for class jhplot.PND
Construct an empty container with a title
PND(String, boolean, PND) - Constructor for class jhplot.PND
Construct a copy from a PND.
PND(String, String) - Constructor for class jhplot.PND
Construct a container with a title from external file (see the method toFile() how to write such ASCII file).
PND() - Constructor for class jhplot.PND
Construct an empty container with no title
PND_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
PNG - Static variable in interface org.jfree.chart.encoders.ImageFormat
Portable Network Graphics - lossless
PNI - Class in jhplot
Data holder in 2D for integer number.
PNI(String) - Constructor for class jhplot.PNI
Construct an empty container with a title
PNI(String, boolean, PNI) - Constructor for class jhplot.PNI
Construct a copy from a PNI.
PNI(String, String) - Constructor for class jhplot.PNI
Construct a container with a title from external file (see the method toFile() how to write such ASCII file)
PNI() - Constructor for class jhplot.PNI
Construct an empty container with no title
PNI_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
PNodeI - Interface in org.lsmp.djep.sjep
An element in a polynomial representation of an expression.
Point<S extends Space> - Interface in org.apache.commons.math3.geometry
This interface represents a generic geometrical point.
Point - Class in org.freehep.math.minuit
A class representing a pair of double (x,y) or (lower,upper)
Point(double, double) - Constructor for class org.freehep.math.minuit.Point
 
pointAt(double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get one point from the line.
Pointer() - Constructor for class org.jfree.chart.plot.dial.DialPointer.Pointer
Creates a new instance.
Pointer(int) - Constructor for class org.jfree.chart.plot.dial.DialPointer.Pointer
Creates a new instance.
PointerNeedle - Class in org.jfree.chart.needle
A needle in the shape of a pointer, for use with the CompassPlot class.
PointerNeedle() - Constructor for class org.jfree.chart.needle.PointerNeedle
 
pointRenderer(Graphics2D, Rectangle2D, PlotRenderingInfo, ContourPlot, ValueAxis, ValueAxis, ColorBar, ContourDataset, CrosshairState) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Draws the visual representation of a single data item.
points() - Method in class org.freehep.math.minuit.ContoursError
 
points(int, int) - Method in class org.freehep.math.minuit.MnContours
 
points(int, int, double) - Method in class org.freehep.math.minuit.MnContours
 
points(int, int, double, int) - Method in class org.freehep.math.minuit.MnContours
Calculates one function contour of FCN with respect to parameters parx and pary.
points - Variable in class org.jfree.chart.renderer.xy.XYSplineRenderer.XYSplineState
The points.
PointsShapes - Class in jhplot.utils
 
PointsShapes() - Constructor for class jhplot.utils.PointsShapes
 
PointValuePair - Class in org.apache.commons.math3.optim
This class holds a point and the value of an objective function at that point.
PointValuePair(double[], double) - Constructor for class org.apache.commons.math3.optim.PointValuePair
Builds a point/objective function value pair.
PointValuePair(double[], double, boolean) - Constructor for class org.apache.commons.math3.optim.PointValuePair
Builds a point/objective function value pair.
PointValuePair - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
PointValuePair(double[], double) - Constructor for class org.apache.commons.math3.optimization.PointValuePair
Deprecated.
Builds a point/objective function value pair.
PointValuePair(double[], double, boolean) - Constructor for class org.apache.commons.math3.optimization.PointValuePair
Deprecated.
Builds a point/objective function value pair.
PointVectorValuePair - Class in org.apache.commons.math3.optim
This class holds a point and the vectorial value of an objective function at that point.
PointVectorValuePair(double[], double[]) - Constructor for class org.apache.commons.math3.optim.PointVectorValuePair
Builds a point/objective function value pair.
PointVectorValuePair(double[], double[], boolean) - Constructor for class org.apache.commons.math3.optim.PointVectorValuePair
Build a point/objective function value pair.
PointVectorValuePair - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
PointVectorValuePair(double[], double[]) - Constructor for class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated.
Builds a point/objective function value pair.
PointVectorValuePair(double[], double[], boolean) - Constructor for class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated.
Build a point/objective function value pair.
Poisson - Class in cern.jet.random
Poisson distribution (quick); See the math definition and animated definition.
Poisson(double, RandomEngine) - Constructor for class cern.jet.random.Poisson
Constructs a poisson distribution.
poisson(int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the first k terms of the Poisson distribution.
poisson(int, double) - Static method in class graph.SpecialFunction
Returns the sum of the first k terms of the Poisson distribution.
Poisson - Class in jhplot.fit
Poisson distribution.
Poisson() - Constructor for class jhplot.fit.Poisson
 
Poisson(String) - Constructor for class jhplot.fit.Poisson
 
Poisson(String[], String[]) - Constructor for class jhplot.fit.Poisson
 
Poisson - Class in jhplot.math.num.pdf
The Poisson distribution.
Poisson() - Constructor for class jhplot.math.num.pdf.Poisson
Default distribution.
Poisson(double) - Constructor for class jhplot.math.num.pdf.Poisson
Create a distribution with the given mean.
Poisson - Class in jhplot.math
Build a Poisson distribution
Poisson(Random, double) - Constructor for class jhplot.math.Poisson
Build a Posson generator
Poisson(double) - Constructor for class jhplot.math.Poisson
Build a Poisson random numbers with a given lambda
Poisson(long, double) - Constructor for class jhplot.math.Poisson
Build a Posson random numbers
poissonc(int, double) - Static method in class graph.SpecialFunction
Returns the sum of the terms k+1 to infinity of the Poisson distribution.
poissonComplemented(int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the terms k+1 to Infinity of the Poisson distribution.
PoissonDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Poisson distribution.
PoissonDistribution(double) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
Creates a new Poisson distribution with specified mean.
PoissonDistribution(double, double, int) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
Creates a new Poisson distribution with specified mean, convergence criterion and maximum number of iterations.
PoissonDistribution(RandomGenerator, double, double, int) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
Creates a new Poisson distribution with specified mean, convergence criterion and maximum number of iterations.
PoissonDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
Creates a new Poisson distribution with the specified mean and convergence criterion.
PoissonDistribution(double, int) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
Creates a new Poisson distribution with the specified mean and maximum number of iterations.
PoissonRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Poisson distribution.
PoissonRandomVariable() - Constructor for class jhplot.math.num.random.PoissonRandomVariable
Default constructor.
PoissonRandomVariable(double) - Constructor for class jhplot.math.num.random.PoissonRandomVariable
Create a random variable with the given mean.
PoissonRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.PoissonRandomVariable
Create a random variable with the given parameters.
PoissonSlow - Class in cern.jet.random
Poisson distribution; See the math definition and animated definition.
PoissonSlow(double, RandomEngine) - Constructor for class cern.jet.random.PoissonSlow
Constructs a poisson distribution.
Polar - Class in org.nfunk.jep.function
Converts a pair of real numbers to a complex number Complex(x,y)=x+i y.
Polar() - Constructor for class org.nfunk.jep.function.Polar
 
polar2Complex(double, double) - Static method in class org.apache.commons.math3.complex.ComplexUtils
Creates a complex number from the given polar representation.
PolarAxisLocation - Class in org.jfree.chart.plot
Used to indicate the location of an axis on a PolarPlot.
PolarChartPanel - Class in org.jfree.chart
PolarChartPanel is the top level object for using the PolarPlot.
PolarChartPanel(JFreeChart) - Constructor for class org.jfree.chart.PolarChartPanel
Constructs a JFreeChart panel.
PolarChartPanel(JFreeChart, boolean) - Constructor for class org.jfree.chart.PolarChartPanel
Creates a new panel.
PolarItemRenderer - Interface in org.jfree.chart.renderer
The interface for a renderer that can be used by the PolarPlot class.
PolarPlot - Class in org.jfree.chart.plot
Plots data that is in (theta, radius) pairs where theta equal to zero is due north and increases clockwise.
PolarPlot() - Constructor for class org.jfree.chart.plot.PolarPlot
Default constructor.
PolarPlot(XYDataset, ValueAxis, PolarItemRenderer) - Constructor for class org.jfree.chart.plot.PolarPlot
Creates a new plot.
polarValueOf(Number, Number) - Static method in class org.nfunk.jep.type.Complex
Converts an [r,theta] pair to a complex number r * e^(i theta).
polevl(double, double[], int) - Static method in class cern.jet.math.Polynomial
Evaluates the given polynomial of degree N at x.
polevl(double, double[], int) - Static method in class jhplot.stat.Statistics
Evaluates the given polynomial of degree N at x.
POLYGON - Static variable in class jhplot.shapes.HShape
 
PolygonsSet - Class in org.apache.commons.math3.geometry.euclidean.twod
This class represents a 2D region: a set of polygons.
PolygonsSet(double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a polygons set representing the whole plane.
PolygonsSet(BSPTree<Euclidean2D>, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a polygons set from a BSP tree.
PolygonsSet(Collection<SubHyperplane<Euclidean2D>>, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a polygons set from a Boundary REPresentation (B-rep).
PolygonsSet(double, double, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a parallellepipedic box.
PolygonsSet(double, Vector2D...) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a polygon from a simple list of vertices.
PolygonsSet() - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Deprecated.
as of 3.3, replaced with PolygonsSet.PolygonsSet(double)
PolygonsSet(BSPTree<Euclidean2D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Deprecated.
PolygonsSet(Collection<SubHyperplane<Euclidean2D>>) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Deprecated.
PolygonsSet(double, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
PolyhedronsSet - Class in org.apache.commons.math3.geometry.euclidean.threed
This class represents a 3D region: a set of polyhedrons.
PolyhedronsSet(double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set representing the whole real line.
PolyhedronsSet(BSPTree<Euclidean3D>, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set from a BSP tree.
PolyhedronsSet(Collection<SubHyperplane<Euclidean3D>>, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set from a Boundary REPresentation (B-rep) specified by sub-hyperplanes.
PolyhedronsSet(List<Vector3D>, List<int[]>, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set from a Boundary REPresentation (B-rep) specified by connected vertices.
PolyhedronsSet(double, double, double, double, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Build a parallellepipedic box.
PolyhedronsSet() - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Deprecated.
as of 3.3, replaced with PolyhedronsSet.PolyhedronsSet(double)
PolyhedronsSet(BSPTree<Euclidean3D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Deprecated.
PolyhedronsSet(Collection<SubHyperplane<Euclidean3D>>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Deprecated.
PolyhedronsSet(double, double, double, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Polynomial - Class in cern.jet.math
Polynomial functions.
Polynomial - Class in org.lsmp.djep.groupJep.values
The ring of polynomials over a ring R.
Polynomial(RingI, String, Number[]) - Constructor for class org.lsmp.djep.groupJep.values.Polynomial
Construct a polynomial over a ring.
Polynomial - Class in org.lsmp.djep.sjep
Represents a polynomial.
PolynomialCreator - Class in org.lsmp.djep.sjep
Main entry point for simplification routines.
PolynomialCreator(XJep) - Constructor for class org.lsmp.djep.sjep.PolynomialCreator
 
PolynomialCurveFitter - Class in org.apache.commons.math3.fitting
Fits points to a polynomial function.
polynomialDerivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Returns the derivative as a PolynomialFunction.
PolynomialFitter - Class in org.apache.commons.math3.fitting
Deprecated.
As of 3.3. Please use PolynomialCurveFitter and WeightedObservedPoints instead.
PolynomialFitter(MultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.fitting.PolynomialFitter
Deprecated.
Simple constructor.
PolynomialFitter - Class in org.apache.commons.math3.optimization.fitting
Deprecated.
As of 3.1 (to be removed in 4.0).
PolynomialFitter(int, DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.PolynomialFitter
Deprecated.
Since 3.1 (to be removed in 4.0). Please use PolynomialFitter.PolynomialFitter(DifferentiableMultivariateVectorOptimizer) instead.
PolynomialFitter(DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.PolynomialFitter
Deprecated.
Simple constructor.
PolynomialFunction - Class in org.apache.commons.math3.analysis.polynomials
Immutable representation of a real polynomial function with real coefficients.
PolynomialFunction(double[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Construct a polynomial with the given coefficients.
PolynomialFunction.Parametric - Class in org.apache.commons.math3.analysis.polynomials
Dedicated parametric polynomial class.
PolynomialFunction2D - Class in org.jfree.data.function
A function in the form y = a0 + a1 * x + a2 * x^2 + ...
PolynomialFunction2D(double[]) - Constructor for class org.jfree.data.function.PolynomialFunction2D
Constructs a new polynomial function y = a0 + a1 * x + a2 * x^2 + ...
PolynomialFunctionLagrangeForm - Class in org.apache.commons.math3.analysis.polynomials
Implements the representation of a real polynomial function in Lagrange Form.
PolynomialFunctionLagrangeForm(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Construct a Lagrange polynomial with the given abscissas and function values.
PolynomialFunctionNewtonForm - Class in org.apache.commons.math3.analysis.polynomials
Implements the representation of a real polynomial function in Newton Form.
PolynomialFunctionNewtonForm(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Construct a Newton polynomial with the given a[] and c[].
PolynomialSolver - Interface in org.apache.commons.math3.analysis.solvers
Interface for (polynomial) root-finding algorithms.
polynomialSplineDerivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Get the derivative of the polynomial spline function.
PolynomialSplineFunction - Class in org.apache.commons.math3.analysis.polynomials
Represents a polynomial spline function.
PolynomialSplineFunction(double[], PolynomialFunction[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Construct a polynomial spline function with the given segment delimiters and interpolating polynomials.
PolynomialsUtils - Class in org.apache.commons.math3.analysis.polynomials
A collection of static methods that operate on or return polynomials.
PolynomialVisitor - Class in org.lsmp.djep.groupJep
Constructs a polynomial from a JEP equation.
PolynomialVisitor(JEP) - Constructor for class org.lsmp.djep.groupJep.PolynomialVisitor
 
pooledMean(int, double, int, double) - Static method in class cern.jet.stat.Descriptive
Returns the pooled mean of two data sequences.
pooledVariance(int, double, int, double) - Static method in class cern.jet.stat.Descriptive
Returns the pooled variance of two data sequences.
POperator - Class in org.lsmp.djep.sjep
Represents an operator.
POperator(PolynomialCreator, XOperator, PNodeI[]) - Constructor for class org.lsmp.djep.sjep.POperator
 
popSubHandler() - Method in class org.jfree.data.xml.RootHandler
Pops a sub-handler from the stack.
Population - Interface in org.apache.commons.math3.genetics
A collection of chromosomes that facilitates generational evolution.
PopulationSize(int) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer.PopulationSize
 
PopulationSize(int) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer.PopulationSize
Deprecated.
 
populationVariance(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the population variance of the entries in the input array, or Double.NaN if the array is empty.
populationVariance(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the population variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
populationVariance(double[], double, int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the population variance of the entries in the specified portion of the input array, using the precomputed mean value.
populationVariance(double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the population variance of the entries in the input array, using the precomputed mean value.
POSITION_INDEX - Static variable in class org.jfree.chart.renderer.WaferMapRenderer
default multivalue paint calculation
positionAxis(int, int, int, int) - Method in class graph.Axis
Position the axis at the passed coordinates.
POSITIVE - Static variable in class org.jfree.data.RangeType
Positive range.
POSITIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
A vector with all coordinates set to positive infinity.
POSITIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
A vector with all coordinates set to positive infinity.
POSITIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
A vector with all coordinates set to positive infinity.
POSITIVE_INFINITY - Static variable in class org.apache.commons.math3.util.Decimal64
The constant value of Double.POSITIVE_INFINITY as a Decimal64.
positiveOrNull() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is greater than or equal to 0.
PostfixMathCommand - Class in org.nfunk.jep.function
Function classes extend this class.
PostfixMathCommand() - Constructor for class org.nfunk.jep.function.PostfixMathCommand
Creates a new PostfixMathCommand class.
PostfixMathCommandI - Interface in org.nfunk.jep.function
All function classes must implement this interface to ensure that the run() method is implemented.
postVisitDirectory(Path, IOException) - Method in class org.apache.commons.io.file.CountingPathVisitor
 
postVisitDirectory(Path, IOException) - Method in class org.apache.commons.io.file.DeletingPathVisitor
 
pow(DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = As <=> A[i] = Math.pow(A[i], s).
pow(DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = AB <=> A[i] = Math.pow(A[i], B[i]).
pow(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = As <=> A[row,col] = Math.pow(A[row,col], s).
pow(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated.
A = AB <=> A[row,col] = Math.pow(A[row,col], B[row,col]).
pow(DoubleMatrix2D, int) - Method in class cern.colt.matrix.linalg.Algebra
Linear algebraic matrix power; B = Ak <==> B = A*A*...*A.
pow - Static variable in class cern.jet.math.Functions
Function that returns Math.pow(a,b).
pow(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns Math.pow(a,b).
pow - Static variable in class cern.jet.math.IntFunctions
Function that returns (int) Math.pow(a,b).
pow(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns (int) Math.pow(a,b).
Pow - Class in jhplot.fit
Power-law distribution.
Pow() - Constructor for class jhplot.fit.Pow
 
Pow(String) - Constructor for class jhplot.fit.Pow
 
Pow(String[], String[]) - Constructor for class jhplot.fit.Pow
 
pow(ValueErr, double) - Method in class jhplot.math.ValueErr
returns an ValueErr number raised to an error free power
pow(double, ValueErr) - Method in class jhplot.math.ValueErr
returns an error free number raised to an ValueErr power
pow(ValueErr, ValueErr, double) - Method in class jhplot.math.ValueErr
returns a ValueErr number raised to a ValueErr power with correlation
pow(ValueErr, ValueErr) - Method in class jhplot.math.ValueErr
ValueErr number raised to a ValueErr power with no correlation
pow(double, double) - Static method in class net.jafama.FastMath
1e-13ish accuracy or better on whole double range.
pow(double, double) - Static method in class net.jafama.StrictFastMath
1e-13ish accuracy or better on whole double range.
pow(double, DerivativeStructure) - Static method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute ax where a is a double and x a DerivativeStructure
pow(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Power operation.
pow(int) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Integer power operation.
pow(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Power operation.
pow(double, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute power of a double to a derivative structure.
pow(double[], int, double, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute power of a derivative structure.
pow(double[], int, int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute integer power of a derivative structure.
pow(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute power of a derivative structure.
pow(double) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Power operation.
pow(int) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Integer power operation.
pow(SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Power operation.
pow(double, SparseGradient) - Static method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute ax where a is a double and x a SparseGradient
Pow - Class in org.apache.commons.math3.analysis.function
Power function.
Pow() - Constructor for class org.apache.commons.math3.analysis.function.Pow
 
pow(Complex) - Method in class org.apache.commons.math3.complex.Complex
Returns of value of this complex number raised to the power of x.
pow(double) - Method in class org.apache.commons.math3.complex.Complex
Returns of value of this complex number raised to the power of x.
pow(double) - Method in class org.apache.commons.math3.dfp.Dfp
Power operation.
pow(int) - Method in class org.apache.commons.math3.dfp.Dfp
Integer power operation.
pow(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Power operation.
pow(Dfp, int) - Static method in class org.apache.commons.math3.dfp.DfpMath
Raises base to the power a by successive squaring.
pow(Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
Computes x to the y power.
pow(int) - Method in class org.apache.commons.math3.fraction.BigFraction
Returns a BigFraction whose value is (this<sup>exponent</sup>), returning the result in reduced form.
pow(long) - Method in class org.apache.commons.math3.fraction.BigFraction
Returns a BigFraction whose value is (thisexponent), returning the result in reduced form.
pow(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
Returns a BigFraction whose value is (thisexponent), returning the result in reduced form.
pow(double) - Method in class org.apache.commons.math3.fraction.BigFraction
Returns a double whose value is (thisexponent), returning the result in reduced form.
pow(double) - Method in interface org.apache.commons.math3.RealFieldElement
Power operation.
pow(int) - Method in interface org.apache.commons.math3.RealFieldElement
Integer power operation.
pow(T) - Method in interface org.apache.commons.math3.RealFieldElement
Power operation.
pow(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise an int to an int power.
pow(int, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Deprecated.
As of 3.3. Please use ArithmeticUtils.pow(int,int) instead.
pow(long, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise a long to an int power.
pow(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Deprecated.
As of 3.3. Please use ArithmeticUtils.pow(long,int) instead.
pow(BigInteger, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise a BigInteger to an int power.
pow(BigInteger, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise a BigInteger to a long power.
pow(BigInteger, BigInteger) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise a BigInteger to a BigInteger power.
pow(double) - Method in class org.apache.commons.math3.util.Decimal64
Power operation.
pow(int) - Method in class org.apache.commons.math3.util.Decimal64
Integer power operation.
pow(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Power operation.
pow(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Power function.
pow(double, int) - Static method in class org.apache.commons.math3.util.FastMath
Raise a double to an int power.
pow(double, long) - Static method in class org.apache.commons.math3.util.FastMath
Raise a double to a long power.
pow(Object, Object) - Method in class org.lsmp.djep.groupJep.function.GPower
 
pow(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.ExtendedFreeGroup
Limited implementation of power, only works with integer powers.
pow(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Integers
 
pow(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
pow(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Reals
 
pow(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Zn
 
pow(Number, Number) - Method in interface org.lsmp.djep.groupJep.interfaces.HasPowerI
 
pow(int) - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
pow(Rational) - Method in class org.lsmp.djep.groupJep.values.Rational
 
POW - Static variable in class org.lsmp.djep.rpe.RpEval
 
pow(PNodeI) - Method in class org.lsmp.djep.sjep.AbstractPNode
 
pow(PNodeI) - Method in class org.lsmp.djep.sjep.Monomial
 
pow(PNodeI) - Method in class org.lsmp.djep.sjep.PConstant
 
pow(PNodeI) - Method in interface org.lsmp.djep.sjep.PNodeI
Raise this to the argument.
pow2(float) - Static method in class net.jafama.FastMath
 
pow2(double) - Static method in class net.jafama.FastMath
 
pow2(int) - Static method in class net.jafama.NumbersUtils
 
pow2(long) - Static method in class net.jafama.NumbersUtils
 
pow2(float) - Static method in class net.jafama.NumbersUtils
 
pow2(double) - Static method in class net.jafama.NumbersUtils
 
pow2(float) - Static method in class net.jafama.StrictFastMath
 
pow2(double) - Static method in class net.jafama.StrictFastMath
 
pow2_strict(float) - Static method in class net.jafama.NumbersUtils
Strict version.
pow2_strict(double) - Static method in class net.jafama.NumbersUtils
Strict version.
pow3(float) - Static method in class net.jafama.FastMath
 
pow3(double) - Static method in class net.jafama.FastMath
 
pow3(int) - Static method in class net.jafama.NumbersUtils
 
pow3(long) - Static method in class net.jafama.NumbersUtils
 
pow3(float) - Static method in class net.jafama.NumbersUtils
 
pow3(double) - Static method in class net.jafama.NumbersUtils
 
pow3(float) - Static method in class net.jafama.StrictFastMath
 
pow3(double) - Static method in class net.jafama.StrictFastMath
 
pow3_strict(float) - Static method in class net.jafama.NumbersUtils
Strict version.
pow3_strict(double) - Static method in class net.jafama.NumbersUtils
Strict version.
PowellOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
Powell's algorithm.
PowellOptimizer(double, double, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.PowellOptimizer
This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure.
PowellOptimizer(double, double, double, double, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.PowellOptimizer
This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure and the line search tolerances.
PowellOptimizer(double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.PowellOptimizer
The parameters control the default convergence checking procedure.
PowellOptimizer(double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.PowellOptimizer
Builds an instance with the default convergence checking procedure.
PowellOptimizer - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
PowellOptimizer(double, double, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.PowellOptimizer
Deprecated.
This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure.
PowellOptimizer(double, double, double, double, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.PowellOptimizer
Deprecated.
This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure and the line search tolerances.
PowellOptimizer(double, double) - Constructor for class org.apache.commons.math3.optimization.direct.PowellOptimizer
Deprecated.
The parameters control the default convergence checking procedure.
PowellOptimizer(double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.PowellOptimizer
Deprecated.
Builds an instance with the default convergence checking procedure.
POWER - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
Power - Class in org.apache.commons.math3.analysis.function
Power function.
Power(double) - Constructor for class org.apache.commons.math3.analysis.function.Power
 
power(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the result multiplying this with itself p times.
power(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of multiplying this with itself p times.
power(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the result multiplying this with itself p times.
power(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of multiplying this with itself p times.
Power - Class in org.nfunk.jep.function
 
Power() - Constructor for class org.nfunk.jep.function.Power
 
power(Object, Object) - Method in class org.nfunk.jep.function.Power
 
power(Number, Number) - Method in class org.nfunk.jep.function.Power
 
power(Complex, Complex) - Method in class org.nfunk.jep.function.Power
 
power(Complex, Number) - Method in class org.nfunk.jep.function.Power
 
power(Number, Complex) - Method in class org.nfunk.jep.function.Power
 
POWER - Static variable in interface org.nfunk.jep.ParserConstants
 
power(double) - Method in class org.nfunk.jep.type.Complex
Returns the value of this complex number raised to the power of a real component (in double precision).
power(Complex) - Method in class org.nfunk.jep.type.Complex
Returns the value of this complex number raised to the power of a complex exponent
power10(int) - Method in class org.apache.commons.math3.dfp.Dfp
Return the specified power of 10.
power10K(int) - Method in class org.apache.commons.math3.dfp.Dfp
Get the specified power of 10000.
PowerDiffRule - Class in org.lsmp.djep.djep.diffRules
Diffrentiates a power with respect to var.
PowerDiffRule(String) - Constructor for class org.lsmp.djep.djep.diffRules.PowerDiffRule
 
PowerExpression() - Method in class org.nfunk.jep.Parser
 
PowerFunction2D - Class in org.jfree.data.function
A function of the form y = a * x ^ b.
PowerFunction2D(double, double) - Constructor for class org.jfree.data.function.PowerFunction2D
Creates a new power function.
PowerSeries - Class in jhplot.math.num
This class provides the means to evaluate infinite power series (1).
powerSeries(double, double, double) - Static method in class jhplot.stat.Statistics
Power series for incomplete beta integral.
powFast(double, int) - Static method in class net.jafama.FastMath
This treatment is somehow accurate for low values of |power|, and for |power*getExponent(value)| < 1023 or so (to stay away from double extreme magnitudes (large and small)).
powFast(double, int) - Static method in class net.jafama.StrictFastMath
This treatment is somehow accurate for low values of |power|, and for |power*getExponent(value)| < 1023 or so (to stay away from double extreme magnitudes (large and small)).
PowModified - Class in jhplot.fit
Power-law distribution with additional tail suppression.
PowModified() - Constructor for class jhplot.fit.PowModified
 
PowModified(String) - Constructor for class jhplot.fit.PowModified
 
PowModified(String[], String[]) - Constructor for class jhplot.fit.PowModified
 
powQuick(double, double) - Static method in class net.jafama.FastMath
Quick pow, with a max relative error of about 1e-2 for value >= Double.MIN_NORMAL and 1e-10 < |value^power| < 1e10, of about 6e-2 for value >= Double.MIN_NORMAL and 1e-40 < |value^power| < 1e40, and worse accuracy otherwise.
powQuick(double, double) - Static method in class net.jafama.StrictFastMath
Quick pow, with a max relative error of about 1e-2 for value >= Double.MIN_NORMAL and 1e-10 < |value^power| < 1e10, of about 6e-2 for value >= Double.MIN_NORMAL and 1e-40 < |value^power| < 1e40, and worse accuracy otherwise.
prand(double) - Static method in class jhplot.stat.limit.LimitCalculatorGui
 
PReader - Class in jhplot.io
Some generic methods to read data and to return BufferedReader.
PReader() - Constructor for class jhplot.io.PReader
 
PRECEDENCE_ADDITION - Static variable in class jhplot.math.exp4j.operator.Operator
The precedence value for the addition operation
PRECEDENCE_DIVISION - Static variable in class jhplot.math.exp4j.operator.Operator
The precedence value for the division operation
PRECEDENCE_MODULO - Static variable in class jhplot.math.exp4j.operator.Operator
The precedence value for the modulo operation
PRECEDENCE_MULTIPLICATION - Static variable in class jhplot.math.exp4j.operator.Operator
The precedence value for the multiplication operation
PRECEDENCE_POWER - Static variable in class jhplot.math.exp4j.operator.Operator
The precedence value for the power operation
PRECEDENCE_SUBTRACTION - Static variable in class jhplot.math.exp4j.operator.Operator
The precedence value for the subtraction operation
PRECEDENCE_UNARY_MINUS - Static variable in class jhplot.math.exp4j.operator.Operator
The precedence value for the unary minus operation
PRECEDENCE_UNARY_PLUS - Static variable in class jhplot.math.exp4j.operator.Operator
The precedence value for the unary plus operation
Precision - Class in org.apache.commons.math3.util
Utilities for comparing numbers.
precision() - Method in class org.freehep.math.minuit.MnApplication
 
precision() - Method in class org.freehep.math.minuit.MnUserParameters
 
precision() - Method in class org.freehep.math.minuit.MnUserParameterState
 
precondition(double[], double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
Precondition a search direction.
precondition(double[], double[]) - Method in interface org.apache.commons.math3.optim.nonlinear.scalar.gradient.Preconditioner
Precondition a search direction.
precondition(double[], double[]) - Method in class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
Deprecated.
Precondition a search direction.
precondition(double[], double[]) - Method in interface org.apache.commons.math3.optimization.general.Preconditioner
Deprecated.
Precondition a search direction.
PreconditionedIterativeLinearSolver - Class in org.apache.commons.math3.linear
This abstract class defines preconditioned iterative solvers.
PreconditionedIterativeLinearSolver(int) - Constructor for class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Creates a new instance of this class, with default iteration manager.
PreconditionedIterativeLinearSolver(IterationManager) - Constructor for class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Creates a new instance of this class, with custom iteration manager.
Preconditioner - Interface in org.apache.commons.math3.optim.nonlinear.scalar.gradient
This interface represents a preconditioner for differentiable scalar objective function optimizers.
Preconditioner - Interface in org.apache.commons.math3.optimization.general
Deprecated.
As of 3.1 (to be removed in 4.0).
Predicate - Interface in hep.physics.filter
 
Predict() - Method in class jhplot.math.kalman.JKalman
Alias for prediction with no control.
Predict(Matrix) - Method in class jhplot.math.kalman.JKalman
Estimates subsequent model state.
predict() - Method in class org.apache.commons.math3.filter.KalmanFilter
Predict the internal state estimation one time step ahead.
predict(double[]) - Method in class org.apache.commons.math3.filter.KalmanFilter
Predict the internal state estimation one time step ahead.
predict(RealVector) - Method in class org.apache.commons.math3.filter.KalmanFilter
Predict the internal state estimation one time step ahead.
predict(double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the "predicted" y value associated with the supplied x value, based on the data that has been added to the model when this method is activated.
preferredLayoutSize(Container) - Method in class jhplot.gui.VariableSizeGridLayout
 
PREFIX - Static variable in class org.lsmp.djep.xjep.XOperator
prefix operators -x
prefixFileFilter(String) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that returns true if the file name starts with the specified text.
prefixFileFilter(String, IOCase) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that returns true if the file name starts with the specified text.
PrefixFileFilter - Class in org.apache.commons.io.filefilter
Filters file names for a certain prefix.
PrefixFileFilter(String) - Constructor for class org.apache.commons.io.filefilter.PrefixFileFilter
Constructs a new Prefix file filter for a single prefix.
PrefixFileFilter(String, IOCase) - Constructor for class org.apache.commons.io.filefilter.PrefixFileFilter
Constructs a new Prefix file filter for a single prefix specifying case-sensitivity.
PrefixFileFilter(String...) - Constructor for class org.apache.commons.io.filefilter.PrefixFileFilter
Constructs a new Prefix file filter for any of an array of prefixes.
PrefixFileFilter(String[], IOCase) - Constructor for class org.apache.commons.io.filefilter.PrefixFileFilter
Constructs a new Prefix file filter for any of an array of prefixes specifying case-sensitivity.
PrefixFileFilter(List<String>) - Constructor for class org.apache.commons.io.filefilter.PrefixFileFilter
Constructs a new Prefix file filter for a list of prefixes.
PrefixFileFilter(List<String>, IOCase) - Constructor for class org.apache.commons.io.filefilter.PrefixFileFilter
Constructs a new Prefix file filter for a list of prefixes specifying case-sensitivity.
preMultiply(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Premultiply this matrix by m.
preMultiply(T[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(FieldVector<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of premultiplying this by m.
preMultiply(double[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealVector) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(T[]) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(T[]) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealVector) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Premultiply this matrix by m.
preMultiply(T[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of premultiplying this by m.
preMultiply(double[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealVector) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preprocess(ASTFunNode, MatrixPreprocessor, MatrixJep, MatrixNodeFactory) - Method in class org.lsmp.djep.matrixJep.function.MAssign
 
preprocess(ASTFunNode, MatrixPreprocessor, MatrixJep, MatrixNodeFactory) - Method in class org.lsmp.djep.matrixJep.function.MDiff
 
preprocess(ASTFunNode, MatrixPreprocessor, MatrixJep, MatrixNodeFactory) - Method in class org.lsmp.djep.matrixJep.function.MList
 
preprocess(ASTFunNode, MatrixPreprocessor, MatrixJep, MatrixNodeFactory) - Method in class org.lsmp.djep.matrixJep.function.MMap
 
preprocess(ASTFunNode, MatrixPreprocessor, MatrixJep, MatrixNodeFactory) - Method in class org.lsmp.djep.matrixJep.function.MPower
During preprocessing sets the function to the Cross function if necessary.
preprocess(Node) - Method in class org.lsmp.djep.matrixJep.MatrixJep
Pre-processes an equation to allow the diff and eval operators to be used.
preprocess(Node, MatrixJep) - Method in class org.lsmp.djep.matrixJep.MatrixPreprocessor
Main entry point: pre-process a node.
preprocess(ASTFunNode, MatrixPreprocessor, MatrixJep, MatrixNodeFactory) - Method in interface org.lsmp.djep.matrixJep.SpecialPreProcessorI
Subverts the preprocessing stage.
preprocess(Node) - Method in class org.lsmp.djep.xjep.XJep
Pre-processes an equation to allow the diff and eval operators to be used.
previous() - Method in class org.jfree.data.time.Day
Returns the day preceding this one.
previous() - Method in class org.jfree.data.time.FixedMillisecond
Returns the millisecond preceding this one.
previous() - Method in class org.jfree.data.time.Hour
Returns the hour preceding this one.
previous() - Method in class org.jfree.data.time.Millisecond
Returns the millisecond preceding this one.
previous() - Method in class org.jfree.data.time.Minute
Returns the minute preceding this one.
previous() - Method in class org.jfree.data.time.Month
Returns the month preceding this one.
previous() - Method in class org.jfree.data.time.Quarter
Returns the quarter preceding this one.
previous() - Method in class org.jfree.data.time.RegularTimePeriod
Returns the time period preceding this one, or null if some lower limit has been reached.
previous() - Method in class org.jfree.data.time.Second
Returns the second preceding this one.
previous() - Method in class org.jfree.data.time.Week
Returns the week preceding this one.
previous() - Method in class org.jfree.data.time.Year
Returns the year preceding this one.
previousPage() - Method in class org.jlab.groot.graphics.EmbeddedCanvasGroup
 
preVisitDirectory(Path, BasicFileAttributes) - Method in class org.apache.commons.io.file.CleaningPathVisitor
 
preVisitDirectory(Path, BasicFileAttributes) - Method in class org.apache.commons.io.file.CopyDirectoryVisitor
 
preVisitDirectory(Path, BasicFileAttributes) - Method in class org.apache.commons.io.file.DeletingPathVisitor
 
primeFactors(int) - Static method in class org.apache.commons.math3.primes.Primes
Prime factors decomposition
PrimeFinder - Class in cern.colt.map
Not of interest for users; only for implementors of hashtables.
Primes - Class in org.apache.commons.math3.primes
Methods related to prime numbers in the range of int: primality test prime number generation factorization
primitivesToFront() - Method in class jplot.GraphSettings
Flag, saying whether the primitives should be drawn at the foreground or not.
print(int) - Method in class cern.jet.random.engine.RandomSeedGenerator
Prints the next size generated seeds.
print() - Method in class hephysics.particle.HEParticle
Print particle
print() - Method in class hephysics.particle.LParticle
Print particle
print() - Method in class j4np.physics.LorentzVector
 
print() - Method in class j4np.physics.TransMatrix
 
print(int, int) - Method in class Jama.Matrix
Print the matrix to stdout.
print(PrintWriter, int, int) - Method in class Jama.Matrix
Print the matrix to the output stream.
print(NumberFormat, int) - Method in class Jama.Matrix
Print the matrix to stdout.
print(PrintWriter, NumberFormat, int) - Method in class Jama.Matrix
Print the matrix to the output stream.
Print - Class in Jampack
Print prints numbers, matrices, and arrays.
Print() - Constructor for class Jampack.Print
 
print() - Method in class jhplot.H1D
Print histogram on screen
print() - Method in class jhplot.H1DA
 
print() - Method in class jhplot.HProf1D
Print histogram on screen
print(double[]) - Static method in class jhplot.math.ArrayMathUtils
Prints an array to screen.
print(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Prints an array to screen.
print(int[]) - Static method in class jhplot.math.ArrayMathUtils
Prints an array to screen.
print(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Prints an array to screen.
print(int, int) - Method in class jhplot.math.kalman.jama.Matrix
Print the matrix to stdout.
print(PrintWriter, int, int) - Method in class jhplot.math.kalman.jama.Matrix
Print the matrix to the output stream.
print(NumberFormat, int) - Method in class jhplot.math.kalman.jama.Matrix
Print the matrix to stdout.
print(PrintWriter, NumberFormat, int) - Method in class jhplot.math.kalman.jama.Matrix
Print the matrix to the output stream.
print() - Method in class jhplot.P0D
Print a P0D container.
print() - Method in class jhplot.P0I
Print a P0I container.
print() - Method in class jhplot.P1D
Print a P1D container on the screen
print() - Method in class jhplot.P3D
Print a P3D container on the screen
print() - Method in class jhplot.PND
Print PND to System.out.
print() - Method in class jhplot.PNI
Print PNI to System.out.
print() - Method in class jminhep.cluster.DataHolder
Print all entries of the data holder
print() - Method in class jplot.DataArray
Convert to string
print() - Method in class jplot.DataArray2D
Print a data container on the screen
print() - Method in class jplot.DataArray3D
Print a data container on the screen
print(Graphics, PageFormat, int) - Method in class jplot.GraphGeneral
Prints the graph.
print() - Method in class jplot.GraphSettings
Print the current parameter settings.
print(PrintStream) - Method in class jplot.GraphSettings
Print the current parameter settings.
print() - Method in class jplot.LinePars
Print the current parameter settings.
print(PrintStream) - Method in class jplot.LinePars
Print the current parameter settings.
print() - Method in class jplot.PlotPoint
print PlotPoint
print() - Method in class jplot.PlotPoint2D
print PlotPoint2D
print() - Method in class jplot.PlotPoint3D
print PlotPoint2D
print(Graphics, PageFormat, int) - Method in class jplot.PrintFilePainter
 
print(Graphics, PageFormat, int) - Method in class jplot.PrintTextPainter
 
print(PrintWriter, MnAlgebraicVector) - Static method in class org.freehep.math.minuit.MnPrint
 
print(PrintWriter, MnAlgebraicSymMatrix) - Static method in class org.freehep.math.minuit.MnPrint
 
print(PrintWriter, FunctionMinimum) - Static method in class org.freehep.math.minuit.MnPrint
 
print(PrintWriter, MinimumState) - Static method in class org.freehep.math.minuit.MnPrint
 
print(PrintWriter, MnUserParameters) - Static method in class org.freehep.math.minuit.MnPrint
 
print(PrintWriter, MnUserCovariance) - Static method in class org.freehep.math.minuit.MnPrint
 
print(PrintWriter, MnGlobalCorrelationCoeff) - Static method in class org.freehep.math.minuit.MnPrint
 
print(PrintWriter, MnUserParameterState) - Static method in class org.freehep.math.minuit.MnPrint
 
print(PrintWriter, MinosError) - Static method in class org.freehep.math.minuit.MnPrint
 
print(PrintWriter, ContoursError) - Static method in class org.freehep.math.minuit.MnPrint
 
print(Graphics, PageFormat, int) - Method in class org.jfree.chart.ChartPanel
Prints the chart on a single page.
print() - Method in class org.jlab.groot.tree.Tree
 
print(PrintVisitor) - Method in class org.lsmp.djep.matrixJep.MatrixVariable
 
print(Node, PrintStream) - Method in class org.lsmp.djep.xjep.PrintVisitor
Prints the tree descending from node with lots of brackets or specified stream.
print(Node) - Method in class org.lsmp.djep.xjep.PrintVisitor
Prints on System.out.
print(Node) - Method in class org.lsmp.djep.xjep.XJep
Prints the expression tree on standard output.
print(Node, PrintStream) - Method in class org.lsmp.djep.xjep.XJep
Prints the expression tree on given stream.
print(PrintVisitor) - Method in class org.lsmp.djep.xjep.XSymbolTable
Prints the contents of the symbol table displaying its equations and value.
print(Object) - Method in class org.lsmp.djepExamples.Console
Prints a line of text no newline.
PRINT_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Print action command.
PRINT_PARTIAL_EQNS - Static variable in class org.lsmp.djep.djep.DPrintVisitor
 
PRINT_VARIABLE_EQNS - Static variable in class org.lsmp.djep.djep.DPrintVisitor
 
PrintCommandHandler - Class in hep.lcio.util
 
PrintCommandHandler() - Constructor for class hep.lcio.util.PrintCommandHandler
 
printCommands() - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
printData() - Method in class jhplot.stat.Anova
Prettyprints your data and the results of the ANOVA.
printDiffRules() - Method in class org.lsmp.djep.djep.DifferentiationVisitor
Prints all the differentation rules for all functions on System.out.
printDiffRules(PrintStream) - Method in class org.lsmp.djep.djep.DifferentiationVisitor
Prints all the differentation rules for all functions on specified stream.
printDoubleArray(double[][]) - Static method in class jhplot.math.io.ArrayString
 
printDoubleArray(double[]) - Static method in class jhplot.math.io.ArrayString
 
printDoubleArray(double[][], String, String) - Static method in class jhplot.math.io.ArrayString
 
printDoubleVector(double[]) - Static method in class jhplot.stat.ProbabilityState
A helper function which prints out any given double vector.
printDrawOptions() - Method in class jhplot.DrawOptions
print all drawing options
printDrawOptions(PrintStream) - Method in class jhplot.DrawOptions
Get all drawing options as PrintStream
Printer - Class in hep.lcio.util
A utility class for printing LCEvents and LCCollections of all the LCIO types.
PrintExample - Class in org.lsmp.djepExamples
 
PrintExample() - Constructor for class org.lsmp.djepExamples.PrintExample
 
printf(String, double) - Static method in class corejava.Format
prints a formatted number following printf conventions
printf(String, int) - Static method in class corejava.Format
prints a formatted number following printf conventions
printf(String, long) - Static method in class corejava.Format
prints a formatted number following printf conventions
printf(String, char) - Static method in class corejava.Format
prints a formatted number following printf conventions
printf(String, String) - Static method in class corejava.Format
prints a formatted number following printf conventions
PrintFilePainter - Class in jplot
This class allows to print a file
PrintFilePainter(String) - Constructor for class jplot.PrintFilePainter
Builds the painter.
printFuns() - Method in class org.lsmp.djepExamples.Console
Prints a list of defined functions.
printGraph() - Method in class jhplot.gui.GHPanel
Print the canvas
printGraphSettings() - Method in class jhplot.HPlot
Print the current graph settings to System.out
printGraphSettings(PrintStream) - Method in class jhplot.HPlot
Print the current graph settings to System.out
printGroup() - Method in class org.lsmp.djepExamples.GroupConsole
 
printHelp() - Method in class org.lsmp.djepExamples.Console
Print help message.
printHelp() - Method in class org.lsmp.djepExamples.DJepConsole
 
printHelp() - Method in class org.lsmp.djepExamples.GroupConsole
 
printHelp() - Method in class org.lsmp.djepExamples.JamaConsole
 
printHelp() - Method in class org.lsmp.djepExamples.MatrixConsole
 
printHelp() - Method in class org.lsmp.djepExamples.VectorConsole
 
printHelp() - Method in class org.lsmp.djepExamples.XJepConsole
 
printing - Variable in class jplot3d.JSurface
 
printIntArray(int[][]) - Static method in class jhplot.math.io.ArrayString
 
printIntArray(int[]) - Static method in class jhplot.math.io.ArrayString
 
printIntArray(int[][], String, String) - Static method in class jhplot.math.io.ArrayString
 
printIntroText() - Method in class org.lsmp.djepExamples.Console
Prints introductory text.
printIntroText() - Method in class org.lsmp.djepExamples.DJepConsole
 
printIntroText() - Method in class org.lsmp.djepExamples.GroupConsole
 
printIntroText() - Method in class org.lsmp.djepExamples.JamaConsole
 
printIntroText() - Method in class org.lsmp.djepExamples.MatrixConsole
 
printIntroText() - Method in class org.lsmp.djepExamples.SJepConsole
 
printIntroText() - Method in class org.lsmp.djepExamples.VectorConsole
 
printIntroText() - Method in class org.lsmp.djepExamples.XJepConsole
 
printIntVector(int[]) - Static method in class jhplot.stat.ProbabilityState
A helper function which prints out any given int vector.
printJets() - Method in class hephysics.jet.JetN2
Print the kT jets for debugging.
printJets() - Method in class hephysics.jet.KTjet
Print the kT jets for debugging.
printJets() - Method in class hephysics.jet.SCJet
Print the kT jets for debugging.
println(Node, PrintStream) - Method in class org.lsmp.djep.xjep.PrintVisitor
Prints the tree descending from node with a newline at end.
println(Node) - Method in class org.lsmp.djep.xjep.PrintVisitor
Prints on System.out.
println(Node) - Method in class org.lsmp.djep.xjep.XJep
Prints the expression tree on standard output with newline at end.
println(Node, PrintStream) - Method in class org.lsmp.djep.xjep.XJep
Prints the expression tree on given stream with newline at end.
println(Object) - Method in class org.lsmp.djepExamples.Console
Prints a line of text no newline.
printMatrix(int, int, double[][], int, int) - Static method in class jminhep.utils.VEC
Method for printing a matrix
Based on ER Harold, "Java I/O", O'Reilly, around p.
printMatrix(int, int, int[][], int, int) - Static method in class jminhep.utils.VEC
Method for printing an integer matrix
Based on ER Harold, "Java I/O", O'Reilly, around p.
printOperators() - Method in class org.lsmp.djep.xjep.XOperatorSet
Prints all the operators, with verbose representations of each operators properties.
printOperators() - Method in class org.nfunk.jep.OperatorSet
 
printOps() - Method in class org.lsmp.djepExamples.Console
Prints a list of defined operators.
printOps() - Method in class org.lsmp.djepExamples.XJepConsole
 
printParameters() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Print the parameters.
printResults() - Method in class jhplot.stat.Anova
Pretty prints your results.
printSplitSummary(List, PrintStream) - Static method in class hep.lcio.util.Split
 
printStats() - Method in class hep.lcio.util.LCIOConcat
 
printStdHelp() - Method in class org.lsmp.djepExamples.Console
Prints a standard help message.
PrintTextPainter - Class in jplot
This class allows to print a file
PrintTextPainter(String) - Constructor for class jplot.PrintTextPainter
Builds the painter.
printUsage(boolean) - Method in class hep.lcio.util.CommandHandler
Print usage and (optionally) exit the program.
printUsage(boolean) - Method in class hep.lcio.util.CommandLineTool
Print the lcio command usage.
printUsage(PrintStream) - Static method in class hep.lcio.util.LCIOSplitter
 
printUsage(boolean) - Method in class hep.lcio.util.MergeCommandHandler
Print usage and (optionally) exit the program.
printUsage(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
printUsage() - Static method in class org.jlab.groot.matrix.SparseGridIO
 
printVars() - Method in class org.lsmp.djepExamples.Console
Prints a list of constants.
printVars() - Method in class org.lsmp.djepExamples.XJepConsole
 
printVect(double[], int, int) - Static method in class jminhep.utils.VEC
Method printVect for printing a vector
Based on ER Harold, "Java I/O", O'Reilly, around p.
printVect(int[], int, int) - Static method in class jminhep.utils.VEC
Method printVect for printing a vector
Based on ER Harold, "Java I/O", O'Reilly, around p.
printVector() - Method in class jplot.XMLRead
 
printVersion() - Static method in class jhplot.JHPlot
jHplot version information
PrintVisitor - Class in org.lsmp.djep.xjep
Prints an expression.
PrintVisitor() - Constructor for class org.lsmp.djep.xjep.PrintVisitor
Creates a visitor to create and print string representations of an expression tree.
PrintVisitor.PrintRulesI - Interface in org.lsmp.djep.xjep
This interface specifies the method needed to implement a special print rule.
Probability - Class in cern.jet.stat
Custom tailored numerical integration of certain probability distributions.
probability(int) - Method in class jhplot.math.num.pdf.Binomial
The PMF for this distribution.
probability(int) - Method in class jhplot.math.num.pdf.DiscreteDistribution
The PMF for this distribution.
probability(int) - Method in class jhplot.math.num.pdf.Geometric
The PMF for this distribution.
probability(int) - Method in class jhplot.math.num.pdf.Hypergeometric
The PMF for this distribution.
probability(int) - Method in class jhplot.math.num.pdf.NegativeBinomial
The PMF for this distribution.
probability(int) - Method in class jhplot.math.num.pdf.Poisson
The PMF for this distribution.
probability(double, double) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(double) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.BinomialDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(double) - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.GeometricDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(double, double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(double, double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(int) - Method in class org.apache.commons.math3.distribution.PascalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.PoissonDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.ZipfDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(double) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
ProbabilityState - Class in jhplot.stat
Calculates the probabilities of each state in a random variable.
ProbabilityState(double[]) - Constructor for class jhplot.stat.ProbabilityState
Constructor for the ProbabilityState class.
probMap - Variable in class jhplot.stat.ProbabilityState
 
process(int) - Method in class jhplot.stat.Moments
Process current event for an integer random variable
process(double) - Method in class jhplot.stat.Moments
Process current event for a double random variable
process(int) - Method in class jhplot.stat.MomentsFac
Process current event for an integer random variable
process(int) - Method in class jhplot.stat.MomentsNorm
Process current event for an integer random variable
process(int) - Method in class jhplot.stat.StatShape
Process event.
process(ITree) - Method in class org.jlab.groot.tree.TreeAnalyzer
 
process(ITree, int) - Method in class org.jlab.groot.tree.TreeAnalyzer
 
process(Node, Node[], XJep) - Method in class org.lsmp.djep.djep.Diff
Process the differentiation specified by node.
process(Node, XJep) - Method in class org.lsmp.djep.xjep.CommandVisitor
Descends the tree processing all diff, eval and simplify options
process(Node, Node[], XJep) - Method in interface org.lsmp.djep.xjep.CommandVisitorI
Performs the specified action on an expression tree.
process(Node, Node[], XJep) - Method in class org.lsmp.djep.xjep.Eval
 
process(Node, Node[], XJep) - Method in class org.lsmp.djep.xjep.function.Define
 
process(Node, Node[], XJep) - Method in class org.lsmp.djep.xjep.function.XAssign
In the pre-process stage, set the equation of the lhs variable to the rhs equation.
PROCESS_ID_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
PROCESS_ID_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
PROCESS_ID_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent.Event
 
processCommand(String) - Method in class org.lsmp.djepExamples.Console
Process a single command.
PROCESSDATA_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat
 
PROCESSDATA_FIELD_NUMBER - Static variable in class promc.io.ProMCStatFile.ProMCStat
 
PROCESSDATA_FIELD_NUMBER - Static variable in class pronlo.io.ProMCStatFile.ProMCStat
 
PROCESSDATA_FIELD_NUMBER - Static variable in class proreco.io.ProMCStatFile.ProMCStat
 
processEquation(Node) - Method in class org.lsmp.djepExamples.BlockStatments
Evaluates a node, but only if the state corresponds to the conditionValue.
processEquation(Node) - Method in class org.lsmp.djepExamples.Console
Performs the required operation on a node.
processEquation(Node) - Method in class org.lsmp.djepExamples.DJepConsole
 
processEquation(Node) - Method in class org.lsmp.djepExamples.GroupConsole
 
processEquation(Node) - Method in class org.lsmp.djepExamples.MatrixConsole
 
processEquation(Node) - Method in class org.lsmp.djepExamples.SJepConsole
 
processEquation(Node) - Method in class org.lsmp.djepExamples.XJepConsole
 
processEvent(LCEvent) - Method in class hep.lcio.example.RecJob
 
processEvent(LCEvent) - Method in interface hep.lcio.io.LCEventListener
Call back for analyzing an LCEvent.
processEvent(LCEvent) - Method in class hep.lcio.util.LCIOConcat
 
processEvent(LCEvent) - Method in class hep.lcio.util.LCIOSplitter
 
PROCESSID_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
ProcessModel - Interface in org.apache.commons.math3.filter
Defines the process dynamics model for the use with a KalmanFilter.
processPlay() - Method in class org.jlab.groot.studio.StudioUI
 
processRunHeader(LCRunHeader) - Method in class hep.lcio.example.RecJob
 
processRunHeader(LCRunHeader) - Method in interface hep.lcio.io.LCRunListener
Call back for processing an LCRunHeader.
processRunHeader(LCRunHeader) - Method in class hep.lcio.util.LCIOConcat
 
processRunHeader(LCRunHeader) - Method in class hep.lcio.util.LCIOSplitter
 
processTreeEvent(Tree) - Method in class org.jlab.groot.tree.AbstractDescriptor
 
processTreeEvent(Tree) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
product() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the product, which is Prod( x[i] ).
product(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the product, which is Prod( data[i] ).
product(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the product of a data sequence, which is Prod( data[i] ).
product(double[]) - Static method in class jhplot.math.DoubleArray
Calculates the product of the values in an array.
product(double[][]) - Static method in class jhplot.math.DoubleArray
Calculates the product of the values in each column of a matrix.
product(int[]) - Static method in class jminhep.utils.ArrayOps
#8 Compute and return the product of all of the elements of nums.
Product - Class in org.apache.commons.math3.stat.descriptive.summary
Returns the product of the available values.
Product() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Product
Create a Product instance
Product(Product) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Product
Copy constructor, creates a new Product identical to the original
product(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the product of the entries in the input array, or Double.NaN if the array is empty.
product(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the product of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
Product - Class in org.lsmp.djep.xjep.function
A product function product(x^2,x,1,10) finds the product of x^2 with x running from 1 to 10.
Product() - Constructor for class org.lsmp.djep.xjep.function.Product
 
proeic.io - package proeic.io
 
ProgressBar - Class in org.jlab.groot.ui
 
ProgressBar() - Constructor for class org.jlab.groot.ui.ProgressBar
initialize progress bar properties.
project(float, float, float) - Method in class jplot3d.Projector
Projects 3D points.
project(Point<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Project a point to the hyperplane.
project(Point<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Project a point to the hyperplane.
project(Point<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Project a point to the hyperplane.
project(Point<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Project a point to the hyperplane.
project(Point<Sphere1D>) - Method in class org.apache.commons.math3.geometry.spherical.oned.LimitAngle
Project a point to the hyperplane.
project(Point<Sphere2D>) - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Project a point to the hyperplane.
projection - Variable in class jplot3d.JSurface
 
projection(Projector) - Method in class jplot3d.SurfaceVertex
Gets the 2D projection of the vertex.
projection(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Find the orthogonal projection of this vector onto another vector.
projection(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Find the orthogonal projection of this vector onto another vector.
projection(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(int, int) - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
projectionX() - Method in interface colt.hep.aida.IHistogram2D
Create a projection parallel to the X axis.
projectionX() - Method in class org.jlab.groot.data.H2F
Creates a projection of the 2D histogram onto the X Axis, adding up all the y bins for each x bin
projectionXY() - Method in interface colt.hep.aida.IHistogram3D
Create a projection parallel to the XY plane.
projectionXZ() - Method in interface colt.hep.aida.IHistogram3D
Create a projection parallel to the XZ plane.
projectionY() - Method in interface colt.hep.aida.IHistogram2D
Create a projection parallel to the Y axis.
projectionY() - Method in class org.jlab.groot.data.H2F
Creates a projection of the 2D histogram onto the Y Axis, adding up all the x bins for each y bin
projectionYZ() - Method in interface colt.hep.aida.IHistogram3D
Create a projection parallel to the YZ plane.
projector - Variable in class jplot3d.JSurface
 
Projector - Class in jplot3d
The class Projector projects points in 3D space to 2D space.
projectToBoundary(Point<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Project a point on the boundary of the region.
projectToBoundary(Point<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Project a point on the boundary of the region.
projectToBoundary(Point<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Project a point on the boundary of the region.
projectToBoundary(Point<Sphere1D>) - Method in class org.apache.commons.math3.geometry.spherical.oned.ArcsSet
Project a point on the boundary of the region.
ProMC - Class in proeic.io
 
ProMC - Class in promc.io
 
ProMC - Class in pronlo.io
 
ProMC - Class in proreco.io
 
promc.io - package promc.io
 
ProMC.ProMCEvent - Class in proeic.io
Protobuf type promc.ProMCEvent
ProMC.ProMCEvent - Class in promc.io
Protobuf type promc.ProMCEvent
ProMC.ProMCEvent - Class in pronlo.io
Protobuf type promc.ProMCEvent
ProMC.ProMCEvent - Class in proreco.io
Protobuf type promc.ProMCEvent
ProMC.ProMCEvent.BLJets - Class in proreco.io
Protobuf type promc.ProMCEvent.BLJets
ProMC.ProMCEvent.BLJets.Builder - Class in proreco.io
Protobuf type promc.ProMCEvent.BLJets
ProMC.ProMCEvent.BLJetsOrBuilder - Interface in proreco.io
 
ProMC.ProMCEvent.Builder - Class in proeic.io
Protobuf type promc.ProMCEvent
ProMC.ProMCEvent.Builder - Class in promc.io
Protobuf type promc.ProMCEvent
ProMC.ProMCEvent.Builder - Class in pronlo.io
Protobuf type promc.ProMCEvent
ProMC.ProMCEvent.Builder - Class in proreco.io
Protobuf type promc.ProMCEvent
ProMC.ProMCEvent.Electrons - Class in proreco.io
Protobuf type promc.ProMCEvent.Electrons
ProMC.ProMCEvent.Electrons.Builder - Class in proreco.io
Protobuf type promc.ProMCEvent.Electrons
ProMC.ProMCEvent.ElectronsOrBuilder - Interface in proreco.io
 
ProMC.ProMCEvent.Event - Class in proeic.io
Protobuf type promc.ProMCEvent.Event
ProMC.ProMCEvent.Event - Class in promc.io
Protobuf type promc.ProMCEvent.Event
ProMC.ProMCEvent.Event - Class in pronlo.io
Protobuf type promc.ProMCEvent.Event
ProMC.ProMCEvent.Event - Class in proreco.io
Protobuf type promc.ProMCEvent.Event
ProMC.ProMCEvent.Event.Builder - Class in proeic.io
Protobuf type promc.ProMCEvent.Event
ProMC.ProMCEvent.Event.Builder - Class in promc.io
Protobuf type promc.ProMCEvent.Event
ProMC.ProMCEvent.Event.Builder - Class in pronlo.io
Protobuf type promc.ProMCEvent.Event
ProMC.ProMCEvent.Event.Builder - Class in proreco.io
Protobuf type promc.ProMCEvent.Event
ProMC.ProMCEvent.EventOrBuilder - Interface in proeic.io
 
ProMC.ProMCEvent.EventOrBuilder - Interface in promc.io
 
ProMC.ProMCEvent.EventOrBuilder - Interface in pronlo.io
 
ProMC.ProMCEvent.EventOrBuilder - Interface in proreco.io
 
ProMC.ProMCEvent.GenJets - Class in proreco.io
Protobuf type promc.ProMCEvent.GenJets
ProMC.ProMCEvent.GenJets.Builder - Class in proreco.io
Protobuf type promc.ProMCEvent.GenJets
ProMC.ProMCEvent.GenJetsOrBuilder - Interface in proreco.io
 
ProMC.ProMCEvent.Jets - Class in proreco.io
Protobuf type promc.ProMCEvent.Jets
ProMC.ProMCEvent.Jets.Builder - Class in proreco.io
Protobuf type promc.ProMCEvent.Jets
ProMC.ProMCEvent.JetsOrBuilder - Interface in proreco.io
 
ProMC.ProMCEvent.MissingET - Class in proreco.io
Protobuf type promc.ProMCEvent.MissingET
ProMC.ProMCEvent.MissingET.Builder - Class in proreco.io
Protobuf type promc.ProMCEvent.MissingET
ProMC.ProMCEvent.MissingETOrBuilder - Interface in proreco.io
 
ProMC.ProMCEvent.Muons - Class in proreco.io
Protobuf type promc.ProMCEvent.Muons
ProMC.ProMCEvent.Muons.Builder - Class in proreco.io
Protobuf type promc.ProMCEvent.Muons
ProMC.ProMCEvent.MuonsOrBuilder - Interface in proreco.io
 
ProMC.ProMCEvent.Particles - Class in proeic.io
Protobuf type promc.ProMCEvent.Particles
ProMC.ProMCEvent.Particles - Class in promc.io
Protobuf type promc.ProMCEvent.Particles
ProMC.ProMCEvent.Particles - Class in pronlo.io
Protobuf type promc.ProMCEvent.Particles
ProMC.ProMCEvent.Particles - Class in proreco.io
Protobuf type promc.ProMCEvent.Particles
ProMC.ProMCEvent.Particles.Builder - Class in proeic.io
Protobuf type promc.ProMCEvent.Particles
ProMC.ProMCEvent.Particles.Builder - Class in promc.io
Protobuf type promc.ProMCEvent.Particles
ProMC.ProMCEvent.Particles.Builder - Class in pronlo.io
Protobuf type promc.ProMCEvent.Particles
ProMC.ProMCEvent.Particles.Builder - Class in proreco.io
Protobuf type promc.ProMCEvent.Particles
ProMC.ProMCEvent.ParticlesOrBuilder - Interface in proeic.io
 
ProMC.ProMCEvent.ParticlesOrBuilder - Interface in promc.io
 
ProMC.ProMCEvent.ParticlesOrBuilder - Interface in pronlo.io
 
ProMC.ProMCEvent.ParticlesOrBuilder - Interface in proreco.io
 
ProMC.ProMCEvent.Photons - Class in proreco.io
Protobuf type promc.ProMCEvent.Photons
ProMC.ProMCEvent.Photons.Builder - Class in proreco.io
Protobuf type promc.ProMCEvent.Photons
ProMC.ProMCEvent.PhotonsOrBuilder - Interface in proreco.io
 
ProMC.ProMCEvent.Tracks - Class in proreco.io
Protobuf type promc.ProMCEvent.Tracks
ProMC.ProMCEvent.Tracks.Builder - Class in proreco.io
Protobuf type promc.ProMCEvent.Tracks
ProMC.ProMCEvent.TracksOrBuilder - Interface in proreco.io
 
ProMC.ProMCEventOrBuilder - Interface in proeic.io
 
ProMC.ProMCEventOrBuilder - Interface in promc.io
 
ProMC.ProMCEventOrBuilder - Interface in pronlo.io
 
ProMC.ProMCEventOrBuilder - Interface in proreco.io
 
ProMCDescriptionFile - Class in proeic.io
 
ProMCDescriptionFile - Class in promc.io
 
ProMCDescriptionFile - Class in pronlo.io
 
ProMCDescriptionFile - Class in proreco.io
 
ProMCDescriptionFile.ProMCDescription - Class in proeic.io
Protobuf type promc.ProMCDescription
ProMCDescriptionFile.ProMCDescription - Class in promc.io
Protobuf type promc.ProMCDescription
ProMCDescriptionFile.ProMCDescription - Class in pronlo.io
Protobuf type promc.ProMCDescription
ProMCDescriptionFile.ProMCDescription - Class in proreco.io
Protobuf type promc.ProMCDescription
ProMCDescriptionFile.ProMCDescription.Builder - Class in proeic.io
Protobuf type promc.ProMCDescription
ProMCDescriptionFile.ProMCDescription.Builder - Class in promc.io
Protobuf type promc.ProMCDescription
ProMCDescriptionFile.ProMCDescription.Builder - Class in pronlo.io
Protobuf type promc.ProMCDescription
ProMCDescriptionFile.ProMCDescription.Builder - Class in proreco.io
Protobuf type promc.ProMCDescription
ProMCDescriptionFile.ProMCDescriptionOrBuilder - Interface in proeic.io
 
ProMCDescriptionFile.ProMCDescriptionOrBuilder - Interface in promc.io
 
ProMCDescriptionFile.ProMCDescriptionOrBuilder - Interface in pronlo.io
 
ProMCDescriptionFile.ProMCDescriptionOrBuilder - Interface in proreco.io
 
ProMCHeaderFile - Class in proeic.io
 
ProMCHeaderFile - Class in promc.io
 
ProMCHeaderFile - Class in pronlo.io
 
ProMCHeaderFile - Class in proreco.io
 
ProMCHeaderFile.ProMCHeader - Class in proeic.io
Protobuf type promc.ProMCHeader
ProMCHeaderFile.ProMCHeader - Class in promc.io
Protobuf type promc.ProMCHeader
ProMCHeaderFile.ProMCHeader - Class in pronlo.io
Protobuf type promc.ProMCHeader
ProMCHeaderFile.ProMCHeader - Class in proreco.io
Protobuf type promc.ProMCHeader
ProMCHeaderFile.ProMCHeader.Builder - Class in proeic.io
Protobuf type promc.ProMCHeader
ProMCHeaderFile.ProMCHeader.Builder - Class in promc.io
Protobuf type promc.ProMCHeader
ProMCHeaderFile.ProMCHeader.Builder - Class in pronlo.io
Protobuf type promc.ProMCHeader
ProMCHeaderFile.ProMCHeader.Builder - Class in proreco.io
Protobuf type promc.ProMCHeader
ProMCHeaderFile.ProMCHeader.MetaFloat - Class in proeic.io
Protobuf type promc.ProMCHeader.MetaFloat
ProMCHeaderFile.ProMCHeader.MetaFloat - Class in promc.io
Protobuf type promc.ProMCHeader.MetaFloat
ProMCHeaderFile.ProMCHeader.MetaFloat - Class in pronlo.io
Protobuf type promc.ProMCHeader.MetaFloat
ProMCHeaderFile.ProMCHeader.MetaFloat - Class in proreco.io
Protobuf type promc.ProMCHeader.MetaFloat
ProMCHeaderFile.ProMCHeader.MetaFloat.Builder - Class in proeic.io
Protobuf type promc.ProMCHeader.MetaFloat
ProMCHeaderFile.ProMCHeader.MetaFloat.Builder - Class in promc.io
Protobuf type promc.ProMCHeader.MetaFloat
ProMCHeaderFile.ProMCHeader.MetaFloat.Builder - Class in pronlo.io
Protobuf type promc.ProMCHeader.MetaFloat
ProMCHeaderFile.ProMCHeader.MetaFloat.Builder - Class in proreco.io
Protobuf type promc.ProMCHeader.MetaFloat
ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder - Interface in proeic.io
 
ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder - Interface in promc.io
 
ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder - Interface in pronlo.io
 
ProMCHeaderFile.ProMCHeader.MetaFloatOrBuilder - Interface in proreco.io
 
ProMCHeaderFile.ProMCHeader.MetaInt - Class in proeic.io
Protobuf type promc.ProMCHeader.MetaInt
ProMCHeaderFile.ProMCHeader.MetaInt - Class in promc.io
Protobuf type promc.ProMCHeader.MetaInt
ProMCHeaderFile.ProMCHeader.MetaInt - Class in pronlo.io
Protobuf type promc.ProMCHeader.MetaInt
ProMCHeaderFile.ProMCHeader.MetaInt - Class in proreco.io
Protobuf type promc.ProMCHeader.MetaInt
ProMCHeaderFile.ProMCHeader.MetaInt.Builder - Class in proeic.io
Protobuf type promc.ProMCHeader.MetaInt
ProMCHeaderFile.ProMCHeader.MetaInt.Builder - Class in promc.io
Protobuf type promc.ProMCHeader.MetaInt
ProMCHeaderFile.ProMCHeader.MetaInt.Builder - Class in pronlo.io
Protobuf type promc.ProMCHeader.MetaInt
ProMCHeaderFile.ProMCHeader.MetaInt.Builder - Class in proreco.io
Protobuf type promc.ProMCHeader.MetaInt
ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder - Interface in proeic.io
 
ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder - Interface in promc.io
 
ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder - Interface in pronlo.io
 
ProMCHeaderFile.ProMCHeader.MetaIntOrBuilder - Interface in proreco.io
 
ProMCHeaderFile.ProMCHeader.ParticleData - Class in proeic.io
Protobuf type promc.ProMCHeader.ParticleData
ProMCHeaderFile.ProMCHeader.ParticleData - Class in promc.io
Protobuf type promc.ProMCHeader.ParticleData
ProMCHeaderFile.ProMCHeader.ParticleData - Class in pronlo.io
Protobuf type promc.ProMCHeader.ParticleData
ProMCHeaderFile.ProMCHeader.ParticleData - Class in proreco.io
Protobuf type promc.ProMCHeader.ParticleData
ProMCHeaderFile.ProMCHeader.ParticleData.Builder - Class in proeic.io
Protobuf type promc.ProMCHeader.ParticleData
ProMCHeaderFile.ProMCHeader.ParticleData.Builder - Class in promc.io
Protobuf type promc.ProMCHeader.ParticleData
ProMCHeaderFile.ProMCHeader.ParticleData.Builder - Class in pronlo.io
Protobuf type promc.ProMCHeader.ParticleData
ProMCHeaderFile.ProMCHeader.ParticleData.Builder - Class in proreco.io
Protobuf type promc.ProMCHeader.ParticleData
ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder - Interface in proeic.io
 
ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder - Interface in promc.io
 
ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder - Interface in pronlo.io
 
ProMCHeaderFile.ProMCHeader.ParticleDataOrBuilder - Interface in proreco.io
 
ProMCHeaderFile.ProMCHeaderOrBuilder - Interface in proeic.io
 
ProMCHeaderFile.ProMCHeaderOrBuilder - Interface in promc.io
 
ProMCHeaderFile.ProMCHeaderOrBuilder - Interface in pronlo.io
 
ProMCHeaderFile.ProMCHeaderOrBuilder - Interface in proreco.io
 
ProMCStatFile - Class in proeic.io
 
ProMCStatFile - Class in promc.io
 
ProMCStatFile - Class in pronlo.io
 
ProMCStatFile - Class in proreco.io
 
ProMCStatFile.ProMCStat - Class in proeic.io
Protobuf type promc.ProMCStat
ProMCStatFile.ProMCStat - Class in promc.io
Protobuf type promc.ProMCStat
ProMCStatFile.ProMCStat - Class in pronlo.io
Protobuf type promc.ProMCStat
ProMCStatFile.ProMCStat - Class in proreco.io
Protobuf type promc.ProMCStat
ProMCStatFile.ProMCStat.Builder - Class in proeic.io
Protobuf type promc.ProMCStat
ProMCStatFile.ProMCStat.Builder - Class in promc.io
Protobuf type promc.ProMCStat
ProMCStatFile.ProMCStat.Builder - Class in pronlo.io
Protobuf type promc.ProMCStat
ProMCStatFile.ProMCStat.Builder - Class in proreco.io
Protobuf type promc.ProMCStat
ProMCStatFile.ProMCStat.MetaFloat - Class in proeic.io
Protobuf type promc.ProMCStat.MetaFloat
ProMCStatFile.ProMCStat.MetaFloat.Builder - Class in proeic.io
Protobuf type promc.ProMCStat.MetaFloat
ProMCStatFile.ProMCStat.MetaFloatOrBuilder - Interface in proeic.io
 
ProMCStatFile.ProMCStat.MetaInt - Class in proeic.io
Protobuf type promc.ProMCStat.MetaInt
ProMCStatFile.ProMCStat.MetaInt.Builder - Class in proeic.io
Protobuf type promc.ProMCStat.MetaInt
ProMCStatFile.ProMCStat.MetaIntOrBuilder - Interface in proeic.io
 
ProMCStatFile.ProMCStat.ProcessData - Class in proeic.io
Protobuf type promc.ProMCStat.ProcessData
ProMCStatFile.ProMCStat.ProcessData - Class in promc.io
Protobuf type promc.ProMCStat.ProcessData
ProMCStatFile.ProMCStat.ProcessData - Class in pronlo.io
Protobuf type promc.ProMCStat.ProcessData
ProMCStatFile.ProMCStat.ProcessData - Class in proreco.io
Protobuf type promc.ProMCStat.ProcessData
ProMCStatFile.ProMCStat.ProcessData.Builder - Class in proeic.io
Protobuf type promc.ProMCStat.ProcessData
ProMCStatFile.ProMCStat.ProcessData.Builder - Class in promc.io
Protobuf type promc.ProMCStat.ProcessData
ProMCStatFile.ProMCStat.ProcessData.Builder - Class in pronlo.io
Protobuf type promc.ProMCStat.ProcessData
ProMCStatFile.ProMCStat.ProcessData.Builder - Class in proreco.io
Protobuf type promc.ProMCStat.ProcessData
ProMCStatFile.ProMCStat.ProcessDataOrBuilder - Interface in proeic.io
 
ProMCStatFile.ProMCStat.ProcessDataOrBuilder - Interface in promc.io
 
ProMCStatFile.ProMCStat.ProcessDataOrBuilder - Interface in pronlo.io
 
ProMCStatFile.ProMCStat.ProcessDataOrBuilder - Interface in proreco.io
 
ProMCStatFile.ProMCStatOrBuilder - Interface in proeic.io
 
ProMCStatFile.ProMCStatOrBuilder - Interface in promc.io
 
ProMCStatFile.ProMCStatOrBuilder - Interface in pronlo.io
 
ProMCStatFile.ProMCStatOrBuilder - Interface in proreco.io
 
PromcUtil - Class in hephysics.hepsim
Utils classes to fill particles from ProMC data format of the HepSim repository with Monte Carlo predictions.
PromcUtil() - Constructor for class hephysics.hepsim.PromcUtil
 
pronlo.io - package pronlo.io
 
PROP_COLOR - Static variable in class net.java.dev.colorchooser.ColorChooser
Property name for property fired when the color property changes.
PROP_CONTINUOUS_PALETTE - Static variable in class net.java.dev.colorchooser.ColorChooser
Fired when the value of the continuous palette changes.
PROP_PICKER_VISIBLE - Static variable in class net.java.dev.colorchooser.ColorChooser
Property indicating the visibility of the popup palette.
PROP_TRANSIENT_COLOR - Static variable in class net.java.dev.colorchooser.ColorChooser
Property name for property fired when the transient color property (the color while the user is selecting) changes.
ProperBigFractionFormat - Class in org.apache.commons.math3.fraction
Formats a BigFraction number in proper format.
ProperBigFractionFormat() - Constructor for class org.apache.commons.math3.fraction.ProperBigFractionFormat
Create a proper formatting instance with the default number format for the whole, numerator, and denominator.
ProperBigFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperBigFractionFormat
Create a proper formatting instance with a custom number format for the whole, numerator, and denominator.
ProperBigFractionFormat(NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperBigFractionFormat
Create a proper formatting instance with a custom number format for each of the whole, numerator, and denominator.
ProperFractionFormat - Class in org.apache.commons.math3.fraction
Formats a Fraction number in proper format.
ProperFractionFormat() - Constructor for class org.apache.commons.math3.fraction.ProperFractionFormat
Create a proper formatting instance with the default number format for the whole, numerator, and denominator.
ProperFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperFractionFormat
Create a proper formatting instance with a custom number format for the whole, numerator, and denominator.
ProperFractionFormat(NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperFractionFormat
Create a proper formatting instance with a custom number format for each of the whole, numerator, and denominator.
PROPERTIES_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Properties action command.
property() - Method in class cern.colt.matrix.linalg.Algebra
Returns the property object attached to this Algebra, defining tolerance.
Property - Class in cern.colt.matrix.linalg
Tests matrices for linear algebraic properties (equality, tridiagonality, symmetry, singularity, etc).
Property(double) - Constructor for class cern.colt.matrix.linalg.Property
Constructs an instance with a tolerance of Math.abs(newTolerance).
propertyChange(PropertyChangeEvent) - Method in class org.jfree.chart.panel.CrosshairOverlay
Receives a property change event (typically a change in one of the crosshairs).
propertyChange(PropertyChangeEvent) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Notifies all registered listeners of a property change.
proreco.io - package proreco.io
 
proton_mass_c2 - Static variable in class cern.clhep.PhysicalConstants
 
providesResidual() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Returns true if IterativeLinearSolverEvent.getResidual() is supported.
providesResidual() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Returns true if IterativeLinearSolverEvent.getResidual() is supported.
ProxyCollectionWriter - Class in org.apache.commons.io.output
A Proxy stream collection which acts as expected, that is it passes the method calls on to the proxied streams and doesn't change which methods are being called.
ProxyCollectionWriter(Collection<Writer>) - Constructor for class org.apache.commons.io.output.ProxyCollectionWriter
Creates a new proxy collection writer.
ProxyCollectionWriter(Writer...) - Constructor for class org.apache.commons.io.output.ProxyCollectionWriter
Creates a new proxy collection writer.
ProxyInputStream - Class in org.apache.commons.io.input
A Proxy stream which acts as expected, that is it passes the method calls on to the proxied stream and doesn't change which methods are being called.
ProxyInputStream(InputStream) - Constructor for class org.apache.commons.io.input.ProxyInputStream
Constructs a new ProxyInputStream.
ProxyOutputStream - Class in org.apache.commons.io.output
A Proxy stream which acts as expected, that is it passes the method calls on to the proxied stream and doesn't change which methods are being called.
ProxyOutputStream(OutputStream) - Constructor for class org.apache.commons.io.output.ProxyOutputStream
Constructs a new ProxyOutputStream.
ProxyReader - Class in org.apache.commons.io.input
A Proxy stream which acts as expected, that is it passes the method calls on to the proxied stream and doesn't change which methods are being called.
ProxyReader(Reader) - Constructor for class org.apache.commons.io.input.ProxyReader
Constructs a new ProxyReader.
ProxyWriter - Class in org.apache.commons.io.output
A Proxy stream which acts as expected, that is it passes the method calls on to the proxied stream and doesn't change which methods are being called.
ProxyWriter(Writer) - Constructor for class org.apache.commons.io.output.ProxyWriter
Constructs a new ProxyWriter.
prune() - Method in class org.jfree.data.xy.DefaultTableXYDataset
Removes all x-values for which all the y-values are null.
pruneAroundConvexCell(Object, Object, Object) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Prune a tree around a cell.
pseudoRapidity() - Method in class hephysics.vec.Hep3Vector
Pseudorapidity.
pseudoRapidity() - Method in class hephysics.vec.HepLorentzVector
Pseudorapidity.
PSquarePercentile - Class in org.apache.commons.math3.stat.descriptive.rank
A StorelessUnivariateStatistic estimating percentiles using the P2 Algorithm as explained by Raj Jain and Imrich Chlamtac in P2 Algorithm for Dynamic Calculation of Quantiles and Histogram Without Storing Observations.
PSquarePercentile(double) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile
Constructs a PSquarePercentile with the specific percentile value.
pt() - Method in class j4np.physics.LorentzVector
 
PT_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.BLJets
 
PT_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Electrons
 
PT_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.GenJets
 
PT_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Jets
 
PT_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Muons
 
PT_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
PT_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Photons
 
PT_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
pushSubHandler(DefaultHandler) - Method in class org.jfree.data.xml.RootHandler
Pushes a sub-handler onto the stack.
put(int, int, boolean) - Method in class cern.colt.bitvector.BitMatrix
Sets the bit at the specified coordinate to the state specified by value.
put(int, boolean) - Method in class cern.colt.bitvector.BitVector
Sets the bit with index bitIndex to the state specified by value.
put(long[], int, boolean) - Static method in class cern.colt.bitvector.QuickBitVector
Sets the bit with index bitIndex in the bitvector bits to the state specified by value.
put(double, int) - Method in class cern.colt.map.AbstractDoubleIntMap
Associates the given key with the given value.
put(int, double) - Method in class cern.colt.map.AbstractIntDoubleMap
Associates the given key with the given value.
put(int, int) - Method in class cern.colt.map.AbstractIntIntMap
Associates the given key with the given value.
put(int, Object) - Method in class cern.colt.map.AbstractIntObjectMap
Associates the given key with the given value.
put(long, Object) - Method in class cern.colt.map.AbstractLongObjectMap
Associates the given key with the given value.
put(double, int) - Method in class cern.colt.map.OpenDoubleIntHashMap
Associates the given key with the given value.
put(int, double) - Method in class cern.colt.map.OpenIntDoubleHashMap
Associates the given key with the given value.
put(int, int) - Method in class cern.colt.map.OpenIntIntHashMap
Associates the given key with the given value.
put(int, Object) - Method in class cern.colt.map.OpenIntObjectHashMap
Associates the given key with the given value.
put(long, Object) - Method in class cern.colt.map.OpenLongObjectHashMap
Associates the given key with the given value.
put(String, Object) - Method in class hep.physics.event.BaseEvent
 
put(String, Object) - Method in interface hep.physics.event.HEPEvent
Puts an arbitrary object into the event
put(int, Z) - Method in class Jampack.Z1
Sets the ith element of a Z1 to a Z.
put(int, double, double) - Method in class Jampack.Z1
Sets the real and imaginary parts of the ith element of a Z1.
put(int, Z) - Method in class Jampack.Zdiagmat
Writes the ii-th diagonal element of a Zdiagmat.
put(int, int, Z) - Method in class Jampack.Zmat
Writes the (ii,jj) element of a Zmat.
put(int, int, int, int, Zmat) - Method in class Jampack.Zmat
Overwrites the submatrix (ii1:ii2, jj1:jj2) with a Zmat.
put(int[], int, int, Zmat) - Method in class Jampack.Zmat
Overwrites the submatrix (ii[], jj1:jj2) with a Zmat.
put(int, int, int[], Zmat) - Method in class Jampack.Zmat
Overwrites the submatrix (ii1:ii2, jj[]) with a Zmat.
put(int[], int[], Zmat) - Method in class Jampack.Zmat
Overwrites the submatrix (ii[], jj[]) with a Zmat.
put(int, double) - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Put a value associated with a key in the map.
put(int, T) - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Put a value associated with a key in the map.
put(Comparable, Paint) - Method in class org.jfree.chart.PaintMap
Adds a mapping between the specified key and paint values.
put(Comparable, Stroke) - Method in class org.jfree.chart.StrokeMap
Adds a mapping between the specified key and stroke values.
put(String, PostfixMathCommandI) - Method in class org.nfunk.jep.FunctionTable
adds the PostfixMathCommandI for the function with name s.
put(Object, Object) - Method in class org.nfunk.jep.FunctionTable
overrides the standard hashtable method.
put(Object, Object) - Method in class org.nfunk.jep.SymbolTable
Deprecated.
The setVarValue or makeVar methods should be used instead.
put0(int, Z) - Method in class Jampack.Zdiagmat
Writes the ith diagonal element of a Zdiagmat (0-based).
put0(int, int, Z) - Method in class Jampack.Zmat
Writes the zero-based (i,j)-element of a Zmat.
putLongFromTo(long, int, int) - Method in class cern.colt.bitvector.BitVector
Sets bits of the receiver from index from to index to to the bits of value.
putLongFromTo(long[], long, int, int) - Static method in class cern.colt.bitvector.QuickBitVector
Sets bits of a bitvector from index from to index to to the bits of value.
putQuick(int, int, boolean) - Method in class cern.colt.bitvector.BitMatrix
Sets the bit at the specified coordinate to the state specified by value; WARNING: Does not check preconditions.
putQuick(int, boolean) - Method in class cern.colt.bitvector.BitVector
Sets the bit with index bitIndex to the state specified by value; WARNING: Does not check preconditions.
putSettings(ArrayList<BMark>) - Method in class fitter.SEditor
 
putTransformer(Class<?>, NumberTransformer) - Method in class org.apache.commons.math3.util.TransformerMap
Sets a Class to Transformer Mapping in the Map.
PVariable - Class in org.lsmp.djep.sjep
Represents a variable.
PVariable(PolynomialCreator, XVariable) - Constructor for class org.lsmp.djep.sjep.PVariable
 
pvt - Variable in class Jampack.Zludpp
The pivot array (see Pivot.java )
pwd() - Method in class jhplot.io.FileAida
Print the current directory
pwd() - Method in class org.jlab.groot.data.Directory
 
px() - Method in class hephysics.jet.ParticleD
Get px.
px() - Method in class hephysics.vec.HepLorentzVector
Get X position or (Px,Py,Pz)
px() - Method in class j4np.physics.LorentzVector
 
PX_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
PX_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
PX_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent.Particles
 
PX_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
PXY_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
PXYZ_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record
 
py() - Method in class hephysics.jet.ParticleD
Get py.
py() - Method in class hephysics.vec.HepLorentzVector
Get Y position or Py
py() - Method in class j4np.physics.LorentzVector
 
PY_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
PY_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
PY_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent.Particles
 
PY_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
pz() - Method in class hephysics.jet.ParticleD
Get pz.
pz() - Method in class hephysics.vec.HepLorentzVector
Get Z position ot Pz
pz() - Method in class j4np.physics.LorentzVector
 
PZ_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
PZ_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
PZ_FIELD_NUMBER - Static variable in class pronlo.io.ProMC.ProMCEvent.Particles
 
PZ_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 

Q

Q - Variable in class Jampack.Zqrd
The unitary matrix Q
q(double, int[], double, LimitCalculatorGui.ExperimentData) - Method in class jhplot.stat.limit.LimitCalculatorGui.myFrame
 
Q2_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
qb(Zmat) - Method in class Jampack.Zhqrd
Computes the product QB.
qhb(Zmat) - Method in class Jampack.Zhqrd
Computes the product QHB.
QNAN - Static variable in class org.apache.commons.math3.dfp.Dfp
Indicator value for quiet NaN.
qr() - Method in class Jama.Matrix
QR Decomposition
qr() - Method in class jhplot.math.kalman.jama.Matrix
QR Decomposition
QR(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
QRDecomposition - Class in cern.colt.matrix.linalg
For an m x n matrix A with m >= n, the QR decomposition is an m x n orthogonal matrix Q and an n x n upper triangular matrix R so that A = Q*R.
QRDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.linalg.QRDecomposition
Constructs and returns a new QR decomposition object; computed by Householder reflections; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
QRDecomposition - Class in Jama
QR Decomposition.
QRDecomposition(Matrix) - Constructor for class Jama.QRDecomposition
QR Decomposition, computed by Householder reflections.
QRDecomposition - Class in jhplot.math.kalman.jama
QR Decomposition.
QRDecomposition(Matrix) - Constructor for class jhplot.math.kalman.jama.QRDecomposition
QR Decomposition, computed by Householder reflections.
QRDecomposition - Class in jhplot.math
QR Decomposition.
QRDecomposition(double[][]) - Constructor for class jhplot.math.QRDecomposition
QR Decomposition, computed by Householder reflections.
QRDecomposition - Class in org.apache.commons.math3.linear
Calculates the QR-decomposition of a matrix.
QRDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.QRDecomposition
Calculates the QR-decomposition of the given matrix.
QRDecomposition(RealMatrix, double) - Constructor for class org.apache.commons.math3.linear.QRDecomposition
Calculates the QR-decomposition of the given matrix.
QUAD_CURVE - Static variable in class org.jfree.chart.plot.PieLabelLinkStyle
QUAD_CURVE.
quantile(double) - Static method in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.quantile(percentage).
quantile(double) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the exact phi-quantile; that is, the smallest contained element elem for which holds that phi percent of elements are less than elem.
quantile(double) - Method in class cern.hep.aida.bin.QuantileBin1D
Computes and returns the phi-quantile.
quantile(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the phi-quantile; that is, an element elem for which holds that phi percent of data elements are less than elem.
quantile() - Method in class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile
Returns the quantile estimated by this statistic in the range [0.0-1.0]
Quantile1Test - Class in cern.jet.stat.quantile
A class to test the QuantileBin1D code.
Quantile1Test() - Constructor for class cern.jet.stat.quantile.Quantile1Test
 
QuantileBin1D - Class in cern.hep.aida.bin
1-dimensional non-rebinnable bin holding double elements with scalable quantile operations defined upon; Using little main memory, quickly computes approximate quantiles over very large data sequences with and even without a-priori knowledge of the number of elements to be filled; Conceptually a strongly lossily compressed multiset (or bag); Guarantees to respect the worst case approximation error specified upon instance construction.
QuantileBin1D(double) - Constructor for class cern.hep.aida.bin.QuantileBin1D
Equivalent to new QuantileBin1D(false, Long.MAX_VALUE, epsilon, 0.001, 10000, new cern.jet.random.engine.DRand(new java.util.Date()).
QuantileBin1D(boolean, long, double, double, int, RandomEngine) - Constructor for class cern.hep.aida.bin.QuantileBin1D
Equivalent to new QuantileBin1D(known_N, N, epsilon, delta, quantiles, randomGenerator, false, false, 2).
QuantileBin1D(boolean, long, double, double, int, RandomEngine, boolean, boolean, int) - Constructor for class cern.hep.aida.bin.QuantileBin1D
Constructs and returns an empty bin that, under the given constraints, minimizes the amount of memory needed.
quantileElements(DoubleArrayList) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Computes the specified quantile elements over the values previously added.
QuantileFinderFactory - Class in cern.jet.stat.quantile
Factory constructing exact and approximate quantile finders for both known and unknown N.
quantileInverse(double) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns exactly how many percent of the elements contained in the receiver are <= element.
quantileInverse(double) - Method in class cern.hep.aida.bin.QuantileBin1D
Returns how many percent of the elements contained in the receiver are <= element.
quantileInverse(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns how many percent of the elements contained in the receiver are <= element.
quantiles(DoubleArrayList) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the exact quantiles of the specified percentages.
quantiles(DoubleArrayList) - Method in class cern.hep.aida.bin.QuantileBin1D
Returns the quantiles of the specified percentages.
quantiles(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the quantiles of the specified percentages.
QuantizationError - Class in org.apache.commons.math3.ml.neuralnet.twod.util
Computes the quantization error histogram.
QuantizationError(DistanceMeasure) - Constructor for class org.apache.commons.math3.ml.neuralnet.twod.util.QuantizationError
 
Quarter - Class in org.jfree.data.time
Defines a quarter (in a given year).
Quarter() - Constructor for class org.jfree.data.time.Quarter
Constructs a new Quarter, based on the current system date/time.
Quarter(int, int) - Constructor for class org.jfree.data.time.Quarter
Constructs a new quarter.
Quarter(int, Year) - Constructor for class org.jfree.data.time.Quarter
Constructs a new quarter.
Quarter(Date) - Constructor for class org.jfree.data.time.Quarter
Constructs a new instance, based on a date/time and the default time zone.
Quarter(Date, TimeZone) - Constructor for class org.jfree.data.time.Quarter
Deprecated.
Since 1.0.12, use Quarter.Quarter(Date, TimeZone, Locale) instead.
Quarter(Date, TimeZone, Locale) - Constructor for class org.jfree.data.time.Quarter
Creates a new Quarter instance, using the specified zone and locale.
QuarterDateFormat - Class in org.jfree.chart.axis
A formatter that formats dates to show the year and quarter (for example, '2004 IV' for the last quarter of 2004.
QuarterDateFormat() - Constructor for class org.jfree.chart.axis.QuarterDateFormat
Creates a new instance for the default time zone.
QuarterDateFormat(TimeZone) - Constructor for class org.jfree.chart.axis.QuarterDateFormat
Creates a new instance for the specified time zone.
QuarterDateFormat(TimeZone, String[]) - Constructor for class org.jfree.chart.axis.QuarterDateFormat
Creates a new instance for the specified time zone.
QuarterDateFormat(TimeZone, String[], boolean) - Constructor for class org.jfree.chart.axis.QuarterDateFormat
Creates a new instance for the specified time zone.
quasiSigmoidDecay(double, double, long) - Static method in class org.apache.commons.math3.ml.neuralnet.sofm.LearningFactorFunctionFactory
Creates an sigmoid-like LearningFactorFunction function.
quasiSigmoidDecay(double, double, long) - Static method in class org.apache.commons.math3.ml.neuralnet.sofm.NeighbourhoodSizeFunctionFactory
Creates an sigmoid-like NeighbourhoodSizeFunction function.
QuasiSigmoidDecayFunction - Class in org.apache.commons.math3.ml.neuralnet.sofm.util
Decay function whose shape is similar to a sigmoid.
QuasiSigmoidDecayFunction(double, double, long) - Constructor for class org.apache.commons.math3.ml.neuralnet.sofm.util.QuasiSigmoidDecayFunction
Creates an instance.
Quaternion - Class in org.apache.commons.math3.complex
This class implements quaternions (Hamilton's hypercomplex numbers).
Quaternion(double, double, double, double) - Constructor for class org.apache.commons.math3.complex.Quaternion
Builds a quaternion from its components.
Quaternion(double, double[]) - Constructor for class org.apache.commons.math3.complex.Quaternion
Builds a quaternion from scalar and vector parts.
Quaternion(double[]) - Constructor for class org.apache.commons.math3.complex.Quaternion
Builds a pure quaternion from a vector (assuming that the scalar part is zero).
Quaternion(double, double, double, double) - Constructor for class org.lsmp.djep.groupJep.groups.Quaternions.Quaternion
 
Quaternions - Class in org.lsmp.djep.groupJep.groups
Possibly the Quaternions, completely untested.
Quaternions() - Constructor for class org.lsmp.djep.groupJep.groups.Quaternions
 
Quaternions.Quaternion - Class in org.lsmp.djep.groupJep.groups
 
QuickBitVector - Class in cern.colt.bitvector
Implements quick non polymorphic non bounds checking low level bitvector operations.
quickSort(int, int, IntComparator, Swapper) - Static method in class cern.colt.GenericSorting
Sorts the specified range of elements according to the order induced by the specified comparator.
quickSort() - Method in class cern.colt.list.AbstractList
Sorts the receiver into ascending order.
quickSort - Static variable in class cern.colt.matrix.doublealgo.Sorting
A prefabricated quicksort.
quickSort - Static variable in class cern.colt.matrix.objectalgo.Sorting
A prefabricated quicksort.
quickSort(byte[], int, int, ByteComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(char[], int, int, CharComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(double[], int, int, DoubleComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(float[], int, int, FloatComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(int[], int, int, IntComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(long[], int, int, LongComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(Object[]) - Static method in class cern.colt.Sorting
Sorts the specified range of the receiver into ascending order, according to the natural ordering of its elements.
quickSort(Object[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the receiver into ascending order, according to the natural ordering of its elements.
quickSort(Object[], int, int, Comparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array according to the order induced by the specified comparator.
quickSort(Object[], Comparator) - Static method in class cern.colt.Sorting
Sorts the specified array according to the order induced by the specified comparator.
quickSort(short[], int, int, ShortComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractByteList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, ByteComparator) - Method in class cern.colt.list.AbstractByteList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractCharList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, CharComparator) - Method in class cern.colt.list.AbstractCharList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractDoubleList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, DoubleComparator) - Method in class cern.colt.list.AbstractDoubleList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractFloatList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, FloatComparator) - Method in class cern.colt.list.AbstractFloatList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractIntList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, IntComparator) - Method in class cern.colt.list.AbstractIntList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractList
Sorts the specified range of the receiver into ascending order.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractLongList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, LongComparator) - Method in class cern.colt.list.AbstractLongList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractShortList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, ShortComparator) - Method in class cern.colt.list.AbstractShortList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Sorts the specified range of the receiver into ascending order (false < true).
quickSortFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Sorts the specified range of the receiver into ascending order, according to the natural ordering of its elements.
quickSortFromTo(int, int, Comparator) - Method in class cern.colt.list.ObjectArrayList
Sorts the receiver according to the order induced by the specified comparator.
quit() - Method in class jhplot.HChart
Quit the frame
quit() - Method in class jhplot.HPlot
Quit the canvas (and dispose all components) Note: a memory leak is found - no time to study it.
quit() - Method in class jhplot.HPlot3D
exit the frame and clear all components
quit() - Method in class jhplot.HPlot3DP
 
quit() - Method in class jplot.JPlot
Quits the app, really quits.
quitDialog() - Method in class jplot.JPlot
Quits the application but asks confirmation if you didn't saved yet.
QWORD - Static variable in class org.jfree.chart.util.HexNumberFormat
Number of hexadecimal digits for a quad word.

R

R - Variable in class Jampack.Zchol
The Cholesky factor
R - Variable in class Jampack.Zhqrd
The R factor.
R - Variable in class Jampack.Zqrd
The R factor.
R - Variable in class jminhep.algorithms.KMeansExchangeAlg
 
rad - Static variable in class cern.clhep.Units
 
radian - Static variable in class cern.clhep.Units
 
RADIX - Static variable in class org.apache.commons.math3.dfp.Dfp
The radix, or base of this system.
RainbowPalette - Class in org.jfree.chart.plot
Deprecated.
This class is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
RainbowPalette() - Constructor for class org.jfree.chart.plot.RainbowPalette
Deprecated.
Default constructor.
raise(double[], double) - Static method in class jhplot.math.LinearAlgebra
Raise each element of an array to a scalar power.
raise(double[][], double) - Static method in class jhplot.math.LinearAlgebra
Raise each element of a matrix to a scalar power
Rand - Class in Jampack
The rand suite generates random objects with elements distributed randomly on [0,1] or normally with mean zero and standard deviation one.
Rand() - Constructor for class Jampack.Rand
 
rand() - Static method in class jhplot.math.Random
Generate a random number between 0 and 1.
RandEngine - Static variable in class jhplot.math.Random
 
randInt(int, int) - Static method in class jhplot.math.Random
Generate a random integer.
random(int) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int, int) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random() - Static method in class cern.jet.math.Functions
Constructs a function that returns a new uniform random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
random() - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE).
random(int, boolean, double, String) - Static method in class cern.jet.random.Benchmark
Benchmarks all subclasses
random(int, int) - Static method in class Jama.Matrix
Generate matrix with random elements
random(int, int) - Static method in class jhplot.math.DoubleArray
Generates an m x n matrix of random numbers uniformly distributed between 0 and 1.
random(int) - Static method in class jhplot.math.DoubleArray
Generates an m element array of random numbers uniformly distributed between 0 and 1.
random(int, int, double, double) - Static method in class jhplot.math.DoubleArray
Generates an mxn matrix of random numbers uniformly distributed between min and max.
random(int, double, double) - Static method in class jhplot.math.DoubleArray
Generates an m element array of random numbers uniformly distributed between min and max.
random(int, int, double[], double[]) - Static method in class jhplot.math.DoubleArray
Generates an m x n matrix of random numbers uniformly distributed numbers.
random(int, int) - Static method in class jhplot.math.kalman.jama.Matrix
Generate matrix with random elements
Random - Class in jhplot.math
BSD License
Random() - Constructor for class jhplot.math.Random
 
random(int, AbstractDistribution) - Method in class jhplot.P0D
Fill array with random numbers Random generators are taken from cern.jet.random.*.
random(int, AbstractDistribution) - Method in class jhplot.P0I
Fill array with random numbers Random generators are taken from cern.jet.random.*.
random() - Static method in class net.jafama.FastMath
 
random() - Static method in class net.jafama.StrictFastMath
 
random() - Static method in class org.apache.commons.math3.util.FastMath
Returns a pseudo-random number between 0.0 and 1.0.
random() - Method in class org.jlab.groot.math.RandomFunc
 
Random - Class in org.nfunk.jep.function
Encapsulates the Math.random() function.
Random() - Constructor for class org.nfunk.jep.function.Random
 
RandomAccessFileInputStream - Class in org.apache.commons.io.input
Streams data from a RandomAccessFile starting at its current position.
RandomAccessFileInputStream(RandomAccessFile) - Constructor for class org.apache.commons.io.input.RandomAccessFileInputStream
Constructs a new instance configured to leave the underlying file open when this stream is closed.
RandomAccessFileInputStream(RandomAccessFile, boolean) - Constructor for class org.apache.commons.io.input.RandomAccessFileInputStream
Constructs a new instance.
RandomAdaptor - Class in org.apache.commons.math3.random
Extension of java.util.Random wrapping a RandomGenerator.
RandomAdaptor(RandomGenerator) - Constructor for class org.apache.commons.math3.random.RandomAdaptor
Construct a RandomAdaptor wrapping the supplied RandomGenerator.
randomBernoulli(double, int) - Static method in class jhplot.stat.StatUtils
Return a new array of Bernoulli random variables with a given probability of success p.
randomBeta(int, int, double, double) - Static method in class jhplot.math.StatisticSample
Random beata distribution
randomBeta(int, double, double) - Static method in class jhplot.math.StatisticSample
1D Random Beta distribution
randomBinaryRepresentation(int) - Static method in class org.apache.commons.math3.genetics.BinaryChromosome
Returns a representation of a random binary array of length length.
randomCauchy(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D Cauchy PDF
randomCauchy(int, double, double) - Static method in class jhplot.math.StatisticSample
1D Cauchy PDF
randomChi2(int, int, int) - Static method in class jhplot.math.StatisticSample
2D array with Chi2
randomChi2(int, int) - Static method in class jhplot.math.StatisticSample
1D array with random numbers
RandomData - Interface in org.apache.commons.math3.random
Deprecated.
to be removed in 4.0. Use RandomDataGenerator directly
RandomDataGenerator - Class in org.apache.commons.math3.random
Implements the RandomData interface using a RandomGenerator instance to generate non-secure data and a SecureRandom instance to provide data for the nextSecureXxx methods.
RandomDataGenerator() - Constructor for class org.apache.commons.math3.random.RandomDataGenerator
Construct a RandomDataGenerator, using a default random generator as the source of randomness.
RandomDataGenerator(RandomGenerator) - Constructor for class org.apache.commons.math3.random.RandomDataGenerator
Construct a RandomDataGenerator using the supplied RandomGenerator as the source of (non-secure) random data.
RandomDataImpl - Class in org.apache.commons.math3.random
Deprecated.
to be removed in 4.0. Use RandomDataGenerator instead
RandomDataImpl() - Constructor for class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Construct a RandomDataImpl, using a default random generator as the source of randomness.
RandomDataImpl(RandomGenerator) - Constructor for class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Construct a RandomDataImpl using the supplied RandomGenerator as the source of (non-secure) random data.
randomDirac(int, int, double[], double[]) - Static method in class jhplot.math.StatisticSample
2D array with Dirac random values
randomDirac(int, double[], double[]) - Static method in class jhplot.math.StatisticSample
1D array with Dirac random values
randomDoubleArray(int, int, AbstractDistribution) - Method in class jhplot.math.StatisticSample
Build 2D integer array list with integer numbers from input random number generator
randomDoubleArrayList(int, AbstractDistribution) - Method in class jhplot.math.StatisticSample
Build double array list with integer numbers from input random number generator
RandomEngine - Class in cern.jet.random.engine
Abstract base class for uniform pseudo-random number generating engines.
RandomEvent - Class in hep.lcio.test
 
RandomEvent(int) - Constructor for class hep.lcio.test.RandomEvent
 
RandomEvent() - Constructor for class hep.lcio.test.RandomEvent
 
RandomEventCommandHandler - Class in hep.lcio.util
CommandHandler for the random command.
RandomEventCommandHandler() - Constructor for class hep.lcio.util.RandomEventCommandHandler
 
RandomEventTest - Class in hep.lcio.test
 
RandomEventTest() - Constructor for class hep.lcio.test.RandomEventTest
 
randomExponential(int, int, double) - Static method in class jhplot.math.StatisticSample
2D array with exponential random distribution
randomExponential(int, double) - Static method in class jhplot.math.StatisticSample
1D array with exponential numbers
randomExponential(double, int) - Static method in class jhplot.stat.StatUtils
Return a new array of exponentially distributed doubles with parameter lambda.
RandomFunc - Class in org.jlab.groot.math
 
RandomFunc(Func1D) - Constructor for class org.jlab.groot.math.RandomFunc
 
RandomFunc(Func1D, int) - Constructor for class org.jlab.groot.math.RandomFunc
 
randomGausian(int, double, double, int, double, double) - Static method in class org.jlab.groot.math.FunctionFactory
generates a histogram with gaussian function
randomGausian2D(int, double, double, int, double, double) - Static method in class org.jlab.groot.math.FunctionFactory
 
randomGaussian(double, double, int) - Static method in class jhplot.stat.StatUtils
Return a new array of Gaussian distributed doubles with a given mean and standard deviation.
RandomGenerator - Interface in cern.jet.random.engine
Interface for uniform pseudo-random number generators.
RandomGenerator - Interface in org.apache.commons.math3.random
Interface extracted from java.util.Random.
RandomGeneratorFactory - Class in org.apache.commons.math3.random
Utilities for creating RandomGenerator instances.
randomh() - Method in class org.jlab.groot.math.RandomFunc
 
randomInstance(int, boolean, AbstractDistribution) - Static method in class cern.jet.random.Benchmark
generates random numbers from
randomInt(int, int, int, int) - Static method in class jhplot.math.StatisticSample
Random 2D array with integers
randomInt(int, int, int) - Static method in class jhplot.math.StatisticSample
Random array with integers
randomIntArray(int, Binomial) - Method in class jhplot.math.StatisticSample
Build integer array list with integer numbers from input random number generator
randomIntArray(int, int, AbstractDistribution) - Method in class jhplot.math.StatisticSample
Build 2D integer array list with integer numbers from input random number generator
randomIntArrayList(int, AbstractDistribution) - Method in class jhplot.math.StatisticSample
Build integer array list with integer numbers from input random number generator
randomize(RealDistribution, FeatureInitializer) - Static method in class org.apache.commons.math3.ml.neuralnet.FeatureInitializerFactory
Adds some amount of random data to the given initializer.
RandomKey<T> - Class in org.apache.commons.math3.genetics
Random Key chromosome is used for permutation representation.
RandomKey(List<Double>) - Constructor for class org.apache.commons.math3.genetics.RandomKey
Constructor.
RandomKey(Double[]) - Constructor for class org.apache.commons.math3.genetics.RandomKey
Constructor.
RandomKeyMutation - Class in org.apache.commons.math3.genetics
Mutation operator for RandomKeys.
RandomKeyMutation() - Constructor for class org.apache.commons.math3.genetics.RandomKeyMutation
 
randomLogNormal(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D Log-normal distribution
randomLogNormal(int, double, double) - Static method in class jhplot.math.StatisticSample
1D array with random Log-normal values
randomNormal(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D array with Gaussian numbers
randomNormal(int, double, double) - Static method in class jhplot.math.StatisticSample
1D array with Gaussian numbers
randomNormal(int, double, double) - Method in class jhplot.P0D
Fill with random numbers distributed using the normal (gaussian) distribution.
randomNormal(int, double, double) - Method in class jhplot.P0I
Fill with random numbers distributed using the normal (gaussian) distribution.
randomPermutation(int) - Static method in class org.apache.commons.math3.genetics.RandomKey
Generates a representation corresponding to a random permutation of length l which can be passed to the RandomKey constructor.
RandomPivotingStrategy - Class in org.apache.commons.math3.util
A strategy of selecting random index between begin and end indices.
RandomPivotingStrategy(RandomGenerator) - Constructor for class org.apache.commons.math3.util.RandomPivotingStrategy
Simple constructor.
randomPoisson(int, double) - Static method in class jhplot.math.StatisticSample
Build an array with Poisson distribution
randomPoisson(double, int) - Static method in class jhplot.stat.StatUtils
Return a new array of Poisson random variables (as doubles) with a given mean.
randomRejection(int, int, Expression, double, double, double) - Static method in class jhplot.math.StatisticSample
Build 2D random array using analytic function.
randomRejection(int, Expression, double, double, double) - Static method in class jhplot.math.StatisticSample
Build 1D array using analytic function.
RandomRNG - Class in jhplot.math.num.random
A random number generator that delegates random number generation to a Random object.
RandomRNG() - Constructor for class jhplot.math.num.random.RandomRNG
Create a random number generator using a default Random delegate.
RandomRNG(long) - Constructor for class jhplot.math.num.random.RandomRNG
Create a random number generator using a Random delegate initialized with the given seed.
RandomRNG(Random) - Constructor for class jhplot.math.num.random.RandomRNG
Create a random number generator using the given Random delegate.
RandomSampler - Class in cern.jet.random.sampling
Space and time efficiently computes a sorted Simple Random Sample Without Replacement (SRSWOR), that is, a sorted set of n random numbers from an interval of N numbers; Example: Computing n=3 random numbers from the interval [1,50] may yield the sorted random set (7,13,47).
RandomSampler(long, long, long, RandomEngine) - Constructor for class cern.jet.random.sampling.RandomSampler
Constructs a random sampler that computes and delivers sorted random sets in blocks.
RandomSamplingAssistant - Class in cern.jet.random.sampling
Conveniently computes a stable Simple Random Sample Without Replacement (SRSWOR) subsequence of n elements from a given input sequence of N elements; Example: Computing a sublist of n=3 random elements from a list (1,...,50) may yield the sublist (7,13,47).
RandomSamplingAssistant(long, long, RandomEngine) - Constructor for class cern.jet.random.sampling.RandomSamplingAssistant
Constructs a random sampler that samples n random elements from an input sequence of N elements.
RandomSeedGenerator - Class in cern.jet.random.engine
Deterministic seed generator for pseudo-random number generators.
RandomSeedGenerator() - Constructor for class cern.jet.random.engine.RandomSeedGenerator
Constructs and returns a new seed generator.
RandomSeedGenerator(int, int) - Constructor for class cern.jet.random.engine.RandomSeedGenerator
Constructs and returns a new seed generator; you normally won't need to use this method.
RandomSeedTable - Class in cern.jet.random.engine
(Seemingly gigantic) table of good seeds for pseudo-random number generators.
RandomTree - Class in org.jlab.groot.tree
 
RandomTree() - Constructor for class org.jlab.groot.tree.RandomTree
 
randomTriangular(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D array for Triangular random PDF
randomTriangular(int, double, double) - Static method in class jhplot.math.StatisticSample
1D array with Triangular random PDF
randomTriangular(int, int, double, double, double) - Static method in class jhplot.math.StatisticSample
2D array for Triangular
randomTriangular(int, double, double, double) - Static method in class jhplot.math.StatisticSample
1D array for Triangular
randomUniform(int, double, double) - Method in class jhplot.P0D
Fill with with uniform random numbers between min and max.
randomUniform(int, double, double) - Method in class jhplot.P0I
Fill with with uniform random numbers between min and max.
randomUniform(double, double, int) - Static method in class jhplot.stat.StatUtils
Return a new array of uniformly distributed doubles ranging from a to b.
RandomVectorGenerator - Interface in org.apache.commons.math3.random
This interface represents a random generator for whole vectors.
randomWeibull(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D Weibull
randomWeibull(int, double, double) - Static method in class jhplot.math.StatisticSample
1D Weibull
randUniform(int, double, double) - Static method in class jhplot.math.StatisticSample
2D array with uniform values
randUniform(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D array with random uniform values
range(double, double, double) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for a to b with steps of size step.
range(double, double) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for a to b inclusively with steps of size 1.
range(double[]) - Static method in class jhplot.math.ArrayMathUtils
returns the difference between the max and the min element
range(double) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for 0 to b with steps of size 1.
range(int, int) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for a to b with steps of size 1.
range(int) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for 0 to b with steps of size 1.
range(int, int, int) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for a to b with steps of size step.
range(int, int) - Method in class jhplot.P0D
Get range between min and max
range(int, int) - Method in class jhplot.P0I
Get range between min and max
range(int, int) - Method in class jhplot.P1D
Obtain a new PD1 in the range between Min and Max indexes.
range(int, int) - Static method in class org.apache.commons.math3.util.IntegerSequence
Creates a sequence {@code [start ..
range(int, int, int) - Static method in class org.apache.commons.math3.util.IntegerSequence
Creates a sequence \( a_i, i < 0 <= n \) where \( a_i = start + i * step \) and \( n \) is such that \( a_n <= max \) and \( a_{n+1} > max \).
Range(int, int, int) - Constructor for class org.apache.commons.math3.util.IntegerSequence.Range
Creates a sequence \( a_i, i < 0 <= n \) where \( a_i = start + i * step \) and \( n \) is such that \( a_n <= max \) and \( a_{n+1} > max \).
range() - Method in class org.freehep.math.minuit.MinosError
 
range(int) - Method in class org.freehep.math.minuit.MnMinos
 
range(int, double) - Method in class org.freehep.math.minuit.MnMinos
 
range(int, double, int) - Method in class org.freehep.math.minuit.MnMinos
Causes a MINOS error analysis for external parameter n.
RANGE - Static variable in class org.jfree.chart.axis.CategoryLabelWidthType
Percentage of range.
RANGE - Static variable in class org.jfree.chart.block.LengthConstraintType
Range.
Range - Class in org.jfree.data
Represents an immutable range of values.
Range(double, double) - Constructor for class org.jfree.data.Range
Creates a new range.
Range - Class in org.nfunk.jep.function
The list function.
Range() - Constructor for class org.nfunk.jep.function.Range
 
rangeCut(int, double, double) - Method in class jhplot.P1D
Construct P1D removing a range of values defined by Min and Max.
RangeInfo - Interface in org.jfree.data
An interface (optional) that can be implemented by a dataset to assist in determining the minimum and maximum values.
RangeSlider - Class in org.jlab.groot.ui
An extension of JSlider to select a range of values using two thumb controls.
RangeSlider() - Constructor for class org.jlab.groot.ui.RangeSlider
Constructs a RangeSlider with default minimum and maximum values of 0 and 100.
RangeSlider(int, int) - Constructor for class org.jlab.groot.ui.RangeSlider
Constructs a RangeSlider with the specified default minimum and maximum values.
RangeType - Class in org.jfree.data
Used to indicate the type of range to display on an axis (full, positive or negative).
rank(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the effective numerical rank of matrix A, obtained from Singular Value Decomposition.
rank() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the effective numerical matrix rank, which is the number of nonnegligible singular values.
rank() - Method in class Jama.Matrix
Matrix rank
rank() - Method in class Jama.SingularValueDecomposition
Effective numerical matrix rank
rank(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
rank() - Method in class jhplot.math.SingularValueDecomposition
Effective numerical matrix rank
rank(double[]) - Method in class org.apache.commons.math3.stat.ranking.NaturalRanking
Rank data using the natural ordering on Doubles, with NaN values handled according to nanStrategy and ties resolved using tiesStrategy.
rank(double[]) - Method in interface org.apache.commons.math3.stat.ranking.RankingAlgorithm
Performs a rank transformation on the input data, returning an array of ranks.
Rank - Class in org.lsmp.djep.jama
Find the rank of a matrix.
Rank() - Constructor for class org.lsmp.djep.jama.Rank
 
rank() - Method in class org.lsmp.djep.vectorJep.Dimensions
rank of dimensions 0 for numbers, 1 for vectors, 2 for matrices
RankingAlgorithm - Interface in org.apache.commons.math3.stat.ranking
Interface representing a rank transformation.
rankInterpolated(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the linearly interpolated number of elements in a list less or equal to a given element.
rapidity() - Method in class hephysics.jet.ParticleD
Compute rapidity.
rapidity() - Method in class hephysics.particle.HEParticle
Compute rapidity.
rapidity() - Method in class hephysics.vec.Hep3Vector
Rapidity.
rapidity() - Method in class hephysics.vec.HepLorentzVector
Rapidity.
Rational - Class in org.lsmp.djep.groupJep.values
A Rational number with full precision.
Rational(BigInteger) - Constructor for class org.lsmp.djep.groupJep.values.Rational
 
Rational(BigInteger, BigInteger) - Constructor for class org.lsmp.djep.groupJep.values.Rational
Rationals will always be represented in most reduced form with a positive denominator.
Rationals - Class in org.lsmp.djep.groupJep.groups
The Field of rational numbers.
Rationals() - Constructor for class org.lsmp.djep.groupJep.groups.Rationals
 
raw() - Method in class cern.jet.random.engine.MersenneTwister64
Returns a 64 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
raw() - Method in class cern.jet.random.engine.RandomEngine
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
raw() - Method in interface cern.jet.random.engine.RandomGenerator
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
raw() - Static method in class jhplot.math.Random
Generate a random number between 0 and 1.
RAWCALORIMETERHIT - Static variable in interface hep.lcio.event.LCIO
 
RawCalorimeterHit - Interface in hep.lcio.event
The generic calorimeter hit for real data (or simulation thereof).
Rayleigh - Class in jhplot.math.num.pdf
The Rayleigh distribution.
Rayleigh() - Constructor for class jhplot.math.num.pdf.Rayleigh
Default constructor.
Rayleigh(double) - Constructor for class jhplot.math.num.pdf.Rayleigh
Create a distribution with the scale parameter.
RayleighRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Rayleigh distribution.
RayleighRandomVariable() - Constructor for class jhplot.math.num.random.RayleighRandomVariable
Default constructor.
RayleighRandomVariable(double) - Constructor for class jhplot.math.num.random.RayleighRandomVariable
Create a random variable with the given mean.
RayleighRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.RayleighRandomVariable
Create a random variable with the given parameters.
RCDoubleMatrix2D - Class in cern.colt.matrix.impl
Sparse row-compressed 2-d matrix holding double elements.
RCDoubleMatrix2D(double[][]) - Constructor for class cern.colt.matrix.impl.RCDoubleMatrix2D
Constructs a matrix with a copy of the given values.
RCDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.impl.RCDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
RCHBIT_BARREL - Static variable in interface hep.lcio.event.LCIO
 
RCHBIT_ENERGY_ERROR - Static variable in interface hep.lcio.event.LCIO
 
RCHBIT_ID1 - Static variable in interface hep.lcio.event.LCIO
 
RCHBIT_LONG - Static variable in interface hep.lcio.event.LCIO
 
RCHBIT_NO_PTR - Static variable in interface hep.lcio.event.LCIO
 
RCHBIT_TIME - Static variable in interface hep.lcio.event.LCIO
 
re - Variable in class Jampack.Z
The real part of Z.
re(Object) - Method in class org.nfunk.jep.function.Real
 
re() - Method in class org.nfunk.jep.type.Complex
Returns the real component of this object
read(BufferedReader) - Static method in class Jama.Matrix
Read a matrix from a stream.
read(String) - Method in class jhplot.HPlot
Read HPlot file and inserts graphs to the main frame.
read(String) - Method in class jhplot.io.CFBook
Read external XML file with all objects (H1D, H2D, P1D)
read() - Method in class jhplot.io.EFile
Read next event
read(int) - Method in class jhplot.io.EFile
Get object from a file using its index.
read() - Method in class jhplot.io.HFile
Get object from a file.
read(String) - Method in class jhplot.io.HFile
Read an object using a key if exits.
read() - Method in class jhplot.io.HFileDIF
Read data as sheet.
read() - Method in class jhplot.io.HFileXML
Get object from a file.
read(String) - Method in class jhplot.io.HFileXML
Read an object using a key if exits.
read(String) - Method in class jhplot.io.PFile
Get object from a file using its name.
read() - Method in class jhplot.io.PFile
Read next object
read(int) - Method in class jhplot.io.PFile
Get object from a file using its index.
read(URL) - Static method in class jhplot.io.PReader
Read data from URL.
read(File) - Static method in class jhplot.io.PReader
Read from a file.
read(String) - Static method in class jhplot.io.PReader
Read data from a given location.
read(File, boolean) - Static method in class jhplot.IO
Read an object from a serialized file
read(URL, boolean) - Static method in class jhplot.IO
Read an object from an URL
read(String) - Static method in class jhplot.IO
Read an object from a serialized file.
read(File, boolean) - Static method in class jhplot.io.Serialized
Read an object from a serialized file
read(URL, boolean) - Static method in class jhplot.io.Serialized
Read an object from an URL
read(String) - Static method in class jhplot.io.Serialized
Read an object from a serialized file.
read(File) - Static method in class jhplot.math.io.ASCIIFile
 
read() - Method in class jhplot.math.io.ASCIIFile
Read an ASCII File
read() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
read(byte[], int, int) - Method in class jhplot.math.io.LEDataInputStream
 
read(byte[], int, int) - Method in class jhplot.math.io.LERandomAccessFile
 
read(byte[]) - Method in class jhplot.math.io.LERandomAccessFile
 
read() - Method in class jhplot.math.io.LERandomAccessFile
 
read(BufferedReader) - Static method in class jhplot.math.kalman.jama.Matrix
Read a matrix from a stream.
read(InputStream, boolean) - Static method in class jhplot.math.pca.DataReader
Read data matrix from a CSV file.
read(BufferedReader) - Method in class jhplot.P0D
Read one dimensional data from uncompressed ASCII file.
read(File) - Method in class jhplot.P0D
Read P0D from a file.
read(URL) - Method in class jhplot.P0D
Read data from URL.
read(String) - Method in class jhplot.P0D
Read PNI from a file.
read(BufferedReader) - Method in class jhplot.P0I
Read one dimensional data from uncompressed ASCII file.
read(File) - Method in class jhplot.P0I
Read P0I from a file.
read(URL) - Method in class jhplot.P0I
Read data from URL.
read(String) - Method in class jhplot.P0I
Read PNI from a file.
read(BufferedReader) - Method in class jhplot.P1D
Read data using 10-column format.
read(URL) - Method in class jhplot.P1D
Read data from URL.
read(String) - Method in class jhplot.P1D
Read P1D from a file.
read(BufferedReader) - Method in class jhplot.P2D
Read P2D from a file.
read(File) - Method in class jhplot.P2D
Read P2D from a file.
read(URL) - Method in class jhplot.P2D
Read data from URL.
read(String) - Method in class jhplot.P2D
Read P2D from a file.
read(String) - Method in class jhplot.P3D
Read P3D from a file.
read(BufferedReader) - Method in class jhplot.PND
Read the data from an external source.
read(File) - Method in class jhplot.PND
Read PND from a file.
read(URL) - Method in class jhplot.PND
Read data from URL.
read(String) - Method in class jhplot.PND
Read PND from a file.
read(BufferedReader) - Method in class jhplot.PNI
Read the data from external file.
read(File) - Method in class jhplot.PNI
Read PNI from a file.
read(URL) - Method in class jhplot.PNI
Read data from URL.
read(String) - Method in class jhplot.PNI
Read PNI from a file.
read(String) - Method in class jminhep.cluster.DataHolder
Reads the input data from the ARFF file and stores in the data holder
read() - Method in class org.apache.commons.io.input.AbstractCharacterFilterReader
 
read(char[], int, int) - Method in class org.apache.commons.io.input.AbstractCharacterFilterReader
 
read() - Method in class org.apache.commons.io.input.BOMInputStream
Invokes the delegate's read() method, detecting and optionally skipping BOM.
read(byte[], int, int) - Method in class org.apache.commons.io.input.BOMInputStream
Invokes the delegate's read(byte[], int, int) method, detecting and optionally skipping BOM.
read(byte[]) - Method in class org.apache.commons.io.input.BOMInputStream
Invokes the delegate's read(byte[]) method, detecting and optionally skipping BOM.
read() - Method in class org.apache.commons.io.input.BoundedInputStream
Invokes the delegate's read() method if the current position is less than the limit.
read(byte[]) - Method in class org.apache.commons.io.input.BoundedInputStream
Invokes the delegate's read(byte[]) method.
read(byte[], int, int) - Method in class org.apache.commons.io.input.BoundedInputStream
Invokes the delegate's read(byte[], int, int) method.
read() - Method in class org.apache.commons.io.input.BoundedReader
Reads a single character
read(char[], int, int) - Method in class org.apache.commons.io.input.BoundedReader
Reads into an array
read() - Method in class org.apache.commons.io.input.BrokenInputStream
Throws the configured exception.
read(char[], int, int) - Method in class org.apache.commons.io.input.BrokenReader
Throws the configured exception.
read() - Method in class org.apache.commons.io.input.buffer.CircularBufferInputStream
 
read(byte[]) - Method in class org.apache.commons.io.input.buffer.CircularBufferInputStream
 
read(byte[], int, int) - Method in class org.apache.commons.io.input.buffer.CircularBufferInputStream
 
read() - Method in class org.apache.commons.io.input.buffer.CircularByteBuffer
Returns the next byte from the buffer, removing it at the same time, so that following invocations won't return it again.
read(byte[], int, int) - Method in class org.apache.commons.io.input.buffer.CircularByteBuffer
Returns the given number of bytes from the buffer by storing them in the given byte array at the given offset.
read(byte[], int, int) - Method in class org.apache.commons.io.input.CharSequenceInputStream
 
read() - Method in class org.apache.commons.io.input.CharSequenceInputStream
 
read(byte[]) - Method in class org.apache.commons.io.input.CharSequenceInputStream
 
read() - Method in class org.apache.commons.io.input.CharSequenceReader
Read a single character.
read(char[], int, int) - Method in class org.apache.commons.io.input.CharSequenceReader
Read the specified number of characters into the array.
read() - Method in class org.apache.commons.io.input.CircularInputStream
 
read() - Method in class org.apache.commons.io.input.ClosedInputStream
Returns -1 to indicate that the stream is closed.
read(char[], int, int) - Method in class org.apache.commons.io.input.ClosedReader
Returns -1 to indicate that the stream is closed.
read() - Method in class org.apache.commons.io.input.DemuxInputStream
Reads byte from stream associated with current thread.
read() - Method in class org.apache.commons.io.input.NullInputStream
Read a byte.
read(byte[]) - Method in class org.apache.commons.io.input.NullInputStream
Read some bytes into the specified array.
read(byte[], int, int) - Method in class org.apache.commons.io.input.NullInputStream
Read the specified number bytes into an array.
read() - Method in class org.apache.commons.io.input.NullReader
Reads a character.
read(char[]) - Method in class org.apache.commons.io.input.NullReader
Reads some characters into the specified array.
read(char[], int, int) - Method in class org.apache.commons.io.input.NullReader
Reads the specified number characters into an array.
read() - Method in class org.apache.commons.io.input.ObservableInputStream
 
read(byte[]) - Method in class org.apache.commons.io.input.ObservableInputStream
 
read(byte[], int, int) - Method in class org.apache.commons.io.input.ObservableInputStream
 
read() - Method in class org.apache.commons.io.input.ProxyInputStream
Invokes the delegate's read() method.
read(byte[]) - Method in class org.apache.commons.io.input.ProxyInputStream
Invokes the delegate's read(byte[]) method.
read(byte[], int, int) - Method in class org.apache.commons.io.input.ProxyInputStream
Invokes the delegate's read(byte[], int, int) method.
read() - Method in class org.apache.commons.io.input.ProxyReader
Invokes the delegate's read() method.
read(char[]) - Method in class org.apache.commons.io.input.ProxyReader
Invokes the delegate's read(char[]) method.
read(char[], int, int) - Method in class org.apache.commons.io.input.ProxyReader
Invokes the delegate's read(char[], int, int) method.
read(CharBuffer) - Method in class org.apache.commons.io.input.ProxyReader
Invokes the delegate's read(CharBuffer) method.
read() - Method in class org.apache.commons.io.input.RandomAccessFileInputStream
 
read(byte[]) - Method in class org.apache.commons.io.input.RandomAccessFileInputStream
 
read(byte[], int, int) - Method in class org.apache.commons.io.input.RandomAccessFileInputStream
 
read(byte[], int, int) - Method in class org.apache.commons.io.input.ReaderInputStream
Read the specified number of bytes into an array.
read(byte[]) - Method in class org.apache.commons.io.input.ReaderInputStream
Read the specified number of bytes into an array.
read() - Method in class org.apache.commons.io.input.ReaderInputStream
Read a single byte.
read() - Method in class org.apache.commons.io.input.SequenceReader
 
read(char[], int, int) - Method in class org.apache.commons.io.input.SequenceReader
 
read() - Method in class org.apache.commons.io.input.TeeInputStream
Reads a single byte from the proxied input stream and writes it to the associated output stream.
read(byte[], int, int) - Method in class org.apache.commons.io.input.TeeInputStream
Reads bytes from the proxied input stream and writes the read bytes to the associated output stream.
read(byte[]) - Method in class org.apache.commons.io.input.TeeInputStream
Reads bytes from the proxied input stream and writes the read bytes to the associated output stream.
read() - Method in class org.apache.commons.io.input.TeeReader
Reads a single character from the proxied reader and writes it to the associated writer.
read(char[]) - Method in class org.apache.commons.io.input.TeeReader
Reads characters from the proxied reader and writes the read characters to the associated writer.
read(char[], int, int) - Method in class org.apache.commons.io.input.TeeReader
Reads characters from the proxied reader and writes the read characters to the associated writer.
read(CharBuffer) - Method in class org.apache.commons.io.input.TeeReader
Reads characters from the proxied reader and writes the read characters to the associated writer.
read() - Method in class org.apache.commons.io.input.UnixLineEndingInputStream
read() - Method in class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
 
read(byte[]) - Method in class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
 
read(byte[], int, int) - Method in class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
 
read() - Method in class org.apache.commons.io.input.WindowsLineEndingInputStream
read(char[], int, int) - Method in class org.apache.commons.io.input.XmlStreamReader
Invokes the underlying reader's read(char[], int, int) method.
read(InputStream, byte[]) - Static method in class org.apache.commons.io.IOUtils
Reads bytes from an input stream.
read(InputStream, byte[], int, int) - Static method in class org.apache.commons.io.IOUtils
Reads bytes from an input stream.
read(ReadableByteChannel, ByteBuffer) - Static method in class org.apache.commons.io.IOUtils
Reads bytes from a ReadableByteChannel.
read(Reader, char[]) - Static method in class org.apache.commons.io.IOUtils
Reads characters from an input character stream.
read(Reader, char[], int, int) - Static method in class org.apache.commons.io.IOUtils
Reads characters from an input character stream.
read1DArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads an array from a file.
read1DBooleanArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads an array from a file.
read1DFloatArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads an array from a file.
read1DIntArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads an array from a file.
read2DArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read2DBooleanArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read2DFloatArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read2DIntArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read3DArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read3DBooleanArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read3DFloatArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read3DIntArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read4DArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read4DBooleanArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read4DFloatArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read4DIntArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read5DArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read5DBooleanArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read5DFloatArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
read5DIntArray(String) - Static method in class jhplot.io.ArrayReaderWriter
Reads a rectangular jagged array from a file.
READ_ONLY - Static variable in interface hep.lcio.event.LCIO
 
READ_ONLY - Static variable in class org.apache.commons.io.filefilter.CanReadFileFilter
Singleton instance of read-only filter
readBinary(String) - Method in class jhplot.P0D
Read a P0D from a binary file (big endian by default).
readBinary(String) - Method in class jhplot.P0I
Read a P0I from a binary file (big endian by default).
readBoolean() - Method in class jhplot.math.io.LEDataInputStream
 
readBoolean() - Method in class jhplot.math.io.LERandomAccessFile
 
readBoolean() - Method in class org.apache.commons.io.input.SwappedDataInputStream
readByte() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readByte() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readByte() - Method in class jhplot.math.io.LEDataInputStream
 
readByte() - Method in class jhplot.math.io.LERandomAccessFile
 
readByte() - Method in class org.apache.commons.io.input.SwappedDataInputStream
Invokes the delegate's read() method.
readByteArray() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readByteArray() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readCategoryDataset(Reader) - Method in class org.jfree.data.io.CSV
Reads a CategoryDataset from a CSV file or input source.
readCategoryDatasetFromXML(File) - Static method in class org.jfree.data.xml.DatasetReader
Reads a CategoryDataset from a file.
readCategoryDatasetFromXML(InputStream) - Static method in class org.jfree.data.xml.DatasetReader
Reads a CategoryDataset from a stream.
readChar() - Method in class jhplot.math.io.LEDataInputStream
 
readChar() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readChar except little endian.
readChar() - Method in class jplot3dp.MathParser.SimpleCharStream
 
readChar() - Method in class org.apache.commons.io.input.SwappedDataInputStream
Reads a character delegating to SwappedDataInputStream.readShort().
readChar() - Method in class org.nfunk.jep.JavaCharStream
 
readColor(DataInputStream) - Static method in class jplot3d.Utils
 
readCurrentFile() - Method in class hep.lcio.util.LCIOConcat
 
readDouble() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readDouble() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readDouble() - Method in class jhplot.math.io.LEDataInputStream
 
readDouble() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readDouble except little endian.
readDouble() - Method in class org.apache.commons.io.input.SwappedDataInputStream
readDouble1DArray(File) - Static method in class jhplot.math.io.ASCIIFile
 
readDoubleArray(File) - Static method in class jhplot.math.io.ASCIIFile
 
readDoubleArray(File, String) - Static method in class jhplot.math.io.BinaryFile
 
readDoubleArray() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readDoubleArray(InputStream, String) - Static method in class jhplot.math.io.BinaryInputStream
 
readDoubleArray() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readDoubleArray(int, int) - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readEntry(int) - Method in interface org.jlab.groot.tree.ITree
 
readEntry(int) - Method in class org.jlab.groot.tree.Tree
 
readEntry(int) - Method in class org.jlab.groot.tree.TreeTextFile
 
reader() - Method in class hep.lcio.util.MergeFileParameters
Get the LCReader associated with these input events.
ReaderInputStream - Class in org.apache.commons.io.input
InputStream implementation that reads a character stream from a Reader and transforms it to a byte stream using a specified charset encoding.
ReaderInputStream(Reader, CharsetEncoder) - Constructor for class org.apache.commons.io.input.ReaderInputStream
Construct a new ReaderInputStream.
ReaderInputStream(Reader, CharsetEncoder, int) - Constructor for class org.apache.commons.io.input.ReaderInputStream
Construct a new ReaderInputStream.
ReaderInputStream(Reader, Charset, int) - Constructor for class org.apache.commons.io.input.ReaderInputStream
Construct a new ReaderInputStream.
ReaderInputStream(Reader, Charset) - Constructor for class org.apache.commons.io.input.ReaderInputStream
Construct a new ReaderInputStream with a default input buffer size of characters.
ReaderInputStream(Reader, String, int) - Constructor for class org.apache.commons.io.input.ReaderInputStream
Construct a new ReaderInputStream.
ReaderInputStream(Reader, String) - Constructor for class org.apache.commons.io.input.ReaderInputStream
Construct a new ReaderInputStream with a default input buffer size of characters.
ReaderInputStream(Reader) - Constructor for class org.apache.commons.io.input.ReaderInputStream
readEvent(int, int) - Method in interface hep.lcio.io.LCReader
Reads the specified event from file.
readEvent(int, int, int) - Method in interface hep.lcio.io.LCReader
Same as LCEvent* readEvent(int runNumber, int evtNumber) allowing to set the access mode LCIO::READ_ONLY (default) or LCIO::Update.
readExternal(ObjectInput) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
readExternal(ObjectInput) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
ReadFile - Static variable in class jhplot.JHPlot
 
readFile(String) - Method in class org.jlab.groot.data.GraphErrors
 
readFile(String) - Method in class org.jlab.groot.data.TDirectory
 
readFile(String) - Method in class org.jlab.groot.tree.TreeTextFile
 
readFile(String, String) - Method in class org.jlab.groot.tree.TreeTextFile
 
readFileToByteArray(File) - Static method in class org.apache.commons.io.FileUtils
Reads the contents of a file into a byte array.
readFileToString(File) - Static method in class org.apache.commons.io.FileUtils
Deprecated.
2.5 use FileUtils.readFileToString(File, Charset) instead (and specify the appropriate encoding)
readFileToString(File, Charset) - Static method in class org.apache.commons.io.FileUtils
Reads the contents of a file into a String.
readFileToString(File, String) - Static method in class org.apache.commons.io.FileUtils
Reads the contents of a file into a String.
readFloat() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readFloat() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readFloat() - Method in class jhplot.math.io.LEDataInputStream
 
readFloat() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readFloat except little endian.
readFloat() - Method in class org.apache.commons.io.input.SwappedDataInputStream
readFloatArray(File, String) - Static method in class jhplot.math.io.BinaryFile
 
readFloatArray() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readFloatArray(InputStream, String) - Static method in class jhplot.math.io.BinaryInputStream
 
readFloatArray() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readFromStream(DataInputStream) - Method in class jplot3dp.ModelView.AxesDefinition
 
readFromStream(DataInputStream) - Method in class jplot3dp.ModelView.FunctionsList
 
readFromStream(DataInputStream) - Method in class jplot3dp.ModelView.ModelFunction
 
readFromStream(DataInputStream) - Method in class jplot3dp.ModelView
 
readFully(byte[]) - Method in class jhplot.math.io.LEDataInputStream
 
readFully(byte[], int, int) - Method in class jhplot.math.io.LEDataInputStream
 
readFully(byte[]) - Method in class jhplot.math.io.LERandomAccessFile
 
readFully(byte[], int, int) - Method in class jhplot.math.io.LERandomAccessFile
 
readFully(byte[]) - Method in class org.apache.commons.io.input.SwappedDataInputStream
Invokes the delegate's read(byte[] data, int, int) method.
readFully(byte[], int, int) - Method in class org.apache.commons.io.input.SwappedDataInputStream
Invokes the delegate's read(byte[] data, int, int) method.
readFully(InputStream, byte[]) - Static method in class org.apache.commons.io.IOUtils
Reads the requested number of bytes or fail if there are not enough left.
readFully(InputStream, byte[], int, int) - Static method in class org.apache.commons.io.IOUtils
Reads the requested number of bytes or fail if there are not enough left.
readFully(InputStream, int) - Static method in class org.apache.commons.io.IOUtils
Reads the requested number of bytes or fail if there are not enough left.
readFully(ReadableByteChannel, ByteBuffer) - Static method in class org.apache.commons.io.IOUtils
Reads the requested number of bytes or fail if there are not enough left.
readFully(Reader, char[]) - Static method in class org.apache.commons.io.IOUtils
Reads the requested number of characters or fail if there are not enough left.
readFully(Reader, char[], int, int) - Static method in class org.apache.commons.io.IOUtils
Reads the requested number of characters or fail if there are not enough left.
readGZip(File) - Static method in class jhplot.io.PReader
Read data from a gzipped file (GNU gzip/gunzip commands in linux)
readGZip(URL) - Static method in class jhplot.io.PReader
Read data from URL.
readGZip(String) - Static method in class jhplot.io.PReader
Read data from either URL or file
readGZip(String) - Method in class jhplot.P0D
Read P0D from a GZiped file.
readGZip(File) - Method in class jhplot.P0D
Read PNI from a GZiped file.
readGZip(String) - Method in class jhplot.P0I
Read P0I from a GZiped file.
readGZip(File) - Method in class jhplot.P0I
Read PNI from a GZiped file.
readGZip(String) - Method in class jhplot.P1D
Read P1D from a GZiped file.
readGZip(String) - Method in class jhplot.P2D
Read P2D from a GZiped file.
readGZip(String) - Method in class jhplot.P3D
Read P3D from a GZipped file.
readGZip(String) - Method in class jhplot.PND
Read PND from a GZiped file.
readGZip(File) - Method in class jhplot.PND
Read PND from a GZiped file.
readGZip(String) - Method in class jhplot.PNI
Read PNI from a GZiped file.
readGZip(File) - Method in class jhplot.PNI
Read PNI from a GZiped file.
readInfo() - Static method in class jhplot.JHPlot
 
readInt() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readInt() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readInt() - Method in class jhplot.math.io.LEDataInputStream
 
readInt() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readInt except little endian.
readInt() - Method in class org.apache.commons.io.input.SwappedDataInputStream
readInt1DArray(File) - Static method in class jhplot.math.io.ASCIIFile
 
readIntArray(File) - Static method in class jhplot.math.io.ASCIIFile
 
readIntArray(File, String) - Static method in class jhplot.math.io.BinaryFile
 
readIntArray() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readIntArray(InputStream, String) - Static method in class jhplot.math.io.BinaryInputStream
 
readIntArray() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readLine(File, int) - Static method in class jhplot.math.io.ASCIIFile
 
readLine(int) - Method in class jhplot.math.io.ASCIIFile
Read only one line in an ASCII File
readLine() - Method in class jhplot.math.io.LEDataInputStream
 
readLine() - Method in class jhplot.math.io.LERandomAccessFile
 
readLine() - Method in class org.apache.commons.io.input.ReversedLinesFileReader
Returns the lines of the file from bottom to top.
readLine() - Method in class org.apache.commons.io.input.SwappedDataInputStream
Not currently supported - throws UnsupportedOperationException.
readLines(File) - Static method in class jhplot.math.io.ASCIIFile
 
readLines() - Method in class jhplot.math.io.ASCIIFile
Read lines of an ASCII File
readLines(File) - Static method in class org.apache.commons.io.FileUtils
Deprecated.
2.5 use FileUtils.readLines(File, Charset) instead (and specify the appropriate encoding)
readLines(File, Charset) - Static method in class org.apache.commons.io.FileUtils
Reads the contents of a file line by line to a List of Strings.
readLines(File, String) - Static method in class org.apache.commons.io.FileUtils
Reads the contents of a file line by line to a List of Strings.
readLines(int) - Method in class org.apache.commons.io.input.ReversedLinesFileReader
Returns lineCount lines of the file from bottom to top.
readLines(InputStream) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
readLines(InputStream, Charset) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of an InputStream as a list of Strings, one entry per line, using the specified character encoding.
readLines(InputStream, String) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of an InputStream as a list of Strings, one entry per line, using the specified character encoding.
readLines(Reader) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a Reader as a list of Strings, one entry per line.
readLong() - Method in class jhplot.math.io.LEDataInputStream
 
readLong() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readLong except little endian.
readLong() - Method in class org.apache.commons.io.input.SwappedDataInputStream
Readme - Static variable in interface jminhep.gui.Constants
 
readNext() - Method in class org.jlab.groot.io.TextFileReader
reads the next line in the file and populates the internal list of tokens
readNext() - Method in interface org.jlab.groot.tree.ITree
 
readNext() - Method in class org.jlab.groot.tree.RandomTree
 
readNext() - Method in class org.jlab.groot.tree.Tree
 
readNext() - Method in class org.jlab.groot.tree.TreeTextFile
 
readNextEvent() - Method in interface hep.lcio.io.LCReader
Reads the next event from the file.
readNextEvent(int) - Method in interface hep.lcio.io.LCReader
Same as readNextEvent() but allows to set the access mode LCIO::READ_ONLY (default) or LCIO::Update.
readNextRunHeader() - Method in interface hep.lcio.io.LCReader
Reads the next run header from the file.
readNextRunHeader(int) - Method in interface hep.lcio.io.LCReader
Same as readNextRunHeader() but allows to set the access mode LCIO::READ_ONLY (default) or LCIO::Update.
readObject() - Method in class jhplot.io.db.RecordReader
Reads the next object in the record using an ObjectInputStream.
readObject() - Method in class root.FakeTKey
 
ReadOnlyException - Exception in hep.lcio.exceptions
An exception thrown when attempting to modify a read-only object
ReadOnlyException() - Constructor for exception hep.lcio.exceptions.ReadOnlyException
 
readPieDatasetFromXML(File) - Static method in class org.jfree.data.xml.DatasetReader
Reads a PieDataset from an XML file.
readPieDatasetFromXML(InputStream) - Static method in class org.jfree.data.xml.DatasetReader
Reads a PieDataset from a stream.
readProject(String) - Method in class jplot.JPlot
Load the script from a file in memory after heaving cleared the actual data.
readRecord(String) - Method in class jhplot.io.db.BaseRecordsFile
Reads a record.
readRunHeader(int) - Method in interface hep.lcio.io.LCReader
Reads the specified runHeader from file.
readRunHeader(int, int) - Method in interface hep.lcio.io.LCReader
Same as LCEvent* readRunHeader(int runNumber) allowing to set the access mode LCIO::READ_ONLY (default) or LCIO::Update.
readScript(File, HPlot) - Static method in class jhplot.io.JHreader
Read the file.
readSerialized(String) - Method in class jhplot.P0D
Read a P0D object from a serialized file
readSerialized(String) - Method in class jhplot.P0I
Read a P0I object from a serialized file
readSerialized(String) - Method in class jhplot.P1D
Read a P1D object from a serialized file
readSerialized(String) - Method in class jhplot.P2D
Read a P2D object from a serialized file
readSerialized(String) - Method in class jhplot.P3D
Read a P3D object from a serialized file
readSerialized(String) - Method in class jhplot.PND
Read a PND object from a serialized file
readSerialized(String) - Method in class jhplot.PNI
Read a PNI object from a serialized file
readShort() - Method in class jhplot.math.io.LEDataInputStream
 
readShort() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readShort except little endian.
readShort() - Method in class org.apache.commons.io.input.SwappedDataInputStream
readStream() - Method in interface hep.lcio.io.LCReader
Reads the input stream and notifies registered listeners according to the object type found in the stream.
readStream(int) - Method in interface hep.lcio.io.LCReader
Reads maxRecord from the input stream and notifies registered listeners according to the object type found in the stream.
readString1DDouble(String) - Static method in class jhplot.math.io.ArrayString
 
readString1DDouble(String, String, String) - Static method in class jhplot.math.io.ArrayString
 
readString1DInt(String) - Static method in class jhplot.math.io.ArrayString
 
readString1DInt(String, String, String) - Static method in class jhplot.math.io.ArrayString
 
readStringDouble(String) - Static method in class jhplot.math.io.ArrayString
 
readStringDouble(String, String, String) - Static method in class jhplot.math.io.ArrayString
 
readStringInt(String) - Static method in class jhplot.math.io.ArrayString
 
readStringInt(String, String, String) - Static method in class jhplot.math.io.ArrayString
 
readSwappedDouble(byte[], int) - Static method in class org.apache.commons.io.EndianUtils
Reads a "double" value from a byte array at a given offset.
readSwappedDouble(InputStream) - Static method in class org.apache.commons.io.EndianUtils
Reads a "double" value from an InputStream.
readSwappedFloat(byte[], int) - Static method in class org.apache.commons.io.EndianUtils
Reads a "float" value from a byte array at a given offset.
readSwappedFloat(InputStream) - Static method in class org.apache.commons.io.EndianUtils
Reads a "float" value from an InputStream.
readSwappedInteger(byte[], int) - Static method in class org.apache.commons.io.EndianUtils
Reads a "int" value from a byte array at a given offset.
readSwappedInteger(InputStream) - Static method in class org.apache.commons.io.EndianUtils
Reads a "int" value from an InputStream.
readSwappedLong(byte[], int) - Static method in class org.apache.commons.io.EndianUtils
Reads a "long" value from a byte array at a given offset.
readSwappedLong(InputStream) - Static method in class org.apache.commons.io.EndianUtils
Reads a "long" value from an InputStream.
readSwappedShort(byte[], int) - Static method in class org.apache.commons.io.EndianUtils
Reads a "short" value from a byte array at a given offset.
readSwappedShort(InputStream) - Static method in class org.apache.commons.io.EndianUtils
Reads a "short" value from an InputStream.
readSwappedUnsignedInteger(byte[], int) - Static method in class org.apache.commons.io.EndianUtils
Reads an unsigned integer (32-bit) value from a byte array at a given offset.
readSwappedUnsignedInteger(InputStream) - Static method in class org.apache.commons.io.EndianUtils
Reads a unsigned integer (32-bit) from an InputStream.
readSwappedUnsignedShort(byte[], int) - Static method in class org.apache.commons.io.EndianUtils
Reads an unsigned short (16-bit) value from a byte array at a given offset.
readSwappedUnsignedShort(InputStream) - Static method in class org.apache.commons.io.EndianUtils
Reads a unsigned short (16-bit) from an InputStream.
readUnsignedByte() - Method in class jhplot.math.io.LEDataInputStream
 
readUnsignedByte() - Method in class jhplot.math.io.LERandomAccessFile
 
readUnsignedByte() - Method in class org.apache.commons.io.input.SwappedDataInputStream
Invokes the delegate's read() method.
readUnsignedShort() - Method in class jhplot.math.io.LEDataInputStream
 
readUnsignedShort() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readUnsignedShort except little endian.
readUnsignedShort() - Method in class org.apache.commons.io.input.SwappedDataInputStream
readUTF() - Method in class jhplot.math.io.LEDataInputStream
 
readUTF(DataInput) - Static method in class jhplot.math.io.LEDataInputStream
 
readUTF() - Method in class jhplot.math.io.LERandomAccessFile
 
readUTF() - Method in class org.apache.commons.io.input.SwappedDataInputStream
Not currently supported - throws UnsupportedOperationException.
readXML(String) - Static method in class jhplot.IO
Read an object from a serialized XML file (should be written using writeXML() method).
readXML(String) - Static method in class jhplot.io.Serialized
Read an object from a serialized XML file (should be written using writeXML() method).
ready() - Method in class org.apache.commons.io.input.BrokenReader
Throws the configured exception.
ready() - Method in class org.apache.commons.io.input.CharSequenceReader
Tells whether this stream is ready to be read.
ready() - Method in class org.apache.commons.io.input.ProxyReader
Invokes the delegate's ready() method.
readZip(String) - Method in class jhplot.P0D
Read one dimensional data from ZIP ASCII file.
readZip(String) - Method in class jhplot.P0I
Read one dimensional data from ZIP ASCII file.
readZip(String) - Method in class jhplot.P1D
Read P1D from a Zipped file.
readZip(String) - Method in class jhplot.P2D
Read P1D from a Zipped file.
readZip(String) - Method in class jhplot.P3D
Read P3D from a Zipped file.
readZip(String) - Method in class jhplot.PND
Read the data from ZIPed external file.
readZip(String) - Method in class jhplot.PNI
Read the data from ZIPed external file.
real() - Method in class jhplot.math.Complex
Real part of this Complex number (the x-coordinate in rectangular coordinates).
Real - Class in org.nfunk.jep.function
 
Real() - Constructor for class org.nfunk.jep.function.Real
 
RealConstant() - Method in class org.nfunk.jep.Parser
 
RealDistribution - Interface in org.apache.commons.math3.distribution
Base interface for distributions on the reals.
RealFieldElement<T> - Interface in org.apache.commons.math3
Interface representing a real field.
RealFieldUnivariateFunction<T extends RealFieldElement<T>> - Interface in org.apache.commons.math3.analysis
An interface representing a univariate real function.
RealLinearOperator - Class in org.apache.commons.math3.linear
This class defines a linear operator operating on real (double) vector spaces.
RealLinearOperator() - Constructor for class org.apache.commons.math3.linear.RealLinearOperator
 
RealMatrix - Interface in org.apache.commons.math3.linear
Interface defining a real-valued matrix with basic algebraic operations.
RealMatrixChangingVisitor - Interface in org.apache.commons.math3.linear
Interface defining a visitor for matrix entries.
RealMatrixFormat - Class in org.apache.commons.math3.linear
Formats a nxm matrix in components list format "{{a00,a01, ..., a0m-1},{a10, a11, ..., a1m-1},{...},{ an-10, an-11, ..., an-1m-1}}".
RealMatrixFormat() - Constructor for class org.apache.commons.math3.linear.RealMatrixFormat
Create an instance with default settings.
RealMatrixFormat(NumberFormat) - Constructor for class org.apache.commons.math3.linear.RealMatrixFormat
Create an instance with a custom number format for components.
RealMatrixFormat(String, String, String, String, String, String) - Constructor for class org.apache.commons.math3.linear.RealMatrixFormat
Create an instance with custom prefix, suffix and separator.
RealMatrixFormat(String, String, String, String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.linear.RealMatrixFormat
Create an instance with custom prefix, suffix, separator and format for components.
RealMatrixPreservingVisitor - Interface in org.apache.commons.math3.linear
Interface defining a visitor for matrix entries.
Reals - Class in org.lsmp.djep.groupJep.groups
A representation of the Reals where elements are represented as Doubles.
Reals() - Constructor for class org.lsmp.djep.groupJep.groups.Reals
Operations on the reals (Implemented as Doubles).
RealTransformer - Interface in org.apache.commons.math3.transform
Interface for one-dimensional data sets transformations producing real results.
RealVector - Class in org.apache.commons.math3.linear
Class defining a real-valued vector with basic algebraic operations.
RealVector() - Constructor for class org.apache.commons.math3.linear.RealVector
 
RealVectorChangingVisitor - Interface in org.apache.commons.math3.linear
This interface defines a visitor for the entries of a vector.
RealVectorFormat - Class in org.apache.commons.math3.linear
Formats a vector in components list format "{v0; v1; ...; vk-1}".
RealVectorFormat() - Constructor for class org.apache.commons.math3.linear.RealVectorFormat
Create an instance with default settings.
RealVectorFormat(NumberFormat) - Constructor for class org.apache.commons.math3.linear.RealVectorFormat
Create an instance with a custom number format for components.
RealVectorFormat(String, String, String) - Constructor for class org.apache.commons.math3.linear.RealVectorFormat
Create an instance with custom prefix, suffix and separator.
RealVectorFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.linear.RealVectorFormat
Create an instance with custom prefix, suffix, separator and format for components.
RealVectorPreservingVisitor - Interface in org.apache.commons.math3.linear
This interface defines a visitor for the entries of a vector.
rebin(int) - Method in class jhplot.H1D
Rebin a histogram with constant bin width.
rebinX(int) - Method in class org.jlab.groot.data.H2F
 
rebinY(int) - Method in class org.jlab.groot.data.H2F
 
reciprocal() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Returns the multiplicative inverse of this element.
reciprocal() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Returns the multiplicative inverse of this element.
reciprocal() - Method in class org.apache.commons.math3.complex.Complex
Returns the multiplicative inverse of this element.
reciprocal() - Method in class org.apache.commons.math3.dfp.Dfp
Returns the multiplicative inverse of this element.
reciprocal() - Method in interface org.apache.commons.math3.FieldElement
Returns the multiplicative inverse of this element.
reciprocal() - Method in class org.apache.commons.math3.fraction.BigFraction
Return the multiplicative inverse of this fraction.
reciprocal() - Method in class org.apache.commons.math3.fraction.Fraction
Return the multiplicative inverse of this fraction.
reciprocal() - Method in interface org.apache.commons.math3.RealFieldElement
Returns the multiplicative inverse of this element.
reciprocal() - Method in class org.apache.commons.math3.util.BigReal
Returns the multiplicative inverse of this element.
reciprocal() - Method in class org.apache.commons.math3.util.Decimal64
Returns the multiplicative inverse of this element.
RecJob - Class in hep.lcio.example
 
RECONSTRUCTEDPARTICLE - Static variable in interface hep.lcio.event.LCIO
 
ReconstructedParticle - Interface in hep.lcio.event
The LCIO reconstructedParticle.
recordExists(String) - Method in class jhplot.io.db.BaseRecordsFile
Checks there is a record with the given key.
recordExists(String) - Method in class jhplot.io.db.RecordsFile
Checks if there is a record belonging to the given key.
RecordHeader - Class in jhplot.io.db
 
RecordReader - Class in jhplot.io.db
DB fir HDataBase
RecordsFile - Class in jhplot.io.db
 
RecordsFile(String, int) - Constructor for class jhplot.io.db.RecordsFile
Creates a new database file.
RecordsFile(String, String) - Constructor for class jhplot.io.db.RecordsFile
Opens an existing database and initializes the in-memory index.
recordsFile - Variable in class jhplot.io.HDataBase
 
recordsFile - Variable in class jhplot.io.HFileXML
 
RecordsFileException - Exception in jhplot.io.db
 
RecordWriter - Class in jhplot.io.db
 
RecordWriter(String) - Constructor for class jhplot.io.db.RecordWriter
 
RECTAN - Static variable in class jhplot.shapes.HShape
 
Rectan - Class in jhplot.shapes
Draw a rectangle using the user or NDC coordinate system
Rectan(double, double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.Rectan
Build a rectangle
Rectan(double, double, double, double) - Constructor for class jhplot.shapes.Rectan
Build a rectangle.
rectangleByRadius(Rectangle2D, double, double) - Static method in class org.jfree.chart.plot.dial.DialPlot
A utility method that computes a rectangle using relative radius values.
RectangleConstraint - Class in org.jfree.chart.block
A description of a constraint for resizing a rectangle.
RectangleConstraint(double, double) - Constructor for class org.jfree.chart.block.RectangleConstraint
Creates a new "fixed width and height" instance.
RectangleConstraint(Range, Range) - Constructor for class org.jfree.chart.block.RectangleConstraint
Creates a new "range width and height" instance.
RectangleConstraint(Range, double) - Constructor for class org.jfree.chart.block.RectangleConstraint
Creates a new constraint with a range for the width and a fixed height.
RectangleConstraint(double, Range) - Constructor for class org.jfree.chart.block.RectangleConstraint
Creates a new constraint with a fixed width and a range for the height.
RectangleConstraint(double, Range, LengthConstraintType, double, Range, LengthConstraintType) - Constructor for class org.jfree.chart.block.RectangleConstraint
Creates a new constraint.
RectangularCholeskyDecomposition - Class in org.apache.commons.math3.linear
Calculates the rectangular Cholesky decomposition of a matrix.
RectangularCholeskyDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.RectangularCholeskyDecomposition
Decompose a symmetric positive semidefinite matrix.
RectangularCholeskyDecomposition(RealMatrix, double) - Constructor for class org.apache.commons.math3.linear.RectangularCholeskyDecomposition
Decompose a symmetric positive semidefinite matrix.
recursiveGetVarsInEquation(Node, Vector) - Method in class org.lsmp.djep.xjep.XJep
Finds all the variables in an equation and if any of those variables are defined by equations find the variables in those equations as well.
red3D - Static variable in class org.jlab.groot.base.ColorPalette
 
RED_B - Static variable in class jplot3d.ColorModelSet
 
RED_H - Static variable in class jplot3d.ColorModelSet
 
RED_S - Static variable in class jplot3d.ColorModelSet
 
redraw - Variable in class graph.Axis
Default value true.
reduce() - Method in class org.apache.commons.math3.fraction.BigFraction
Reduce this BigFraction to its lowest terms.
reduce(double, double, double) - Static method in class org.apache.commons.math3.util.MathUtils
Reduce |a - offset| to the primary interval [0, |period|).
reducePoints(Collection<Vector2D>) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.hull.AklToussaintHeuristic
Returns a point set that is reduced by all points for which it is safe to assume that they are not part of the convex hull.
REFLEXIVE - Static variable in class org.lsmp.djep.xjep.XOperator
Reflecive relations x=x for all x.
refresh(GraphLabel) - Method in class jplot.LabelProperties
Updates the panel with a graph label object.
refresh() - Method in class jplot.panels.PanelAxes.AxesOptions
Updates the panel with the current graphical parameters.
refresh() - Method in class jplot.panels.PanelAxes.BoxOptions
Updates the panel with the current graphical parameters.
refresh() - Method in class jplot.panels.PanelAxes.GridOptions
Updates the panel with the current graphical parameters.
refresh() - Method in class jplot.panels.PanelAxes
 
refresh(Color) - Method in class jplot.panels.PanelColor
Refreshes the panel with a new color
refresh(LinePars) - Method in class jplot.panels.PanelDash
Refreshes the panel with the current data.
refresh(Font, Color) - Method in class jplot.panels.PanelFonts
updates the panel.
refresh(GraphSettings) - Method in class jplot.panels.PanelGrid
Updates the panel with graph parameters.
refresh() - Method in class jplot.panels.PanelLabel
Updates the panel with graph parameters.
refresh() - Method in class jplot.panels.PanelLegend
Updates the panel with the current graphical parameters.
refresh(LinePars) - Method in class jplot.panels.PanelPoint
Refreshes the panel with the current data.
refresh() - Method in class jplot.panels.PanelSave
Updates the panel with the current graphical parameters.
refresh() - Method in class jplot.panels.PanelScaling
Updates the panel with the current graphical parameters.
refresh() - Method in class jplot.PiperOptions
Updates the panel with the current graphical parameters.
refresh(File) - Method in class jplot.SimpleEditor
Refreshes the text, updates with the content of the current outputfile.
refresh(String) - Method in class jplot.SimpleEditor
Refreshes the text, updates with the content of the current viewer/editor.
refresh(File) - Method in class org.apache.commons.io.monitor.FileEntry
Refresh the attributes from the File, indicating whether the file has changed.
refreshFrame() - Method in class jhplot.HPlot
Refresh all the frames
refreshTicks(Graphics2D, AxisState, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.Axis
Calculates the positions of the ticks for the axis, storing the results in the tick list (ready for drawing).
refreshTicks(Graphics2D, AxisState, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.CategoryAxis
Creates a temporary list of ticks that can be used when drawing the axis.
refreshTicks(Graphics2D, AxisState, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.DateAxis
Calculates the positions of the tick labels for the axis, storing the results in the tick label list (ready for drawing).
refreshTicks(Graphics2D, AxisState, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.LogAxis
Calculates the positions of the tick labels for the axis, storing the results in the tick label list (ready for drawing).
refreshTicks(Graphics2D, AxisState, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.NumberAxis
Calculates the positions of the tick labels for the axis, storing the results in the tick label list (ready for drawing).
refreshTicks(Graphics2D, AxisState, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.PeriodAxis
Calculates the positions of the ticks for the axis, storing the results in the tick list (ready for drawing).
refreshTicks(Graphics2D, AxisState, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.SymbolAxis
Calculates the positions of the tick labels for the axis, storing the results in the tick label list (ready for drawing).
RegexFileFilter - Class in org.apache.commons.io.filefilter
Filters files using supplied regular expression(s).
RegexFileFilter(String) - Constructor for class org.apache.commons.io.filefilter.RegexFileFilter
Construct a new regular expression filter.
RegexFileFilter(String, IOCase) - Constructor for class org.apache.commons.io.filefilter.RegexFileFilter
Construct a new regular expression filter with the specified flags case sensitivity.
RegexFileFilter(String, int) - Constructor for class org.apache.commons.io.filefilter.RegexFileFilter
Construct a new regular expression filter with the specified flags.
RegexFileFilter(Pattern) - Constructor for class org.apache.commons.io.filefilter.RegexFileFilter
Construct a new regular expression filter for a compiled regular expression
Region<S extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface represents a region of a space as a partition.
Region.Location - Enum in org.apache.commons.math3.geometry.partitioning
Enumerate for the location of a point with respect to the region.
RegionFactory<S extends Space> - Class in org.apache.commons.math3.geometry.partitioning
This class is a factory for Region.
RegionFactory() - Constructor for class org.apache.commons.math3.geometry.partitioning.RegionFactory
Simple constructor.
registerAllExtensions(ExtensionRegistry) - Static method in class proeic.io.ProMC
 
registerAllExtensions(ExtensionRegistry) - Static method in class proeic.io.ProMCDescriptionFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class proeic.io.ProMCHeaderFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class proeic.io.ProMCStatFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class promc.io.PBufFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class promc.io.PEventFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class promc.io.ProMC
 
registerAllExtensions(ExtensionRegistry) - Static method in class promc.io.ProMCDescriptionFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class promc.io.ProMCHeaderFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class promc.io.ProMCStatFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class pronlo.io.ProMC
 
registerAllExtensions(ExtensionRegistry) - Static method in class pronlo.io.ProMCDescriptionFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class pronlo.io.ProMCHeaderFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class pronlo.io.ProMCStatFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class proreco.io.ProMC
 
registerAllExtensions(ExtensionRegistry) - Static method in class proreco.io.ProMCDescriptionFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class proreco.io.ProMCHeaderFile
 
registerAllExtensions(ExtensionRegistry) - Static method in class proreco.io.ProMCStatFile
 
registerFunction(Func1D) - Static method in class org.jlab.groot.math.FunctionFactory
 
registerLCEventListener(LCEventListener) - Method in interface hep.lcio.io.LCReader
Registers a listener for reading LCEvents from a stream.
registerLCRunListener(LCRunListener) - Method in interface hep.lcio.io.LCReader
Registers a listener for reading LCEventsLCRunHeaders from a stream.
registerVariationalEquations(ExpandableStatefulODE) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Register the variational equations for the Jacobians matrices to the expandable set.
regress() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Conducts a regression on the data in the model, using all regressors.
regress(int) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Conducts a regression on the data in the model, using a subset of regressors.
regress(int[]) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Conducts a regression on the data in the model, using regressors in array Calling this method will change the internal order of the regressors and care is required in interpreting the hatmatrix.
regress() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Performs a regression on data present in buffers and outputs a RegressionResults object.
regress(int[]) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Performs a regression on data present in buffers including only regressors indexed in variablesToInclude and outputs a RegressionResults object
regress() - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Performs a regression on data present in buffers and outputs a RegressionResults object
regress(int[]) - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Performs a regression on data present in buffers including only regressors indexed in variablesToInclude and outputs a RegressionResults object
Regression - Class in org.jfree.data.statistics
A utility class for fitting regression curves to data.
Regression() - Constructor for class org.jfree.data.statistics.Regression
 
RegressionResults - Class in org.apache.commons.math3.stat.regression
Results of a Multiple Linear Regression model fit.
RegressionResults(double[], double[][], boolean, long, int, double, double, double, boolean, boolean) - Constructor for class org.apache.commons.math3.stat.regression.RegressionResults
Constructor for Regression Results.
RegulaFalsiSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Regula Falsi or False position method for root-finding (approximating a zero of a univariate real function).
RegulaFalsiSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.RegulaFalsiSolver
Construct a solver with default accuracy (1e-6).
RegulaFalsiSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.RegulaFalsiSolver
Construct a solver.
RegulaFalsiSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.RegulaFalsiSolver
Construct a solver.
RegulaFalsiSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.RegulaFalsiSolver
Construct a solver.
REGULAR_QUARTERS - Static variable in class org.jfree.chart.axis.QuarterDateFormat
Symbols for regular quarters.
regularizedBeta(double, double, double) - Static method in class jhplot.math.num.special.Beta
Returns the regularized beta function Ix(a, b) (1).
regularizedBeta(double, double, double) - Static method in class org.apache.commons.math3.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, double) - Static method in class org.apache.commons.math3.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, int) - Static method in class org.apache.commons.math3.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, double, int) - Static method in class org.apache.commons.math3.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedGammaP(double, double) - Static method in class jhplot.math.num.special.Gamma
Returns the regularized gamma function P(a, x) (1).
regularizedGammaP(double, double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the regularized gamma function P(a, x).
regularizedGammaP(double, double, double, int) - Static method in class org.apache.commons.math3.special.Gamma
Returns the regularized gamma function P(a, x).
regularizedGammaQ(double, double) - Static method in class jhplot.math.num.special.Gamma
Returns the regularized gamma function Q(a, x) = 1 - P(a, x) (1).
regularizedGammaQ(double, double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
regularizedGammaQ(double, double, double, int) - Static method in class org.apache.commons.math3.special.Gamma
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
RegularTimePeriod - Class in org.jfree.data.time
An abstract class representing a unit of time.
RegularTimePeriod() - Constructor for class org.jfree.data.time.RegularTimePeriod
 
ReInit(InputStream) - Method in class jplot3dp.MathParser.MathParser
 
ReInit(Reader) - Method in class jplot3dp.MathParser.MathParser
 
ReInit(MathParserTokenManager) - Method in class jplot3dp.MathParser.MathParser
 
ReInit(SimpleCharStream) - Method in class jplot3dp.MathParser.MathParserTokenManager
 
ReInit(SimpleCharStream, int) - Method in class jplot3dp.MathParser.MathParserTokenManager
 
ReInit(Reader, int, int, int) - Method in class jplot3dp.MathParser.SimpleCharStream
 
ReInit(Reader, int, int) - Method in class jplot3dp.MathParser.SimpleCharStream
 
ReInit(Reader) - Method in class jplot3dp.MathParser.SimpleCharStream
 
ReInit(InputStream, int, int, int) - Method in class jplot3dp.MathParser.SimpleCharStream
 
ReInit(InputStream) - Method in class jplot3dp.MathParser.SimpleCharStream
 
ReInit(InputStream, int, int) - Method in class jplot3dp.MathParser.SimpleCharStream
 
ReInit(Reader, int, int, int) - Method in class org.nfunk.jep.JavaCharStream
 
ReInit(Reader, int, int) - Method in class org.nfunk.jep.JavaCharStream
 
ReInit(Reader) - Method in class org.nfunk.jep.JavaCharStream
 
ReInit(InputStream, int, int, int) - Method in class org.nfunk.jep.JavaCharStream
 
ReInit(InputStream, int, int) - Method in class org.nfunk.jep.JavaCharStream
 
ReInit(InputStream) - Method in class org.nfunk.jep.JavaCharStream
 
ReInit(InputStream) - Method in class org.nfunk.jep.Parser
 
ReInit(Reader) - Method in class org.nfunk.jep.Parser
 
ReInit(ParserTokenManager) - Method in class org.nfunk.jep.Parser
 
ReInit(JavaCharStream) - Method in class org.nfunk.jep.ParserTokenManager
 
ReInit(JavaCharStream, int) - Method in class org.nfunk.jep.ParserTokenManager
 
reinitialize(double[], boolean, EquationsMapper, EquationsMapper[]) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Reinitialize the instance.
reinitialize(double, double, double[], Array2DRowRealMatrix) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Reinitialize the instance.
reinitializeBegin(StepInterpolator) - Method in class org.apache.commons.math3.ode.events.EventState
Reinitialize the beginning of the step.
reinitializeBegin(FieldStepInterpolator<T>) - Method in class org.apache.commons.math3.ode.events.FieldEventState
Reinitialize the beginning of the step.
reInitializeVars() - Method in class jplot3dp.ModelView
 
reject(Class<?>...) - Method in class org.apache.commons.io.serialization.ValidatingObjectInputStream
Reject the specified classes for deserialization, even if they are otherwise accepted.
reject(String...) - Method in class org.apache.commons.io.serialization.ValidatingObjectInputStream
Reject the wildcard specified classes for deserialization, even if they are otherwise accepted.
reject(Pattern) - Method in class org.apache.commons.io.serialization.ValidatingObjectInputStream
Reject class names that match the supplied pattern for deserialization, even if they are otherwise accepted.
reject(ClassNameMatcher) - Method in class org.apache.commons.io.serialization.ValidatingObjectInputStream
Reject class names where the supplied ClassNameMatcher matches for deserialization, even if they are otherwise accepted.
rejection(Function, double, double, double) - Static method in class jhplot.math.Random
Generate a random number from a random variable definied by its density function, using the rejection technic.
rejection(Expression, double, double, double) - Static method in class jhplot.math.Random
Generate a random number from a random variable definied by its density function, using the rejection technic.
RelationalExpression() - Method in class org.nfunk.jep.Parser
 
Relationship - Enum in org.apache.commons.math3.optim.linear
Types of relationships between two cells in a Solver LinearConstraint.
Relationship - Enum in org.apache.commons.math3.optimization.linear
Deprecated.
As of 3.1 (to be removed in 4.0).
RELATIVE - Static variable in class org.jfree.chart.util.XYCoordinateType
The (x, y) coordinates represent a relative position in the data space.
RELATIVE_FREQUENCY - Static variable in class org.jfree.data.statistics.HistogramType
Relative frequency.
RelativeDateFormat - Class in org.jfree.chart.util
A formatter that formats dates to show the elapsed time relative to some base date.
RelativeDateFormat() - Constructor for class org.jfree.chart.util.RelativeDateFormat
Creates a new instance with base milliseconds set to zero.
RelativeDateFormat(Date) - Constructor for class org.jfree.chart.util.RelativeDateFormat
Creates a new instance.
RelativeDateFormat(long) - Constructor for class org.jfree.chart.util.RelativeDateFormat
Creates a new instance.
relativizeDirectories(Path, boolean, Comparator<? super Path>) - Method in class org.apache.commons.io.file.AccumulatorPathVisitor
Relativizes each directory path with Path.relativize(Path) against the given parent, optionally sorting the result.
relativizeFiles(Path, boolean, Comparator<? super Path>) - Method in class org.apache.commons.io.file.AccumulatorPathVisitor
Relativizes each file path with Path.relativize(Path) against the given parent, optionally sorting the result.
release(int) - Method in class org.freehep.math.minuit.MnApplication
 
release(String) - Method in class org.freehep.math.minuit.MnApplication
 
release(int) - Method in class org.freehep.math.minuit.MnUserParameters
Releases the specified parameter (so that the minimizer can vary it)
release(String) - Method in class org.freehep.math.minuit.MnUserParameters
Releases the specified parameter (so that the minimizer can vary it)
release(int) - Method in class org.freehep.math.minuit.MnUserParameterState
 
release(String) - Method in class org.freehep.math.minuit.MnUserParameterState
 
reload() - Method in class jplot.panels.PanelPlot
Reloads the datafile and resets the selection to default.
reloadCanvas() - Static method in class jhplot.SHPlot
Reload the canvas by removing components
reloadCanvas() - Static method in class jhplot.SHPlot3D
Reload the canvas by removing components
remainder(double, double) - Static method in class net.jafama.FastMath
Returns dividend - divisor * n, where n is the mathematical integer closest to dividend/divisor.
remainder(double, double) - Static method in class net.jafama.StrictFastMath
Returns dividend - divisor * n, where n is the mathematical integer closest to dividend/divisor.
remainder(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
IEEE remainder operator.
remainder(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
IEEE remainder operator.
remainder(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Perform remainder of two derivative structures.
remainder(double) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
IEEE remainder operator.
remainder(SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
IEEE remainder operator.
remainder(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Returns the IEEE remainder.
remainder(double) - Method in class org.apache.commons.math3.dfp.Dfp
IEEE remainder operator.
remainder(double) - Method in interface org.apache.commons.math3.RealFieldElement
IEEE remainder operator.
remainder(T) - Method in interface org.apache.commons.math3.RealFieldElement
IEEE remainder operator.
remainder(double) - Method in class org.apache.commons.math3.util.Decimal64
IEEE remainder operator.
remainder(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
IEEE remainder operator.
remove(int) - Method in class cern.colt.list.AbstractList
Removes the element at the specified position from the receiver.
remove(int) - Method in class cern.colt.list.adapter.DoubleListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.adapter.FloatListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.adapter.IntListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.adapter.LongListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.adapter.ObjectListAdapter
Removes the element at the specified position in this list (optional operation).
remove() - Method in class hep.physics.filter.Filter
 
remove(String) - Method in class jhplot.io.HDataBase
Remove object from the database using the key
remove(int) - Method in class jhplot.P1D
Removes at the position
remove(int) - Method in class jhplot.PND
Remove a row
remove(int) - Method in class jhplot.PNI
Remove a row
remove(int[], int) - Static method in class jminhep.utils.ArrayOps
#9 Remove from nums the value at the specified index.
remove(String, String) - Static method in class jminhep.utils.StringUtil
Return a String with all occurrences of the "search" String within "original" removed.
remove(ObservableInputStream.Observer) - Method in class org.apache.commons.io.input.ObservableInputStream
Removes an Observer.
remove() - Method in class org.apache.commons.io.LineIterator
Unsupported.
remove() - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Not applicable.
remove() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
 
remove(int) - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Remove the value associated with a key.
remove(int) - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Remove the value associated with a key.
remove(CategoryPlot) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Removes a subplot from the combined chart.
remove(XYPlot) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Removes a subplot from the combined chart and sends a PlotChangeEvent to all registered listeners.
remove(CategoryPlot) - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Removes a subplot from the combined chart.
remove(XYPlot) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Removes a subplot from the combined chart.
remove(Comparable) - Method in class org.jfree.data.ComparableObjectSeries
Removes the item with the specified x-value and sends a SeriesChangeEvent to all registered listeners.
remove(Task) - Method in class org.jfree.data.gantt.TaskSeries
Removes a task from the series and sends a SeriesChangeEvent to all registered listeners.
remove(TaskSeries) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
remove(int) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
remove(Comparable) - Method in class org.jfree.data.general.DefaultPieDataset
Removes an item from the dataset and sends a DatasetChangeEvent to all registered listeners.
remove(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Removes an item from the dataset and sends a DatasetChangeEvent to all registered listeners.
remove(Comparable, Comparable) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Removes an item from the dataset and sends a DatasetChangeEvent to all registered listeners.
remove(int) - Method in class org.jfree.data.time.ohlc.OHLCSeries
Removes the item with the specified index.
remove(TimePeriod, Comparable) - Method in class org.jfree.data.time.TimeTableXYDataset
Removes an existing data item from the dataset.
remove(TimePeriod, Comparable, boolean) - Method in class org.jfree.data.time.TimeTableXYDataset
Removes an existing data item from the dataset and, if requested, sends a DatasetChangeEvent to all registered listeners.
remove(double, String) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Removes a value from the dataset.
remove(Number, String, boolean) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Removes an item from the dataset.
remove(int) - Method in class org.jfree.data.xy.VectorSeries
Removes the item at the specified index and sends a SeriesChangeEvent to all registered listeners.
remove(int) - Method in class org.jfree.data.xy.XYSeries
Removes the item at the specified index and sends a SeriesChangeEvent to all registered listeners.
remove(Number) - Method in class org.jfree.data.xy.XYSeries
Removes an item with the specified x-value and sends a SeriesChangeEvent to all registered listeners.
remove(IDataSet) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
removeActionListener(ActionListener) - Method in class net.java.dev.colorchooser.ColorChooser
Removes ActionListener from the list of listeners.
removeAgedItems(boolean) - Method in class org.jfree.data.time.TimeSeries
Age items in the series.
removeAgedItems(long, boolean) - Method in class org.jfree.data.time.TimeSeries
Age items in the series.
removeAll(AbstractBooleanList) - Method in class cern.colt.list.AbstractBooleanList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractByteList) - Method in class cern.colt.list.AbstractByteList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractCharList) - Method in class cern.colt.list.AbstractCharList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractDoubleList) - Method in class cern.colt.list.AbstractDoubleList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractFloatList) - Method in class cern.colt.list.AbstractFloatList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractIntList) - Method in class cern.colt.list.AbstractIntList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractLongList) - Method in class cern.colt.list.AbstractLongList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractShortList) - Method in class cern.colt.list.AbstractShortList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractBooleanList) - Method in class cern.colt.list.BooleanArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractByteList) - Method in class cern.colt.list.ByteArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractCharList) - Method in class cern.colt.list.CharArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractDoubleList) - Method in class cern.colt.list.DoubleArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractFloatList) - Method in class cern.colt.list.FloatArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractIntList) - Method in class cern.colt.list.IntArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractLongList) - Method in class cern.colt.list.LongArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(ObjectArrayList, boolean) - Method in class cern.colt.list.ObjectArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractShortList) - Method in class cern.colt.list.ShortArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll() - Method in class fitter.SEditor
Removes all items from the table.
removeAll(int, int) - Method in class jhplot.P0D
Remove elements
removeAll(int, int) - Method in class jhplot.P0I
Remove elements
removeAll() - Method in class org.jfree.data.gantt.TaskSeries
Removes all tasks from the series and sends a SeriesChangeEvent to all registered listeners.
removeAll() - Method in class org.jfree.data.gantt.TaskSeriesCollection
Removes all the series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeAllBins() - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Removes all bins and sends a DatasetChangeEvent to all registered listeners.
removeAllDaughters() - Method in class hep.lcio.implementation.event.IMCParticle
 
removeAllObservers() - Method in class org.apache.commons.io.input.ObservableInputStream
Removes all Observers.
removeAllOf(DoubleArrayList) - Method in class cern.hep.aida.bin.DynamicBin1D
Removes from the receiver all elements that are contained in the specified list.
removeAllSeries() - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Removes all the series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeAllSeries() - Method in class org.jfree.data.time.TimeSeriesCollection
Removes all the series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeAllSeries() - Method in class org.jfree.data.xy.DefaultTableXYDataset
Removes all the series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeAllSeries() - Method in class org.jfree.data.xy.MatrixSeriesCollection
Removes all the series from the collection.
removeAllSeries() - Method in class org.jfree.data.xy.VectorSeriesCollection
Removes all the series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeAllSeries() - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Removes all the series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeAllSeries() - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Removes all the series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeAllSeries() - Method in class org.jfree.data.xy.XYSeriesCollection
Removes all the series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeAllSeries() - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Removes all the series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeAllValuesForX(Number) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Removes the items from all series for a given x value.
removeAnnotation(CategoryAnnotation) - Method in class org.jfree.chart.plot.CategoryPlot
Removes an annotation from the plot and sends a PlotChangeEvent to all registered listeners.
removeAnnotation(CategoryAnnotation, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Removes an annotation from the plot and, if requested, sends a PlotChangeEvent to all registered listeners.
removeAnnotation(XYAnnotation) - Method in class org.jfree.chart.plot.XYPlot
Removes an annotation from the plot and sends a PlotChangeEvent to all registered listeners.
removeAnnotation(XYAnnotation, boolean) - Method in class org.jfree.chart.plot.XYPlot
Removes an annotation from the plot and sends a PlotChangeEvent to all registered listeners.
removeAnnotation(XYAnnotation) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Removes the specified annotation and sends a RendererChangeEvent to all registered listeners.
removeAnnotation(XYAnnotation) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Removes the specified annotation and sends a RendererChangeEvent to all registered listeners.
removeAnnotations() - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Removes all annotations and sends a RendererChangeEvent to all registered listeners.
removeAnnotations() - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Removes all annotations and sends a RendererChangeEvent to all registered listeners.
removeAt(int) - Method in class jhplot.P1D
Remove a (X,Y) value at a given index
removeAxes() - Method in class jhplot.HPlot
Remove X and Y axes, ticks, axis labels on the current plot.
removeCategoryLabelToolTip(Comparable) - Method in class org.jfree.chart.axis.CategoryAxis
Removes the tooltip for the specified category and, if there was a value associated with that category, sends an AxisChangeEvent to all registered listeners.
removeCategoryLabelURL(Comparable) - Method in class org.jfree.chart.axis.CategoryAxis
Removes the URL for the specified category and, if there was a URL associated with that category, sends an AxisChangeEvent to all registered listeners.
RemoveCenters() - Static method in class jminhep.clcontrol.Display
Remove cluster centers
removeCenters() - Method in class jminhep.gui.Plotter
Remove centers
removeChangeListener(ChangeListener) - Method in interface jplot3d.SurfaceModel
 
removeChangeListener(ChangeListener) - Method in class jplot3d.SurfaceModelCanvas
 
removeChangeListener(AnnotationChangeListener) - Method in class org.jfree.chart.annotations.AbstractAnnotation
Deregisters an object so that it no longer receives notification of changes to the annotation.
removeChangeListener(AnnotationChangeListener) - Method in interface org.jfree.chart.annotations.Annotation
Deregisters an object for notification of changes to the annotation.
removeChangeListener(AxisChangeListener) - Method in class org.jfree.chart.axis.Axis
Deregisters an object for notification of changes to the axis.
removeChangeListener(ChartChangeListener) - Method in class org.jfree.chart.JFreeChart
Deregisters an object for notification of changes to the chart.
removeChangeListener(OverlayChangeListener) - Method in class org.jfree.chart.panel.AbstractOverlay
Deregisters an object for notification of changes to the overlay.
removeChangeListener(OverlayChangeListener) - Method in interface org.jfree.chart.panel.Overlay
Deregisters a listener from the overlay.
removeChangeListener(DialLayerChangeListener) - Method in class org.jfree.chart.plot.dial.AbstractDialLayer
Deregisters an object for notification of changes to the dial layer.
removeChangeListener(DialLayerChangeListener) - Method in interface org.jfree.chart.plot.dial.DialLayer
Deregisters a listener, so that it no longer receives notification of changes to this layer.
removeChangeListener(MarkerChangeListener) - Method in class org.jfree.chart.plot.Marker
Unregisters an object for notification of changes to the marker.
removeChangeListener(PlotChangeListener) - Method in class org.jfree.chart.plot.Plot
Unregisters an object for notification of changes to the plot.
removeChangeListener(RendererChangeListener) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deregisters an object so that it no longer receives notification of changes to the renderer.
removeChangeListener(RendererChangeListener) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Removes a change listener.
removeChangeListener(RendererChangeListener) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Removes a change listener.
removeChangeListener(RendererChangeListener) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Removes a change listener.
removeChangeListener(TitleChangeListener) - Method in class org.jfree.chart.title.Title
Unregisters an object for notification of changes to the chart title.
removeChangeListener(DatasetChangeListener) - Method in class org.jfree.data.general.AbstractDataset
Deregisters an object so that it no longer receives notification of changes to the dataset.
removeChangeListener(DatasetChangeListener) - Method in interface org.jfree.data.general.Dataset
Deregisters an object for notification of changes to the dataset.
removeChangeListener(SeriesChangeListener) - Method in class org.jfree.data.general.Series
Deregisters an object, so that it not longer receives notification whenever the series changes.
removeChartMouseListener(ChartMouseListener) - Method in class org.jfree.chart.ChartPanel
Removes a listener from the list of objects listening for chart mouse events.
removeChartMouseListener(ChartMouseListenerFX) - Method in class org.jfree.chart.fx.ChartCanvas
Removes a listener from the list of objects listening for chart mouse events.
removeChartMouseListener(ChartMouseListenerFX) - Method in class org.jfree.chart.fx.ChartViewer
Removes a listener from the list of objects listening for chart mouse events.
removeChartMouseListener(ChartMouseListenerFX) - Method in class org.jfree.chart.fx.ChartViewerSkin
Removes a listener from the list of objects listening for chart mouse events.
removeCodeBase(URL, URLClassLoader) - Static method in class org.jfree.chart.util.ResourceBundleWrapper
Instantiate a URLClassLoader for resource lookups where the codeBase URL is removed.
removeCollection(String) - Method in interface hep.lcio.event.LCEvent
Removes (and deletes) the collection with name (if it exists in the event).
removeCollection(String) - Method in class hep.lcio.implementation.event.ILCEvent
 
removeColumn(int) - Method in class jplot.DataFile
remove a column from the vector of columns.
removeColumn(int) - Method in class org.jfree.data.category.DefaultCategoryDataset
Removes a column from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeColumn(Comparable) - Method in class org.jfree.data.category.DefaultCategoryDataset
Removes a column from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeColumn(int) - Method in class org.jfree.data.DefaultKeyedValues2D
Removes a column.
removeColumn(Comparable) - Method in class org.jfree.data.DefaultKeyedValues2D
Removes a column from the table.
removeColumn(int) - Method in class org.jfree.data.KeyedObjects2D
Removes an entire column from the table.
removeColumn(Comparable) - Method in class org.jfree.data.KeyedObjects2D
Removes an entire column from the table.
removeColumn(int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Removes a column from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeColumn(Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Removes a column from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeColumn(int) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Removes a column from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeColumn(Comparable) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Removes a column from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeCornerTextItem(String) - Method in class org.jfree.chart.plot.PolarPlot
Remove the given text from the list of corner text items and sends a PlotChangeEvent to all registered listeners.
removeCurrentNode() - Method in class org.jlab.groot.tree.DynamicTree
Remove the currently selected node.
removeData(double, double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Removes the observation (x,y) from the regression data set.
removeData(double[][]) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Removes observations represented by the elements in data.
removeDaughter(MCParticle) - Method in class hep.lcio.implementation.event.IMCParticle
 
removeDomainCrosshair(Crosshair) - Method in class org.jfree.chart.panel.CrosshairOverlay
Removes a domain axis crosshair and sends an OverlayChangeEvent to all registered listeners.
removeDomainMarker(Marker) - Method in class org.jfree.chart.plot.CategoryPlot
Removes a marker for the domain axis and sends a PlotChangeEvent to all registered listeners.
removeDomainMarker(Marker, Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Removes a marker for the domain axis in the specified layer and sends a PlotChangeEvent to all registered listeners.
removeDomainMarker(int, Marker, Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Removes a marker for a specific dataset/renderer and sends a PlotChangeEvent to all registered listeners.
removeDomainMarker(int, Marker, Layer, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Removes a marker for a specific dataset/renderer and, if requested, sends a PlotChangeEvent to all registered listeners.
removeDomainMarker(Marker) - Method in class org.jfree.chart.plot.XYPlot
Removes a marker for the domain axis and sends a PlotChangeEvent to all registered listeners.
removeDomainMarker(Marker, Layer) - Method in class org.jfree.chart.plot.XYPlot
Removes a marker for the domain axis in the specified layer and sends a PlotChangeEvent to all registered listeners.
removeDomainMarker(int, Marker, Layer) - Method in class org.jfree.chart.plot.XYPlot
Removes a marker for a specific dataset/renderer and sends a PlotChangeEvent to all registered listeners.
removeDomainMarker(int, Marker, Layer, boolean) - Method in class org.jfree.chart.plot.XYPlot
Removes a marker for a specific dataset/renderer and, if requested, sends a PlotChangeEvent to all registered listeners.
removeElementAt(int) - Method in interface hep.lcio.event.LCCollection
Removes the i-th element from the collection.
removeElementAt(int) - Method in class hep.lcio.implementation.event.ILCCollection
 
removeEntry(int) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
removeExtension(String) - Static method in class org.apache.commons.io.FilenameUtils
Removes the extension from a fileName.
removeFileFilter(IOFileFilter) - Method in class org.apache.commons.io.filefilter.AndFileFilter
Removes the specified file filter.
removeFileFilter(IOFileFilter) - Method in interface org.apache.commons.io.filefilter.ConditionalFileFilter
Removes the specified file filter.
removeFileFilter(IOFileFilter) - Method in class org.apache.commons.io.filefilter.OrFileFilter
Removes the specified file filter.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractBooleanList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractByteList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractCharList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractDoubleList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractFloatList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractIntList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractLongList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractShortList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.DistinctNumberList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFunction(int) - Method in class jplot3dp.ModelView.FunctionsList
 
removeFunction(String) - Method in class org.nfunk.jep.JEP
Removes a function from the parser.
removeGraph() - Method in class jhplot.HPlot
Remove all components from the JHPlot frame.
removeGroup(int) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
removeIterationListener(IterationListener) - Method in class org.apache.commons.math3.util.IterationManager
Removes the specified iteration listener from the list of listeners currently attached to this object.
removeKey(double) - Method in class cern.colt.map.AbstractDoubleIntMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.AbstractIntDoubleMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.AbstractIntIntMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.AbstractIntObjectMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.AbstractLongObjectMap
Removes the given key with its associated element from the receiver, if present.
removeKey(double) - Method in class cern.colt.map.OpenDoubleIntHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.OpenIntDoubleHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.OpenIntIntHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.OpenIntObjectHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.OpenLongObjectHashMap
Removes the given key with its associated element from the receiver, if present.
removeLabel(int) - Method in class jhplot.HPlot
remove i-th HLabel or HMLabel on the current plot
removeLabel(int) - Method in class jplot.GraphSettings
Remove i-th label
removeLabels() - Method in class jhplot.HPlot
remove HLabels and HMLabels on the current plot
removeLabels() - Method in class jplot.GraphSettings
Clear all labels
removeLabelsAll() - Method in class jhplot.HPlot
remove all Labels on all plots.
removeLayer(int) - Method in class org.jfree.chart.plot.dial.DialPlot
Removes the layer at the specified index and sends a PlotChangeEvent to all registered listeners.
removeLayer(DialLayer) - Method in class org.jfree.chart.plot.dial.DialPlot
Removes the specified layer and sends a PlotChangeEvent to all registered listeners.
removeLCEventListener(LCEventListener) - Method in interface hep.lcio.io.LCReader
Remove a listener for reading LCEvents from a stream.
removeLCRunListener(LCRunListener) - Method in interface hep.lcio.io.LCReader
Remove a listener for reading LCRunHeaders from a stream.
removeLegend() - Method in class org.jfree.chart.JFreeChart
Removes the first legend in the chart and sends a ChartChangeEvent to all registered listeners.
removeLimits(int) - Method in class org.freehep.math.minuit.MnApplication
 
removeLimits(String) - Method in class org.freehep.math.minuit.MnApplication
 
removeLimits(int) - Method in class org.freehep.math.minuit.MnUserParameters
 
removeLimits(String) - Method in class org.freehep.math.minuit.MnUserParameters
 
removeLimits(int) - Method in class org.freehep.math.minuit.MnUserParameterState
 
removeLimits(String) - Method in class org.freehep.math.minuit.MnUserParameterState
 
removeListener(FileAlterationListener) - Method in class org.apache.commons.io.monitor.FileAlterationObserver
Removes a file system listener.
removeMetaFloat(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
removeMetaFloat(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
removeMetaFloat(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
removeMetaFloat(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
removeMetaFloat(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
removeMetaInt(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
removeMetaInt(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
removeMetaInt(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
removeMetaInt(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
removeMetaInt(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
removeMostRecentValue() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Removes the most recent value from the dataset.
removeMouseHandler(MouseHandlerFX) - Method in class org.jfree.chart.fx.ChartCanvas
Removes a handler from the list of available handlers.
removeObject(Comparable, Comparable) - Method in class org.jfree.data.KeyedObjects2D
Removes an object from the table by setting it to null.
removeObserver(FileAlterationObserver) - Method in class org.apache.commons.io.monitor.FileAlterationMonitor
Removes a file system observer from this monitor.
removeOverlay(Overlay) - Method in class org.jfree.chart.ChartPanel
Removes an overlay from the panel.
removeParticleData(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
removeParticleData(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
removeParticleData(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
removeParticleData(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
removePointer(int) - Method in class org.jfree.chart.plot.dial.DialPlot
Removes the pointer at the specified index and sends a PlotChangeEvent to all registered listeners.
removePointer(DialPointer) - Method in class org.jfree.chart.plot.dial.DialPlot
Removes the specified pointer and sends a PlotChangeEvent to all registered listeners.
removePrimitive(int) - Method in class jplot.GraphSettings
Remove i-th label
removePrimitives() - Method in class jhplot.HPlot
remove 2D java primitives on the current plot
removePrimitives(int) - Method in class jhplot.HPlot
remove i-th 2D java primitives on the current plot
removePrimitives() - Method in class jplot.GraphSettings
Clear all primitives
removePrimitivesAll() - Method in class jhplot.HPlot
remove all 2D java primitives
removeProcessData(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
removeProcessData(int) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
removeProcessData(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
removeProcessData(int) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
removeProgressListener(ChartProgressListener) - Method in class org.jfree.chart.JFreeChart
Deregisters an object for notification of changes to the chart.
removePropertyChangeListener(PropertyChangeListener) - Method in interface jplot3d.SurfaceModel
 
removePropertyChangeListener(String, PropertyChangeListener) - Method in interface jplot3d.SurfaceModel
 
removePropertyChangeListener(PropertyChangeListener) - Method in class jplot3d.SurfaceModelCanvas
 
removePropertyChangeListener(String, PropertyChangeListener) - Method in class jplot3d.SurfaceModelCanvas
 
removePropertyChangeListener(PropertyChangeListener) - Method in class org.jfree.chart.plot.Crosshair
Removes a property change listener.
removePropertyChangeListener(PropertyChangeListener) - Method in class org.jfree.data.general.Series
Removes a property change listener from the series.
removeRangeCrosshair(Crosshair) - Method in class org.jfree.chart.panel.CrosshairOverlay
Removes a range axis crosshair and sends an OverlayChangeEvent to all registered listeners.
removeRangeMarker(Marker) - Method in class org.jfree.chart.plot.CategoryPlot
Removes a marker for the range axis and sends a PlotChangeEvent to all registered listeners.
removeRangeMarker(Marker, Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Removes a marker for the range axis in the specified layer and sends a PlotChangeEvent to all registered listeners.
removeRangeMarker(int, Marker, Layer) - Method in class org.jfree.chart.plot.CategoryPlot
Removes a marker for a specific dataset/renderer and sends a PlotChangeEvent to all registered listeners.
removeRangeMarker(int, Marker, Layer, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Removes a marker for a specific dataset/renderer and sends a PlotChangeEvent to all registered listeners.
removeRangeMarker(Marker) - Method in class org.jfree.chart.plot.XYPlot
Removes a marker for the range axis and sends a PlotChangeEvent to all registered listeners.
removeRangeMarker(Marker, Layer) - Method in class org.jfree.chart.plot.XYPlot
Removes a marker for the range axis in the specified layer and sends a PlotChangeEvent to all registered listeners.
removeRangeMarker(int, Marker, Layer) - Method in class org.jfree.chart.plot.XYPlot
Removes a marker for a specific dataset/renderer and sends a PlotChangeEvent to all registered listeners.
removeRangeMarker(int, Marker, Layer, boolean) - Method in class org.jfree.chart.plot.XYPlot
Removes a marker for a specific dataset/renderer and sends a PlotChangeEvent to all registered listeners.
removeRow(int) - Method in class org.jfree.data.category.DefaultCategoryDataset
Removes a row from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeRow(Comparable) - Method in class org.jfree.data.category.DefaultCategoryDataset
Removes a row from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeRow(int) - Method in class org.jfree.data.DefaultKeyedValues2D
Removes a row.
removeRow(Comparable) - Method in class org.jfree.data.DefaultKeyedValues2D
Removes a row from the table.
removeRow(int) - Method in class org.jfree.data.KeyedObjects2D
Removes an entire row from the table.
removeRow(Comparable) - Method in class org.jfree.data.KeyedObjects2D
Removes an entire row from the table.
removeRow(int) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Removes a row from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeRow(Comparable) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerCategoryDataset
Removes a row from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeRow(int) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Removes a row from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeRow(Comparable) - Method in class org.jfree.data.statistics.DefaultStatisticalCategoryDataset
Removes a row from the dataset and sends a DatasetChangeEvent to all registered listeners.
RemoveSeeds() - Static method in class jminhep.clcontrol.Display
Remove seeds
removeSeeds() - Method in class jminhep.gui.Plotter
Remove seeds
removeSeries(int) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Removes the series with the specified index and sends a DatasetChangeEvent to all registered listeners.
removeSeries(OHLCSeries) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Removes the specified series from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeSeries(TimePeriodValues) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Removes the specified series from the collection.
removeSeries(int) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Removes a series from the collection.
removeSeries(TimeSeries) - Method in class org.jfree.data.time.TimeSeriesCollection
Removes the specified series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSeries(int) - Method in class org.jfree.data.time.TimeSeriesCollection
Removes a series from the collection.
removeSeries(XYSeries) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSeries(int) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSeries(Comparable) - Method in class org.jfree.data.xy.DefaultXYDataset
Removes a series from the dataset, then sends a DatasetChangeEvent to all registered listeners.
removeSeries(Comparable) - Method in class org.jfree.data.xy.DefaultXYZDataset
Removes a series from the dataset, then sends a DatasetChangeEvent to all registered listeners.
removeSeries(MatrixSeries) - Method in class org.jfree.data.xy.MatrixSeriesCollection
Removes a series from the collection.
removeSeries(int) - Method in class org.jfree.data.xy.MatrixSeriesCollection
Removes a series from the collection.
removeSeries(VectorSeries) - Method in class org.jfree.data.xy.VectorSeriesCollection
Removes the specified series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSeries(int) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSeries(XIntervalSeries) - Method in class org.jfree.data.xy.XIntervalSeriesCollection
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSeries(int) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSeries(XYIntervalSeries) - Method in class org.jfree.data.xy.XYIntervalSeriesCollection
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSeries(int) - Method in class org.jfree.data.xy.XYSeriesCollection
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSeries(XYSeries) - Method in class org.jfree.data.xy.XYSeriesCollection
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSeries(int) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSeries(YIntervalSeries) - Method in class org.jfree.data.xy.YIntervalSeriesCollection
Removes a series from the collection and sends a DatasetChangeEvent to all registered listeners.
removeSubtask(Task) - Method in class org.jfree.data.gantt.Task
Removes a sub-task from the task.
removeSubtitle(Title) - Method in class org.jfree.chart.JFreeChart
Removes the specified subtitle and sends a ChartChangeEvent to all registered listeners.
removeTransformer(Class<?>) - Method in class org.apache.commons.math3.util.TransformerMap
Removes a Class to Transformer Mapping in the Map.
removeTreeModelListener(TreeModelListener) - Method in class root.RootHistogramTreeModel
 
removeValue(Comparable, Comparable) - Method in class org.jfree.data.category.DefaultCategoryDataset
Removes a value from the dataset and sends a DatasetChangeEvent to all registered listeners.
removeValue(int) - Method in class org.jfree.data.DefaultKeyedValues
Removes a value from the collection.
removeValue(Comparable) - Method in class org.jfree.data.DefaultKeyedValues
Removes a value from the collection.
removeValue(Comparable, Comparable) - Method in class org.jfree.data.DefaultKeyedValues2D
Removes a value from the table by setting it to null.
removeValue(int) - Method in class org.jfree.data.KeyedObjects
Removes a value from the collection.
removeValue(Comparable) - Method in class org.jfree.data.KeyedObjects
Removes a value from the collection.
removeVariable(String) - Method in class org.nfunk.jep.JEP
Removes a variable from the parser.
removeVetoableChangeListener(VetoableChangeListener) - Method in class org.jfree.data.general.Series
Removes a vetoable property change listener from the series.
RemoveZero(String) - Static method in class jplot.Utils
Format string by removin ".0"
RemoveZero(String) - Static method in class jplot3d.NumUtil
Format string by removin ".0"
render(Graphics2D, Rectangle2D, int, PlotRenderingInfo, CategoryCrosshairState) - Method in class org.jfree.chart.plot.CategoryPlot
Draws a representation of a dataset within the dataArea region using the appropriate renderer.
render(Graphics2D, Rectangle2D, PlotRenderingInfo, CrosshairState) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Draws a representation of the data within the dataArea region, using the current renderer.
render(Graphics2D, Rectangle2D, PlotRenderingInfo, CrosshairState) - Method in class org.jfree.chart.plot.FastScatterPlot
Draws a representation of the data within the dataArea region.
render(Graphics2D, Rectangle2D, int, PlotRenderingInfo, CrosshairState) - Method in class org.jfree.chart.plot.XYPlot
Draws a representation of the data within the dataArea region, using the current renderer.
rendererChanged(RendererChangeEvent) - Method in interface org.jfree.chart.event.RendererChangeListener
Receives notification of a renderer change event.
rendererChanged(RendererChangeEvent) - Method in class org.jfree.chart.plot.CategoryPlot
Receives notification of a renderer change event.
rendererChanged(RendererChangeEvent) - Method in class org.jfree.chart.plot.PolarPlot
Notifies all registered listeners of a property change.
rendererChanged(RendererChangeEvent) - Method in class org.jfree.chart.plot.WaferMapPlot
Notifies all registered listeners of a renderer change.
rendererChanged(RendererChangeEvent) - Method in class org.jfree.chart.plot.XYPlot
Receives notification of a renderer change event.
RendererChangeEvent - Class in org.jfree.chart.event
An event that can be forwarded to any RendererChangeListener to signal a change to a renderer.
RendererChangeEvent(Object) - Constructor for class org.jfree.chart.event.RendererChangeEvent
Creates a new event.
RendererChangeEvent(Object, boolean) - Constructor for class org.jfree.chart.event.RendererChangeEvent
Creates a new event.
RendererChangeListener - Interface in org.jfree.chart.event
The interface that must be supported by classes that wish to receive notification of changes to a renderer.
RendererState - Class in org.jfree.chart.renderer
Represents the current state of a renderer.
RendererState(PlotRenderingInfo) - Constructor for class org.jfree.chart.renderer.RendererState
Creates a new state object.
RendererUtilities - Class in org.jfree.chart.renderer
Utility methods related to the rendering process.
RendererUtilities() - Constructor for class org.jfree.chart.renderer.RendererUtilities
 
repeat(DoubleMatrix1D, int) - Method in class cern.colt.matrix.DoubleFactory1D
C = A||A||..||A; Constructs a new matrix which is concatenated repeat times.
repeat(DoubleMatrix2D, int, int) - Method in class cern.colt.matrix.DoubleFactory2D
C = A||A||..||A; Constructs a new matrix which is duplicated both along the row and column dimension.
repeat(ObjectMatrix1D, int) - Method in class cern.colt.matrix.ObjectFactory1D
C = A||A||..||A; Constructs a new matrix which is concatenated repeat times.
repeat(ObjectMatrix2D, int, int) - Method in class cern.colt.matrix.ObjectFactory2D
C = A||A||..||A; Constructs a new matrix which is duplicated both along the row and column dimension.
replace(String, String, String) - Static method in class jminhep.utils.StringUtil
Return a String with all occurrences of the "from" String within "original" replaced with the "to" String.
replaceBottomPosition(CategoryLabelPositions, CategoryLabelPosition) - Static method in class org.jfree.chart.axis.CategoryLabelPositions
Returns a new instance based on an existing instance but with the bottom position changed.
replaceBoxWith(int, int, int, int, BitMatrix, int, int) - Method in class cern.colt.bitvector.BitMatrix
Replaces a box of the receiver with the contents of another matrix's box.
replaceBoxWith(int, int, int, int, boolean) - Method in class cern.colt.bitvector.BitMatrix
Sets the bits in the given box to the state specified by value.
replaceContent(Vector) - Method in class jplot.Utils.LabeledComboBox
 
replaceContent(String[]) - Method in class jplot.Utils.LabeledComboBox
 
replaceData(int, DataArray) - Method in class jplot.JPlot
 
replaceFromToWith(int, int, BitVector, int) - Method in class cern.colt.bitvector.BitVector
Replaces the bits of the receiver in the given range with the bits of another bit vector.
replaceFromToWith(int, int, boolean) - Method in class cern.colt.bitvector.BitVector
Sets the bits in the given range to the state specified by value.
replaceFromToWithFrom(int, int, AbstractBooleanList, int) - Method in class cern.colt.list.AbstractBooleanList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractByteList, int) - Method in class cern.colt.list.AbstractByteList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractCharList, int) - Method in class cern.colt.list.AbstractCharList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractDoubleList, int) - Method in class cern.colt.list.AbstractDoubleList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractFloatList, int) - Method in class cern.colt.list.AbstractFloatList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractIntList, int) - Method in class cern.colt.list.AbstractIntList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractLongList, int) - Method in class cern.colt.list.AbstractLongList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractShortList, int) - Method in class cern.colt.list.AbstractShortList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractBooleanList, int) - Method in class cern.colt.list.BooleanArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractByteList, int) - Method in class cern.colt.list.ByteArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractCharList, int) - Method in class cern.colt.list.CharArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractDoubleList, int) - Method in class cern.colt.list.DoubleArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractFloatList, int) - Method in class cern.colt.list.FloatArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractIntList, int) - Method in class cern.colt.list.IntArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractLongList, int) - Method in class cern.colt.list.LongArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, ObjectArrayList, int) - Method in class cern.colt.list.ObjectArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractShortList, int) - Method in class cern.colt.list.ShortArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFromTo(int, int, AbstractBooleanList, int, int) - Method in class cern.colt.list.AbstractBooleanList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractByteList, int, int) - Method in class cern.colt.list.AbstractByteList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractCharList, int, int) - Method in class cern.colt.list.AbstractCharList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractDoubleList, int, int) - Method in class cern.colt.list.AbstractDoubleList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractFloatList, int, int) - Method in class cern.colt.list.AbstractFloatList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractIntList, int, int) - Method in class cern.colt.list.AbstractIntList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractLongList, int, int) - Method in class cern.colt.list.AbstractLongList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractShortList, int, int) - Method in class cern.colt.list.AbstractShortList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, ObjectArrayList, int, int) - Method in class cern.colt.list.ObjectArrayList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractBooleanList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractByteList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractCharList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractDoubleList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractFloatList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractIntList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractLongList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractShortList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.ObjectArrayList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceLeftPosition(CategoryLabelPositions, CategoryLabelPosition) - Static method in class org.jfree.chart.axis.CategoryLabelPositions
Returns a new instance based on an existing instance but with the left position changed.
replaceLinePars(int, LinePars) - Method in class jplot.JPlot
 
replaceMostRecentValue(double) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Replaces the most recently stored value with the given value.
replacePoint(int, double, double, double, double, double, double, double, double, double, double) - Method in class jplot.DataArray
Replace the values of a plot-point pair (x,y).
replaceRightPosition(CategoryLabelPositions, CategoryLabelPosition) - Static method in class org.jfree.chart.axis.CategoryLabelPositions
Returns a new instance based on an existing instance but with the right position changed.
replaceTopPosition(CategoryLabelPositions, CategoryLabelPosition) - Static method in class org.jfree.chart.axis.CategoryLabelPositions
Returns a new instance based on an existing instance but with the top position changed.
REPLAY_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Replay data from valuesFilePath.
representableDelta(double, double) - Static method in class org.apache.commons.math3.util.Precision
Computes a number delta close to originalDelta with the property that
REQUESTED_EVENTS_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
REQUESTED_EVENTS_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
REQUESTED_EVENTS_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
REQUESTED_EVENTS_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
requiredCharsets() - Static method in class org.apache.commons.io.Charsets
Constructs a sorted map from canonical charset names to charset objects required of every implementation of the Java platform.
requireNonNegative(int, String) - Static method in class org.jfree.chart.util.ParamChecks
Throws an IllegalArgumentException if value is negative.
rescale(int) - Method in class jhplot.PND
Rescale the column vectors.
rescale(double[][]) - Method in class jhplot.PND
This is an inverse operation to rescale(type) function.
rescale(double) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Rescale the instance.
reSeed(long) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Reseeds the random number generator used by EmpiricalDistribution.getNextValue().
reSeed(long) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Reseeds the random number generator with the supplied seed.
reSeed() - Method in class org.apache.commons.math3.random.RandomDataGenerator
Reseeds the random number generator with System.currentTimeMillis() + System.identityHashCode(this)).
reSeed(long) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Reseeds the random number generator with the supplied seed.
reSeed() - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Reseeds the random number generator with System.currentTimeMillis() + System.identityHashCode(this)).
reSeed(long) - Method in class org.apache.commons.math3.random.ValueServer
Reseeds the random data generator.
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
Reseed the random generator used to generate samples.
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.distribution.AbstractMultivariateRealDistribution
Reseeds the random generator used to generate samples.
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Reseed the random generator used to generate samples.
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
Override with no-op (there is no generator).
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.distribution.EnumeratedDistribution
Reseed the random generator used to generate samples.
reseedRandomGenerator(long) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Reseed the random generator used to generate samples.
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Reseeds the random generator used to generate samples.
reseedRandomGenerator(long) - Method in interface org.apache.commons.math3.distribution.MultivariateRealDistribution
Reseeds the random generator used to generate samples.
reseedRandomGenerator(long) - Method in interface org.apache.commons.math3.distribution.RealDistribution
Reseed the random generator used to generate samples.
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Reseed the random generator used to generate samples.
reSeedSecure() - Method in class org.apache.commons.math3.random.RandomDataGenerator
Reseeds the secure random number generator with the current time in milliseconds.
reSeedSecure(long) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Reseeds the secure random number generator with the supplied seed.
reSeedSecure() - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Reseeds the secure random number generator with the current time in milliseconds.
reSeedSecure(long) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Reseeds the secure random number generator with the supplied seed.
reserved(Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.AxisSpace
Calculates the reserved area.
reserveSpace(Graphics2D, Plot, Rectangle2D, RectangleEdge, AxisSpace) - Method in class org.jfree.chart.axis.Axis
Estimates the space (height or width) required to draw the axis.
reserveSpace(Graphics2D, Plot, Rectangle2D, RectangleEdge, AxisSpace) - Method in class org.jfree.chart.axis.CategoryAxis
Estimates the space required for the axis, given a specific drawing area.
reserveSpace(Graphics2D, Plot, Rectangle2D, Rectangle2D, RectangleEdge, AxisSpace) - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Reserves the space required to draw the color bar.
reserveSpace(Graphics2D, Plot, Rectangle2D, RectangleEdge, AxisSpace) - Method in class org.jfree.chart.axis.CyclicNumberAxis
Reserve some space on each axis side because we draw a centered label at each extremity.
reserveSpace(Graphics2D, Plot, Rectangle2D, RectangleEdge, AxisSpace) - Method in class org.jfree.chart.axis.PeriodAxis
Estimates the space (height or width) required to draw the axis.
reserveSpace(Graphics2D, Plot, Rectangle2D, RectangleEdge, AxisSpace) - Method in class org.jfree.chart.axis.SubCategoryAxis
Estimates the space required for the axis, given a specific drawing area.
reserveSpace(Graphics2D, Plot, Rectangle2D, RectangleEdge, AxisSpace) - Method in class org.jfree.chart.axis.ValueAxis
Returns the space required to draw the axis.
reset() - Method in class cern.colt.Timer
Resets the timer.
reset() - Method in class cern.hep.aida.ref.Histogram1D
 
reset() - Method in class cern.hep.aida.ref.Histogram2D
 
reset() - Method in class cern.hep.aida.ref.Histogram3D
 
reset() - Method in interface colt.hep.aida.IHistogram
Reset contents; as if just constructed.
reset() - Method in class hep.lcio.util.ObjectComparator
 
reset() - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
 
reset() - Method in interface hep.physics.event.generator.EventGenerator
 
reset() - Method in class j4np.physics.LorentzVector
 
reset() - Static method in class jhepsim.Options
Reset preferences.
reset(double, double) - Method in class jhplot.math.ValueErr
Set value and errors to 0
reset() - Method in class jhplot.stat.LinReg
reset data to 0
reset() - Method in class jplot.GraphSettings
Resets the class to default values.
reset(LinePars) - Method in class jplot.LineStyleButton
 
reset() - Method in class org.apache.commons.io.input.BOMInputStream
Invokes the delegate's reset() method.
reset() - Method in class org.apache.commons.io.input.BoundedInputStream
Invokes the delegate's reset() method.
reset() - Method in class org.apache.commons.io.input.BoundedReader
Resets the target to the latest mark,
reset() - Method in class org.apache.commons.io.input.BrokenInputStream
Throws the configured exception.
reset() - Method in class org.apache.commons.io.input.BrokenReader
Throws the configured exception.
reset() - Method in class org.apache.commons.io.input.CharSequenceInputStream
 
reset() - Method in class org.apache.commons.io.input.CharSequenceReader
Reset the reader to the last marked position (or the beginning if mark has not been called).
reset() - Method in class org.apache.commons.io.input.MarkShieldInputStream
 
reset() - Method in class org.apache.commons.io.input.NullInputStream
Reset the stream to the point when mark was last called.
reset() - Method in class org.apache.commons.io.input.NullReader
Resets the stream to the point when mark was last called.
reset() - Method in class org.apache.commons.io.input.ProxyInputStream
Invokes the delegate's reset() method.
reset() - Method in class org.apache.commons.io.input.ProxyReader
Invokes the delegate's reset() method.
reset() - Method in class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
 
reset() - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
 
reset() - Method in class org.apache.commons.io.output.ByteArrayOutputStream
 
reset() - Method in class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
 
reset(Vector3D, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Reset the instance as if built from two points.
reset(Vector3D, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Reset the instance as if built from a point and a normal.
reset(Plane) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Reset the instance from another one.
reset(Vector2D, Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Reset the instance as if built from two points.
reset(Vector2D, double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Reset the instance as if built from a line and an angle.
reset(Vector3D) - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Reset the instance as if built from a pole.
reset(double, double[]) - Method in class org.apache.commons.math3.ode.events.EventState
Let the event handler reset the state if it wants.
reset(FieldODEStateAndDerivative<T>) - Method in class org.apache.commons.math3.ode.events.FieldEventState
Let the event handler reset the state if it wants.
reset() - Method in class org.jlab.groot.data.GraphErrors
 
reset() - Method in class org.jlab.groot.data.H1F
Resets all bins to 0
reset() - Method in class org.jlab.groot.data.H2F
Resets the content of the histogram, sets all bin contents to 0
reset() - Method in interface org.jlab.groot.data.IDataSet
 
reset() - Method in class org.jlab.groot.math.Func1D
 
reset() - Method in class org.jlab.groot.math.UserParameters
 
reset() - Method in interface org.jlab.groot.tree.ITree
 
reset() - Method in class org.jlab.groot.tree.RandomTree
 
reset() - Method in class org.jlab.groot.tree.Tree
 
reset() - Method in class org.jlab.groot.tree.TreeSelector
 
reset() - Method in class org.jlab.groot.tree.TreeTextFile
 
resetBorder() - Method in class jplot.SmallButton
 
resetBorder() - Method in class jplot.SmallToggleButton
Set the border of the button to the appropiate state.
resetBranches(double) - Method in class org.jlab.groot.tree.Tree
 
resetByteCount() - Method in class org.apache.commons.io.input.CountingInputStream
Set the byte count back to 0.
resetByteCount() - Method in class org.apache.commons.io.output.CountingOutputStream
Set the byte count back to 0.
resetColorIndex() - Method in class jplot.GraphSettings
Resets the color index to the first color.
resetCount() - Method in class org.apache.commons.io.input.CountingInputStream
Set the byte count back to 0.
resetCount() - Method in class org.apache.commons.io.output.CountingOutputStream
Set the byte count back to 0.
resetCount() - Method in class org.apache.commons.math3.util.Incrementor
Deprecated.
Resets the counter to 0.
resetIterationCount() - Method in class org.apache.commons.math3.util.IterationManager
Sets the iteration count to 0.
resetKeyWords() - Method in class graph.ScanString
Clear the table containing the keyword/token pairs
resetKeyWords() - Method in class graph.ScanWord
Clear the internal table containing the keyword/token pairs
resetLabelPositions(double, double, double, double) - Method in class jplot.GraphGeneral
 
resetLabels() - Method in class jplot.GraphSettings
Reset the positions of all the labels.
resetMargins() - Method in class jhplot.gui.GHPanel
Reset all margins to the default values.
resetPointIndex() - Method in class jplot.GraphSettings
Resets the point-type index to the first symbol.
resetRange() - Method in class graph.Axis
Reset the range of the axis (the minimum and maximum values) to the default data values.
resetReplayFile() - Method in class org.apache.commons.math3.random.ValueServer
Resets REPLAY_MODE file pointer to the beginning of the valuesFileURL.
resetState(double, double[]) - Method in class org.apache.commons.math3.ode.events.EventFilter
Reset the state prior to continue the integration.
resetState(double, double[]) - Method in interface org.apache.commons.math3.ode.events.EventHandler
Reset the state prior to continue the integration.
resetState(FieldODEStateAndDerivative<T>) - Method in interface org.apache.commons.math3.ode.events.FieldEventHandler
Reset the state prior to continue the integration.
resetStyle() - Method in class jhplot.HPlot
Resets the current plot settings to default values.
resetStyleAll() - Method in class jhplot.HPlot
Resets all plot settings to default values.
resetVariables() - Method in class jplot3dp.MathParser.MathParser
 
resetVars() - Method in class org.lsmp.djepExamples.XJepConsole
 
residuals(float[], float[]) - Static method in class jhplot.stat.StatUtils
Compute residuals of b versus a.
ResizableDoubleArray - Class in org.apache.commons.math3.util
A variable length DoubleArray implementation that automatically handles expanding and contracting its internal storage array as elements are added and removed.
ResizableDoubleArray() - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance with default properties.
ResizableDoubleArray(int) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance with the specified initial capacity.
ResizableDoubleArray(double[]) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance from an existing double[] with the initial capacity and numElements corresponding to the size of the supplied double[] array.
ResizableDoubleArray(int, float) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
ResizableDoubleArray(int, double) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance with the specified initial capacity and expansion factor.
ResizableDoubleArray(int, float, float) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
ResizableDoubleArray(int, double, double) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance with the specified initial capacity, expansion factor, and contraction criteria.
ResizableDoubleArray(int, float, float, int) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
ResizableDoubleArray(int, double, double, ResizableDoubleArray.ExpansionMode, double...) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance with the specified properties.
ResizableDoubleArray(ResizableDoubleArray) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Copy constructor.
ResizableDoubleArray.ExpansionMode - Enum in org.apache.commons.math3.util
Specification of expansion algorithm.
resize(double[][], int, int) - Static method in class jhplot.math.DoubleArray
Generate a resized copy of a matrix
resizePad(double, double) - Method in class jhplot.HChart
Resize the current pad.
resizePad(int, int, double, double) - Method in class jhplot.HChart
Resize the pad given by the inxX and indxY.
resizePad(double, double) - Method in class jhplot.HPlot
Resize the current pad.
resizePad(int, int, double, double) - Method in class jhplot.HPlot
Resize the pad given by the inxX and indxY.
resizePad(double, double) - Method in class jhplot.HPlot3D
Resize the current pad.
resizePad(int, int, double, double) - Method in class jhplot.HPlot3D
Resize the pad given by the inxX and indxY.
resizePad(double, double) - Method in class jhplot.HPlot3DP
Resize the current pad.
resizeRange(double) - Method in class org.jfree.chart.axis.LogAxis
Increases or decreases the axis range by the specified percentage about the central value and sends an AxisChangeEvent to all registered listeners.
resizeRange(double, double) - Method in class org.jfree.chart.axis.LogAxis
 
resizeRange(double) - Method in class org.jfree.chart.axis.ModuloAxis
Increases or decreases the axis range by the specified percentage about the central value and sends an AxisChangeEvent to all registered listeners.
resizeRange(double, double) - Method in class org.jfree.chart.axis.ModuloAxis
Increases or decreases the axis range by the specified percentage about the specified anchor value and sends an AxisChangeEvent to all registered listeners.
resizeRange(double) - Method in class org.jfree.chart.axis.ValueAxis
Increases or decreases the axis range by the specified percentage about the central value and sends an AxisChangeEvent to all registered listeners.
resizeRange(double, double) - Method in class org.jfree.chart.axis.ValueAxis
Increases or decreases the axis range by the specified percentage about the specified anchor value and sends an AxisChangeEvent to all registered listeners.
resizeRange2(double, double) - Method in class org.jfree.chart.axis.LogAxis
Resizes the axis length to the specified percentage of the current range and sends a change event to all registered listeners.
resizeRange2(double, double) - Method in class org.jfree.chart.axis.ValueAxis
Increases or decreases the axis range by the specified percentage about the specified anchor value and sends an AxisChangeEvent to all registered listeners.
resolveDomainAxisLocation(AxisLocation, PlotOrientation) - Static method in class org.jfree.chart.plot.Plot
Resolves a domain axis location for a given plot orientation.
resolveRangeAxisLocation(AxisLocation, PlotOrientation) - Static method in class org.jfree.chart.plot.Plot
Resolves a range axis location for a given plot orientation.
ResourceBundleWrapper - Class in org.jfree.chart.util
Wrapper of ResourceBundle.getBundle() methods.
ResourceLoader - Class in jminhep.utils
 
resourceToByteArray(String) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a classpath resource as a byte array.
resourceToByteArray(String, ClassLoader) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a classpath resource as a byte array.
resourceToString(String, Charset) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a classpath resource as a String using the specified character encoding.
resourceToString(String, Charset, ClassLoader) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a classpath resource as a String using the specified character encoding.
resourceToURL(String) - Static method in class org.apache.commons.io.IOUtils
Gets a URL pointing to the given classpath resource.
resourceToURL(String, ClassLoader) - Static method in class org.apache.commons.io.IOUtils
Gets a URL pointing to the given classpath resource.
restart(Reader, JEP) - Method in class org.nfunk.jep.Parser
Restart the parse with the given stream.
restartParser(String) - Method in class org.lsmp.djep.xjep.XJep
Restarts the parser with the given string.
restartParser(Reader) - Method in class org.lsmp.djep.xjep.XJep
Restarts the parser with the given Reader.
restMass2() - Method in class hephysics.vec.HepLorentzVector
Rest mass squared -- same as m2()
restoreAutoBounds() - Method in class org.jfree.chart.ChartPanel
Restores the auto-range calculation on both axes.
restoreAutoDomainBounds() - Method in class org.jfree.chart.ChartPanel
Restores the auto-range calculation on the domain axis.
restoreAutoRangeBounds() - Method in class org.jfree.chart.ChartPanel
Restores the auto-range calculation on the range axis.
restrictStep(FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>) - Method in class org.apache.commons.math3.ode.sampling.AbstractFieldStepInterpolator
Create a new restricted version of the instance.
retainAll(AbstractBooleanList) - Method in class cern.colt.list.AbstractBooleanList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractByteList) - Method in class cern.colt.list.AbstractByteList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractCharList) - Method in class cern.colt.list.AbstractCharList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractDoubleList) - Method in class cern.colt.list.AbstractDoubleList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractFloatList) - Method in class cern.colt.list.AbstractFloatList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractIntList) - Method in class cern.colt.list.AbstractIntList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractLongList) - Method in class cern.colt.list.AbstractLongList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractShortList) - Method in class cern.colt.list.AbstractShortList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractBooleanList) - Method in class cern.colt.list.BooleanArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractByteList) - Method in class cern.colt.list.ByteArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractCharList) - Method in class cern.colt.list.CharArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractDoubleList) - Method in class cern.colt.list.DoubleArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractFloatList) - Method in class cern.colt.list.FloatArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractIntList) - Method in class cern.colt.list.IntArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractLongList) - Method in class cern.colt.list.LongArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(ObjectArrayList, boolean) - Method in class cern.colt.list.ObjectArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractShortList) - Method in class cern.colt.list.ShortArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
reunite(SubHyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Compute the union of the instance and another sub-hyperplane.
reunite(SubHyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Compute the union of the instance and another sub-hyperplane.
reverse() - Method in class cern.colt.list.AbstractBooleanList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractByteList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractCharList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractDoubleList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractFloatList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractIntList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractLongList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractShortList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.BooleanArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.ByteArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.CharArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.DoubleArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.FloatArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.IntArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.LongArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.ObjectArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.ShortArrayList
Reverses the elements of the receiver.
reverse(int) - Static method in class jhplot.math.SortUtils
Create reverse permutation, that is {n-1, ....
REVERSE - Static variable in class org.jfree.chart.LegendRenderingOrder
In reverse order.
REVERSE - Static variable in class org.jfree.chart.plot.DatasetRenderingOrder
Render datasets in the order N-1, N-2, ..., 2, 1, 0, where N is the number of datasets.
REVERSE - Static variable in class org.jfree.chart.plot.SeriesRenderingOrder
Render series in the order N-1, N-2, ..., 2, 1, 0, where N is the number of series.
ReversedLinesFileReader - Class in org.apache.commons.io.input
Reads lines in a file reversely (similar to a BufferedReader, but starting at the last line).
ReversedLinesFileReader(File) - Constructor for class org.apache.commons.io.input.ReversedLinesFileReader
ReversedLinesFileReader(File, Charset) - Constructor for class org.apache.commons.io.input.ReversedLinesFileReader
Creates a ReversedLinesFileReader with default block size of 4KB and the specified encoding.
ReversedLinesFileReader(File, int, Charset) - Constructor for class org.apache.commons.io.input.ReversedLinesFileReader
Creates a ReversedLinesFileReader with the given block size and encoding.
ReversedLinesFileReader(File, int, String) - Constructor for class org.apache.commons.io.input.ReversedLinesFileReader
Creates a ReversedLinesFileReader with the given block size and encoding.
ReversedLinesFileReader(Path, Charset) - Constructor for class org.apache.commons.io.input.ReversedLinesFileReader
Creates a ReversedLinesFileReader with default block size of 4KB and the specified encoding.
ReversedLinesFileReader(Path, int, Charset) - Constructor for class org.apache.commons.io.input.ReversedLinesFileReader
Creates a ReversedLinesFileReader with the given block size and encoding.
ReversedLinesFileReader(Path, int, String) - Constructor for class org.apache.commons.io.input.ReversedLinesFileReader
Creates a ReversedLinesFileReader with the given block size and encoding.
revert() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Revert a rotation.
revert() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get a line with reversed direction.
revert() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Revert a rotation.
revertSelf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Revert the instance.
revertSelf() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Revert the plane.
revertSelf() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Revert the instance.
revertSelf() - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Revert the instance.
rewrite(Node, XJep, RewriteRuleI[], boolean) - Method in class org.lsmp.djep.rewrite.RewriteVisitor
must be implemented for subclasses.
RewriteRuleI - Interface in org.lsmp.djep.rewrite
 
RewriteTest - Class in org.lsmp.djepJUnit
 
RewriteTest(String) - Constructor for class org.lsmp.djepJUnit.RewriteTest
 
RewriteVisitor - Class in org.lsmp.djep.rewrite
Simplifies an expression.
RewriteVisitor() - Constructor for class org.lsmp.djep.rewrite.RewriteVisitor
 
rho() - Method in class j4np.physics.Vector3
 
richardson(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using the Richardson extrapolation.
RiddersSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Ridders' Method for root finding of real univariate functions.
RiddersSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.RiddersSolver
Construct a solver with default accuracy (1e-6).
RiddersSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.RiddersSolver
Construct a solver.
RiddersSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.RiddersSolver
Construct a solver.
RIGHT - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The alignment string aligning the cells of a column to the right.
RIGHT - Static variable in class graph.Axis
Constant flagging Axis position on the graph.
RIGHT - Static variable in class graph.TextLine
Position the Text to the Right of the point
RIGHT - Static variable in class org.jfree.chart.plot.ThermometerPlot
A constant for the value label position (right of the thermometer).
RIGHT - Static variable in class org.lsmp.djep.xjep.XOperator
Right binding like =: 1=2=3 -> 1=(2=3)
RightExpression() - Method in class org.nfunk.jep.Parser
 
rightWithin(Rectangle, Dimension) - Static method in class jhepsim.Util
 
rightWithin(Component, Component) - Static method in class jhepsim.Util
Puts to the right
rightWithin(Rectangle, Dimension) - Static method in class jhplot.utils.Util
 
rightWithin(Component, Component) - Static method in class jhplot.utils.Util
Puts to the right
rightWithin(Rectangle, Dimension) - Static method in class jminhep.utils.Util
 
rightWithin(Component, Component) - Static method in class jminhep.utils.Util
Puts to the right
RingI - Interface in org.lsmp.djep.groupJep.interfaces
Defines the operations on a ring, i.e.
RingPlot - Class in org.jfree.chart.plot
A customised pie plot that leaves a hole in the middle.
RingPlot() - Constructor for class org.jfree.chart.plot.RingPlot
Creates a new plot with a null dataset.
RingPlot(PieDataset) - Constructor for class org.jfree.chart.plot.RingPlot
Creates a new plot for the specified dataset.
rint - Static variable in class cern.jet.math.Functions
Function that returns Math.rint(a).
rint(float) - Static method in class net.jafama.FastMath
 
rint(double) - Static method in class net.jafama.FastMath
 
rint(float) - Static method in class net.jafama.StrictFastMath
 
rint(double) - Static method in class net.jafama.StrictFastMath
 
rint() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
rint() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
Rint - Class in org.apache.commons.math3.analysis.function
rint function.
Rint() - Constructor for class org.apache.commons.math3.analysis.function.Rint
 
rint() - Method in class org.apache.commons.math3.dfp.Dfp
Round to nearest integer using the round-half-even method.
rint() - Method in interface org.apache.commons.math3.RealFieldElement
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
rint() - Method in class org.apache.commons.math3.util.Decimal64
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
rint(double) - Static method in class org.apache.commons.math3.util.FastMath
Get the whole number that is the nearest to x, or the even one if x is exactly half way between two integers.
rjBesl(double, double, int) - Static method in class org.apache.commons.math3.special.BesselJ
Calculates Bessel functions \(J_{n+alpha}(x)\) for non-negative argument x, and non-negative order n + alpha.
rms() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the rms (Root Mean Square), which is Math.sqrt( Sum( x[i]*x[i] ) / size() ).
rms - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.rms().
rms() - Method in class cern.hep.aida.ref.Histogram1D
 
rms(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the RMS (Root-Mean-Square) of a data sequence.
rms() - Method in interface colt.hep.aida.IHistogram1D
Returns the rms of the whole histogram as calculated on filling-time.
rms() - Method in class jhplot.H1D
Get RMS of histogram
rms() - Method in class jhplot.HProf1D
Get RMS of histogram
RMS_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
RMSES_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
RMSESX_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
RMSESY_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
rmsX() - Method in class cern.hep.aida.ref.Histogram2D
 
rmsX() - Method in class cern.hep.aida.ref.Histogram3D
 
rmsX() - Method in interface colt.hep.aida.IHistogram2D
Returns the rms of the histogram as calculated on filling-time projected on the X axis.
rmsX() - Method in interface colt.hep.aida.IHistogram3D
Returns the rms of the histogram as calculated on filling-time projected on the X axis.
rmsX() - Method in class jhplot.P1D
Returns RMS for X-values.
rmsY() - Method in class cern.hep.aida.ref.Histogram2D
 
rmsY() - Method in class cern.hep.aida.ref.Histogram3D
 
rmsY() - Method in interface colt.hep.aida.IHistogram2D
Returns the rms of the histogram as calculated on filling-time projected on the Y axis.
rmsY() - Method in interface colt.hep.aida.IHistogram3D
Returns the rms of the histogram as calculated on filling-time projected on the Y axis.
rmsY() - Method in class jhplot.P1D
Returns RMS for Y-values.
rmsZ() - Method in class cern.hep.aida.ref.Histogram3D
 
rmsZ() - Method in interface colt.hep.aida.IHistogram3D
Returns the rms of the histogram as calculated on filling-time projected on the Z axis.
RNG - Interface in jhplot.math.num.random
Defines a random number generator that is capable of generating sequences of random numbers uniformly distributed between zero and one.
rollDate(Date) - Method in class org.jfree.chart.axis.DateTickUnit
Rolls the date forward by the amount specified by the roll unit and count.
rollDate(Date, TimeZone) - Method in class org.jfree.chart.axis.DateTickUnit
Rolls the date forward by the amount specified by the roll unit and count.
ROMAN_QUARTERS - Static variable in class org.jfree.chart.axis.QuarterDateFormat
Symbols for roman numbered quarters.
ROMBERG_MAX_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.RombergIntegrator
Maximal number of iterations for Romberg.
RombergIntegrator - Class in jhplot.math.num.integration
An implementation of Romberg Integration.
RombergIntegrator(Function) - Constructor for class jhplot.math.num.integration.RombergIntegrator
Create an integrator for the given function.
RombergIntegrator(Function, int, double) - Constructor for class jhplot.math.num.integration.RombergIntegrator
Create an integrator for the given function.
RombergIntegrator - Class in org.apache.commons.math3.analysis.integration
Implements the Romberg Algorithm for integration of real univariate functions.
RombergIntegrator(double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.RombergIntegrator
Build a Romberg integrator with given accuracies and iterations counts.
RombergIntegrator(int, int) - Constructor for class org.apache.commons.math3.analysis.integration.RombergIntegrator
Build a Romberg integrator with given iteration counts.
RombergIntegrator() - Constructor for class org.apache.commons.math3.analysis.integration.RombergIntegrator
Construct a Romberg integrator with default settings (max iteration count set to RombergIntegrator.ROMBERG_MAX_ITERATIONS_COUNT)
root - package root
Access to ROOT files (based on Tony Johnson's RootHistogramBrowser).
RootHandler - Class in org.jfree.data.xml
A SAX handler that delegates work to sub-handlers.
RootHandler() - Constructor for class org.jfree.data.xml.RootHandler
Creates a new handler.
RootHistogramTreeModel - Class in root
An adaptor that converts a root TDirectory into a TreeModel, allowing any directory structure to be dislayed by a Swing JTree.
RootHistogramTreeModel(TDirectory) - Constructor for class root.RootHistogramTreeModel
Create the tree mode.
rootLogLikelihoodRatio(long, long, long, long) - Method in class org.apache.commons.math3.stat.inference.GTest
Calculates the root log-likelihood ratio for 2 state Datasets.
rootLogLikelihoodRatio(long, long, long, long) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
rootN(int) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Nth root.
rootN(double[], int, int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute nth root of a derivative structure.
rootN(int) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Nth root.
rootN(int) - Method in class org.apache.commons.math3.dfp.Dfp
Nth root.
rootN(int) - Method in interface org.apache.commons.math3.RealFieldElement
Nth root.
rootN(int) - Method in class org.apache.commons.math3.util.Decimal64
Nth root.
RootsOfUnity - Class in org.apache.commons.math3.complex
A helper class for the computation and caching of the n-th roots of unity.
RootsOfUnity() - Constructor for class org.apache.commons.math3.complex.RootsOfUnity
Build an engine for computing the n-th roots of unity.
RootStoreFactory - Class in root
An implementation of IStoreFactory that creates RootStore.
RootStoreFactory() - Constructor for class root.RootStoreFactory
 
Rot - Class in Jampack
Rot generates and manipulates plane rotations.
Rot() - Constructor for class Jampack.Rot
 
rotate(Vector3D, Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Rotate the plane around the specified point.
rotate(Vector3D, Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Rotate the region around the specified point.
rotate(double) - Method in class org.jfree.chart.fx.FXGraphics2D
Applies a rotation (anti-clockwise) about (0, 0).
rotate(double, double, double) - Method in class org.jfree.chart.fx.FXGraphics2D
Applies a rotation (anti-clockwise) about (x, y).
ROTATE_LEFT - Static variable in class org.jlab.groot.ui.LatexText
 
ROTATE_NONE - Static variable in class org.jlab.groot.ui.LatexText
 
ROTATE_RIGHT - Static variable in class org.jlab.groot.ui.LatexText
 
rotateTics(int) - Method in class jplot.GraphSettings
Returns whether or not we should rotate the tics.
rotateX(double) - Method in class j4np.physics.LorentzVector
 
rotateX(double) - Method in class j4np.physics.Vector3
 
rotateY(double) - Method in class j4np.physics.LorentzVector
 
rotateY(double) - Method in class j4np.physics.Vector3
 
rotateZ(double) - Method in class j4np.physics.LorentzVector
 
rotateZ(double) - Method in class j4np.physics.Vector3
 
Rotation - Class in org.apache.commons.math3.geometry.euclidean.threed
This class implements rotations in a three-dimensional space.
Rotation(double, double, double, double, boolean) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build a rotation from the quaternion coordinates.
Rotation(Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Deprecated.
Rotation(Vector3D, double, RotationConvention) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build a rotation from an axis and an angle.
Rotation(double[][], double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build a rotation from a 3X3 matrix.
Rotation(Vector3D, Vector3D, Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build the rotation that transforms a pair of vectors into another pair.
Rotation(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build one of the rotations that transform one vector into another one.
Rotation(RotationOrder, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Rotation(RotationOrder, RotationConvention, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build a rotation from three Cardan or Euler elementary rotations.
RotationConvention - Enum in org.apache.commons.math3.geometry.euclidean.threed
This enumerates is used to differentiate the semantics of a rotation.
RotationOrder - Class in org.apache.commons.math3.geometry.euclidean.threed
This class is a utility representing a rotation order specification for Cardan or Euler angles specification.
rotationStarts() - Method in class jplot3d.SurfaceModelCanvas
Called when automatic rotation starts.
rotationStops() - Method in class jplot3d.SurfaceModelCanvas
Called when automatic rotation stops
round(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns the number rounded to the given precision; Math.rint(a/precision)*precision.
round(float) - Static method in class net.jafama.FastMath
Might have different semantics than Math.round(float), see bugs 6430675 and 8010430.
round(double) - Static method in class net.jafama.FastMath
Might have different semantics than Math.round(double), see bugs 6430675 and 8010430.
round(float) - Static method in class net.jafama.StrictFastMath
Might have different semantics than StrictMath.round(float), see bugs 6430675 and 8010430.
round(double) - Static method in class net.jafama.StrictFastMath
Might have different semantics than StrictMath.round(double), see bugs 6430675 and 8010430.
round() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the closest long to instance value.
round() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Get the closest long to instance value.
round() - Method in class org.apache.commons.math3.dfp.Dfp
Get the closest long to instance value.
round() - Method in interface org.apache.commons.math3.RealFieldElement
Get the closest long to instance value.
round() - Method in class org.apache.commons.math3.util.Decimal64
Get the closest long to instance value.
round(double) - Static method in class org.apache.commons.math3.util.FastMath
Get the closest long to x.
round(float) - Static method in class org.apache.commons.math3.util.FastMath
Get the closest int to x.
round(double, int) - Static method in class org.apache.commons.math3.util.Precision
Rounds the given value to the specified number of decimal places.
round(double, int, int) - Static method in class org.apache.commons.math3.util.Precision
Rounds the given value to the specified number of decimal places.
round(float, int) - Static method in class org.apache.commons.math3.util.Precision
Rounds the given value to the specified number of decimal places.
round(float, int, int) - Static method in class org.apache.commons.math3.util.Precision
Rounds the given value to the specified number of decimal places.
Round - Class in org.nfunk.jep.function
A PostfixMathCommandI which rounds a number round(pi) finds the closest integer to the argument round(pi,3) rounds the argument to 3 decimal places
Round() - Constructor for class org.nfunk.jep.function.Round
 
round(Object) - Method in class org.nfunk.jep.function.Round
 
roundEven(float) - Static method in class net.jafama.FastMath
 
roundEven(double) - Static method in class net.jafama.FastMath
 
roundEven(float) - Static method in class net.jafama.StrictFastMath
 
roundEven(double) - Static method in class net.jafama.StrictFastMath
 
roundUp(double) - Static method in class jplot.Utils
 
RoundUp(double) - Static method in class jplot.Utils
Round up the passed value to a NICE value.
roundUp(double) - Static method in class jplot3d.NumUtil
 
row(Zmat, int[]) - Static method in class Jampack.Pivot
Pivots the rows of a Zmat (altered) as specified by a pivot array.
rowCompressed - Static variable in class cern.colt.matrix.DoubleFactory2D
A factory producing sparse row compressed matrices.
rowi(Zmat, int[]) - Static method in class Jampack.Pivot
Pivots the rows of a Zmat (altered) as in the inverse order specified by a pivot array.
rows() - Method in class cern.colt.bitvector.BitMatrix
Returns the number of rows of the receiver.
rows() - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Returns the number of rows.
rows() - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Returns the number of rows.
rows(Zmat, int, int) - Static method in class Jampack.Swap
Interchances two rows of a Zmat (altered).
rowVector(double[]) - Static method in class jhplot.math.DoubleArray
Converts an n element array into an 1 x n matrix.
RpCommand - Class in org.lsmp.djep.rpe
Data type for the command string
RpCommandList - Class in org.lsmp.djep.rpe
A list of commands
RpEval - Class in org.lsmp.djep.rpe
A fast evaluation algorithm for equations over Doubles, does not work with vectors or matricies.
RpEval(JEP) - Constructor for class org.lsmp.djep.rpe.RpEval
 
RpExample - Class in org.lsmp.djepExamples
Examples using vectors and matricies
RpExample() - Constructor for class org.lsmp.djepExamples.RpExample
 
RpSpeed - Class in org.lsmp.djepExamples
Compares the speed of matrix operations using both VectorJep or MatrixJep.
RpSpeed() - Constructor for class org.lsmp.djepExamples.RpSpeed
 
RpTest - Class in org.lsmp.djepJUnit
JUnit test for full Matrix Rp evaluator
RpTest(String) - Constructor for class org.lsmp.djepJUnit.RpTest
 
rr - Variable in class jhplot.io.HDataBase
 
RRND - Static variable in interface org.nfunk.jep.ParserConstants
 
RRQRDecomposition - Class in org.apache.commons.math3.linear
Calculates the rank-revealing QR-decomposition of a matrix, with column pivoting.
RRQRDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.RRQRDecomposition
Calculates the QR-decomposition of the given matrix.
RRQRDecomposition(RealMatrix, double) - Constructor for class org.apache.commons.math3.linear.RRQRDecomposition
Calculates the QR-decomposition of the given matrix.
RSQ - Static variable in interface org.nfunk.jep.ParserConstants
 
RTextLine - Class in graph
 
RTextLine() - Constructor for class graph.RTextLine
Instantiate the class
RTextLine(String) - Constructor for class graph.RTextLine
Instantiate the class.
RTextLine(Component) - Constructor for class graph.RTextLine
Instantiate the class.
RTextLine(String, Font) - Constructor for class graph.RTextLine
Instantiate the class
RTextLine(String, Font, Color, int) - Constructor for class graph.RTextLine
Instantiate the class
RTextLine(String, Color) - Constructor for class graph.RTextLine
Instantiate the class
RTextLine(Font, Color, int, int) - Constructor for class graph.RTextLine
Instantiate the class
RTextLine(Font, Color, int) - Constructor for class graph.RTextLine
Instantiate the class
RTHBIT_ID1 - Static variable in interface hep.lcio.event.LCIO
 
RTHPBIT_ID1 - Static variable in interface hep.lcio.event.LCIO
 
RTHZBIT_ID1 - Static variable in interface hep.lcio.event.LCIO
 
run() - Method in class graph.LoadData
The method to be run as a seperate thread.
run(Matrix) - Method in interface jhplot.math.pca.covmatrixevd.CovarianceMatrixEVDCalculator
Calculate covariance matrix of the given data
run(Matrix) - Method in class jhplot.math.pca.covmatrixevd.EVDBased
 
run(Matrix) - Method in class jhplot.math.pca.covmatrixevd.SVDBased
 
run(double[]) - Method in class jhplot.stat.BunchingParameters
Collect information about sampling.
run(double[]) - Method in class jhplot.stat.FactorialMoments
Collect information about sampling.
run(boolean) - Method in class jhplot.stat.limit.StatConfidence
Run limit calculations.
run() - Method in class jminhep.algorithms.FuzzyCMeansAlg
Run classic Fuzzy C-Means clustering algorithm: Calculate the cluster centers.
run() - Method in class jminhep.algorithms.HierarchicalAlg
 
run() - Method in class jminhep.algorithms.KMeansAlg
Run classic K-Means clustering algorithm.
run(int) - Method in class jminhep.algorithms.KMeansAlg
Runs the k-means several iterations to find best seed values Only iteration with the best compactness is taken.
run() - Method in class jminhep.algorithms.KMeansExchangeAlg
 
Run(int) - Static method in class jminhep.clcontrol.Analyse
Main method to run clustering: Imod=1 - visual mode Imod=0 - mode for batch (no graphics)
run(int) - Method in class jminhep.cluster.Partition
Main method to run cluster algorithm
run(JSurface) - Static method in class jplot3d.draw.DrawContour
Creates a density plot
run(JSurface) - Static method in class jplot3d.draw.DrawDensity
Creates a density plot
run(JSurface) - Static method in class jplot3d.draw.DrawEmpty
Creates a surface plot
run(JSurface) - Static method in class jplot3d.draw.DrawH2D
Creates a bar plot for histogam.
run(JSurface) - Static method in class jplot3d.draw.DrawP2D
Creates scatter plot for P2D.
run(JSurface) - Static method in class jplot3d.draw.DrawP3D
Creates scatter plot for P3D.
run(int, float, float, float, float, float, float, JSurface) - Static method in class jplot3d.draw.DrawPlain
what =1,2,3,4 - vertical walls what =0 top
run(int, float, float, float, float, float, float, Color, int, JSurface) - Static method in class jplot3d.draw.DrawPlain2
Olso set color and pen what =1,2,3,4 - vertical walls what =0 top
run(JSurface) - Static method in class jplot3d.draw.DrawSurface
Creates a surface plot
run(JSurface) - Static method in class jplot3d.draw.DrawWireframe
Creates a surface plot
run() - Method in class org.apache.commons.io.input.Tailer
Follows changes in the file, calling the TailerListener's handle method for each new line.
run() - Method in class org.apache.commons.io.monitor.FileAlterationMonitor
Runs this monitor.
run() - Method in class org.apache.commons.math3.ml.neuralnet.sofm.KohonenTrainingTask
run(Stack) - Method in class org.lsmp.djep.djep.Diff
Should never be evaluated!
run(Stack) - Method in class org.lsmp.djep.groupJep.function.GAdd
Calculates the result of applying the "+" operator to the arguments from the stack and pushes it back on the stack.
run(Stack) - Method in class org.lsmp.djep.groupJep.function.GComparative
 
run(Stack) - Method in class org.lsmp.djep.groupJep.function.GDivide
Calculates the result of applying the "/" operator to the arguments from the stack and pushes it back on the stack.
run(Stack) - Method in class org.lsmp.djep.groupJep.function.GList
 
run(Stack) - Method in class org.lsmp.djep.groupJep.function.GLogical
 
run(Stack) - Method in class org.lsmp.djep.groupJep.function.GMod
Calculates the result of applying the "+" operator to the arguments from the stack and pushes it back on the stack.
run(Stack) - Method in class org.lsmp.djep.groupJep.function.GMultiply
Calculates the result of applying the "*" operator to the arguments from the stack and pushes it back on the stack.
run(Stack) - Method in class org.lsmp.djep.groupJep.function.GNot
 
run(Stack) - Method in class org.lsmp.djep.groupJep.function.GPower
Calculates the result of applying the "+" operator to the arguments from the stack and pushes it back on the stack.
run(Stack) - Method in class org.lsmp.djep.groupJep.function.GSubtract
Calculates the result of applying the "+" operator to the arguments from the stack and pushes it back on the stack.
run(Stack) - Method in class org.lsmp.djep.groupJep.function.GUMinus
Calculates the result of applying the "+" operator to the arguments from the stack and pushes it back on the stack.
run(Stack) - Method in class org.lsmp.djep.jama.Inverse
 
run(Stack) - Method in class org.lsmp.djep.jama.Rank
 
run(Stack) - Method in class org.lsmp.djep.jama.Solve
 
run(Stack) - Method in class org.lsmp.djep.matrixJep.function.MAssign
The run method should not be called.
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.Determinant
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.Diagonal
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.Ele
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.ElementComparative
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.ExteriorProduct
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.GetDiagonal
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.Id
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.Length
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.MDivide
Need to redo this as the standard jep version assumes commutivity.
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.MDot
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.MMultiply
need to redo this as the standard jep version assumes commutivity.
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.Size
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.Trace
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.Transpose
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.VEle
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.VList
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.VPower
 
run(Stack) - Method in class org.lsmp.djep.vectorJep.function.VSum
 
run(Stack) - Method in class org.lsmp.djep.xjep.Eval
Should not be called by evaluator
run(Stack) - Method in class org.lsmp.djep.xjep.function.FromBase
 
run(Stack) - Method in class org.lsmp.djep.xjep.function.SumType
run method.
run(Stack) - Method in class org.lsmp.djep.xjep.function.ToBase
 
run(Stack) - Method in class org.lsmp.djep.xjep.MacroFunction
Calculates the value of the expression.
run(String[]) - Method in class org.lsmp.djepExamples.Console
The main entry point with command line arguments
run(Stack) - Method in class org.nfunk.jep.function.Abs
 
run(Stack) - Method in class org.nfunk.jep.function.Add
Calculates the result of applying the "+" operator to the arguments from the stack and pushes it back on the stack.
run(Stack) - Method in class org.nfunk.jep.function.ArcCosine
 
run(Stack) - Method in class org.nfunk.jep.function.ArcCosineH
 
run(Stack) - Method in class org.nfunk.jep.function.ArcSine
 
run(Stack) - Method in class org.nfunk.jep.function.ArcSineH
 
run(Stack) - Method in class org.nfunk.jep.function.ArcTangent
 
run(Stack) - Method in class org.nfunk.jep.function.ArcTangent2
 
run(Stack) - Method in class org.nfunk.jep.function.ArcTanH
 
run(Stack) - Method in class org.nfunk.jep.function.Arg
 
run(Stack) - Method in class org.nfunk.jep.function.Binomial
 
run(Stack) - Method in class org.nfunk.jep.function.Ceil
 
run(Stack) - Method in class org.nfunk.jep.function.Comparative
 
run(Stack) - Method in class org.nfunk.jep.function.ComplexPFMC
 
run(Stack) - Method in class org.nfunk.jep.function.Conjugate
 
run(Stack) - Method in class org.nfunk.jep.function.Cosine
 
run(Stack) - Method in class org.nfunk.jep.function.CosineH
 
run(Stack) - Method in class org.nfunk.jep.function.Cross
 
run(Stack) - Method in class org.nfunk.jep.function.Divide
 
run(Stack) - Method in class org.nfunk.jep.function.Dot
 
run(Stack) - Method in class org.nfunk.jep.function.Ele
 
run(Stack) - Method in class org.nfunk.jep.function.Exp
 
run(Stack) - Method in class org.nfunk.jep.function.Floor
 
run(Stack) - Method in class org.nfunk.jep.function.Imaginary
 
run(Stack) - Method in class org.nfunk.jep.function.List
 
run(Stack) - Method in class org.nfunk.jep.function.Logarithm
 
run(Stack) - Method in class org.nfunk.jep.function.Logical
 
run(Stack) - Method in class org.nfunk.jep.function.Modulus
 
run(Stack) - Method in class org.nfunk.jep.function.Multiply
 
run(Stack) - Method in class org.nfunk.jep.function.NaturalLogarithm
 
run(Stack) - Method in class org.nfunk.jep.function.Not
 
run(Stack) - Method in class org.nfunk.jep.function.Polar
 
run(Stack) - Method in class org.nfunk.jep.function.PostfixMathCommand
Throws an exception because this method should never be called under normal circumstances.
run(Stack) - Method in interface org.nfunk.jep.function.PostfixMathCommandI
Run the function on the stack.
run(Stack) - Method in class org.nfunk.jep.function.Power
 
run(Stack) - Method in class org.nfunk.jep.function.Random
 
run(Stack) - Method in class org.nfunk.jep.function.Range
 
run(Stack) - Method in class org.nfunk.jep.function.Real
 
run(Stack) - Method in class org.nfunk.jep.function.Round
 
run(Stack) - Method in class org.nfunk.jep.function.Sine
 
run(Stack) - Method in class org.nfunk.jep.function.SineH
 
run(Stack) - Method in class org.nfunk.jep.function.SquareRoot
Applies the function to the parameters on the stack.
run(Stack) - Method in class org.nfunk.jep.function.Str
 
run(Stack) - Method in class org.nfunk.jep.function.Subtract
 
run(Stack) - Method in class org.nfunk.jep.function.Sum
Calculates the result of summing up all parameters, which are assumed to be of the Double type.
run(Stack) - Method in class org.nfunk.jep.function.Tangent
 
run(Stack) - Method in class org.nfunk.jep.function.TanH
 
run(Stack) - Method in class org.nfunk.jep.function.UMinus
 
run() - Method in class org.nfunk.jepexamples.ThreadTestThread
 
runBest() - Method in class jminhep.algorithms.FuzzyCMeansAlg
Runs for the best estimate
runBest() - Method in class jminhep.algorithms.HierarchicalAlg
 
runBest() - Method in class jminhep.algorithms.KMeansExchangeAlg
 
RunCommandHandler - Class in hep.lcio.util
 
RunCommandHandler() - Constructor for class hep.lcio.util.RunCommandHandler
 
rungeKutta2(double[], F1D, double) - Static method in class jhplot.math.Numeric
Uses the 2nd order Runge-Kutta method to solve an ODE.
rungeKutta4(double[], F1D, double) - Static method in class jhplot.math.Numeric
Uses the 4th order Runge-Kutta method to solve an ODE.
RungeKuttaFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements the common part of all fixed step Runge-Kutta integrators for Ordinary Differential Equations.
RungeKuttaIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the common part of all fixed step Runge-Kutta integrators for Ordinary Differential Equations.
runjava - Static variable in interface jminhep.gui.Constants
 
runKM() - Method in class jminhep.algorithms.KMeansAlg
Classic K-Means clustering algorithm.
runLower() - Method in class jhplot.stat.limit.StatConfidence
Run limit calculations for lower limit.
runTest() - Method in class org.nfunk.jeptesting.JEPTest
Runs the test.
runUpper() - Method in class jhplot.stat.limit.StatConfidence
Run limit calculations for upper limit.
rw - Variable in class jhplot.io.HDataBase
 
rx - Variable in class Jampack.Zmat
The upper row index
rxy() - Method in class hep.physics.vec.SpacePoint
Cylindrical r
rxy() - Method in class hephysics.vec.SpacePoint
Cylindrical r
rxyz() - Method in class hep.physics.vec.SpacePoint
Spherical r
rxyz() - Method in class hephysics.vec.SpacePoint
Spherical r

S

s - Static variable in class cern.clhep.Units
 
S - Variable in class Jampack.Zsvd
The diagonal matrix of singular values
S1Point - Class in org.apache.commons.math3.geometry.spherical.oned
This class represents a point on the 1-sphere.
S1Point(double) - Constructor for class org.apache.commons.math3.geometry.spherical.oned.S1Point
Simple constructor.
S2Point - Class in org.apache.commons.math3.geometry.spherical.twod
This class represents a point on the 2-sphere.
S2Point(double, double) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.S2Point
Simple constructor.
S2Point(Vector3D) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.S2Point
Simple constructor.
S_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
S_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
S_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
S_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
SaddlePoint - Class in jhplot.math.num.pdf
Utility class used by various distributions to accurately compute their respective probability mass functions.
SaddlePoint() - Constructor for class jhplot.math.num.pdf.SaddlePoint
Default constructor.
SAFE_MIN - Static variable in class org.apache.commons.math3.util.Precision
Safe minimum, such that 1 / SAFE_MIN does not overflow.
safeNorm(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Returns the Cartesian norm (2-norm), handling both overflow and underflow.
sameOrientationAs(Hyperplane<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Check if the instance has the same orientation as another hyperplane.
sameOrientationAs(Hyperplane<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Check if the instance has the same orientation as another hyperplane.
sameOrientationAs(Hyperplane<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Check if the instance has the same orientation as another hyperplane.
sameOrientationAs(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Check if the instance has the same orientation as another hyperplane.
sameOrientationAs(Hyperplane<Sphere1D>) - Method in class org.apache.commons.math3.geometry.spherical.oned.LimitAngle
Check if the instance has the same orientation as another hyperplane.
sameOrientationAs(Hyperplane<Sphere2D>) - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Check if the instance has the same orientation as another hyperplane.
sample(int, double, double) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a randomly sampled matrix with the given shape.
sample(int, int, double, double) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a randomly sampled matrix with the given shape.
sample(DoubleMatrix2D, double, double) - Method in class cern.colt.matrix.DoubleFactory2D
Modifies the given matrix to be a randomly sampled matrix.
sample(int, boolean, RandomEngine, DoubleBuffer) - Method in class cern.hep.aida.bin.DynamicBin1D
Uniformly samples (chooses) n random elements with or without replacement from the contained elements and adds them to the given buffer.
sample(long, long, int, long, long[], int, RandomEngine) - Static method in class cern.jet.random.sampling.RandomSampler
Efficiently computes a sorted random set of count elements from the interval [low,low+N-1].
sample(UnivariateFunction, double, double, int) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Samples the specified univariate real function on the specified interval.
sample() - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
Generate a random value sampled from this distribution.
sample(int) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
Generate a random sample from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.AbstractMultivariateRealDistribution
Generates a random value vector sampled from this distribution.
sample(int) - Method in class org.apache.commons.math3.distribution.AbstractMultivariateRealDistribution
Generates a list of a random value vectors from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Generate a random value sampled from this distribution.
sample(int) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Generate a random sample from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.ConstantRealDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.EnumeratedDistribution
Generate a random value sampled from this distribution.
sample(int) - Method in class org.apache.commons.math3.distribution.EnumeratedDistribution
Generate a random sample from the distribution.
sample(int, T[]) - Method in class org.apache.commons.math3.distribution.EnumeratedDistribution
Generate a random sample from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.EnumeratedRealDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.GammaDistribution
This implementation uses the following algorithms:
sample() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Generate a random value sampled from this distribution.
sample(int) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Generate a random sample from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Generates a random value vector sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Generates a random value vector sampled from this distribution.
sample() - Method in interface org.apache.commons.math3.distribution.MultivariateRealDistribution
Generates a random value vector sampled from this distribution.
sample(int) - Method in interface org.apache.commons.math3.distribution.MultivariateRealDistribution
Generates a list of a random value vectors from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.ParetoDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Generate a random value sampled from this distribution.
sample() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Generate a random value sampled from this distribution.
sample(int) - Method in interface org.apache.commons.math3.distribution.RealDistribution
Generate a random sample from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Generate a random value sampled from this distribution.
sampleArray(int, int[]) - Static method in class cern.jet.random.sampling.RandomSamplingAssistant
Just shows how this class can be used; samples n elements from and int[] array.
sampleBootstrap(DynamicBin1D, int, RandomEngine, BinBinFunction1D) - Method in class cern.hep.aida.bin.DynamicBin1D
Generic bootstrap resampling.
sampleFunction2D(Function2D, double, double, int, Comparable) - Static method in class org.jfree.data.general.DatasetUtilities
Creates an XYDataset by sampling the specified function over a fixed range.
sampleFunction2DToSeries(Function2D, double, double, int, Comparable) - Static method in class org.jfree.data.general.DatasetUtilities
Creates an XYSeries by sampling the specified function over a fixed range.
sampleKurtosis(int, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample kurtosis (aka excess) of a data sequence.
sampleKurtosis(DoubleArrayList, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample kurtosis (aka excess) of a data sequence.
sampleKurtosisStandardError(int) - Static method in class cern.jet.stat.Descriptive
Return the standard error of the sample kurtosis.
sampleNextElement() - Method in class cern.jet.random.sampling.RandomSamplingAssistant
Returns whether the next element of the input sequence shall be sampled (picked) or not.
sampleNextElement() - Method in class cern.jet.random.sampling.WeightedRandomSampler
Chooses exactly one random element from successive blocks of weight input elements each.
SampleRun - Class in jhplot.math.pca
An example program using the library
SampleRun() - Constructor for class jhplot.math.pca.SampleRun
 
sampleSkew(int, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample skew of a data sequence.
sampleSkew(DoubleArrayList, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample skew of a data sequence.
sampleSkewStandardError(int) - Static method in class cern.jet.stat.Descriptive
Return the standard error of the sample skew.
sampleStandardDeviation(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample standard deviation.
sampleVariance(int, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample variance of a data sequence.
sampleVariance(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample variance of a data sequence.
sampleWeightedVariance(double, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample weighted variance of a data sequence.
SamplingXYLineRenderer - Class in org.jfree.chart.renderer.xy
A renderer that draws line charts.
SamplingXYLineRenderer() - Constructor for class org.jfree.chart.renderer.xy.SamplingXYLineRenderer
Creates a new renderer.
SamplingXYLineRenderer.State - Class in org.jfree.chart.renderer.xy
Records the state for the renderer.
save() - Static method in class jhepsim.Options
Saves the actual content of the options db to persistent file.
save() - Method in class jplot.SimpleEditor
Saves the text after an edit to the current file.
save(String) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
save(String) - Method in class org.jlab.groot.ui.TCanvas
 
SAVE_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Save action command.
saveAs() - Method in class jplot.SimpleEditor
Saves the text after an edit to a new file.
saveChartAsJPEG(File, JFreeChart, int, int) - Static method in class org.jfree.chart.ChartUtilities
Saves a chart to a file in JPEG format.
saveChartAsJPEG(File, float, JFreeChart, int, int) - Static method in class org.jfree.chart.ChartUtilities
Saves a chart to a file in JPEG format.
saveChartAsJPEG(File, JFreeChart, int, int, ChartRenderingInfo) - Static method in class org.jfree.chart.ChartUtilities
Saves a chart to a file in JPEG format.
saveChartAsJPEG(File, float, JFreeChart, int, int, ChartRenderingInfo) - Static method in class org.jfree.chart.ChartUtilities
Saves a chart to a file in JPEG format.
saveChartAsJPEG(JFreeChart, int, int, HttpSession) - Static method in class org.jfree.chart.servlet.ServletUtilities
Saves the chart as a JPEG format file in the temporary directory.
saveChartAsJPEG(JFreeChart, int, int, ChartRenderingInfo, HttpSession) - Static method in class org.jfree.chart.servlet.ServletUtilities
Saves the chart as a JPEG format file in the temporary directory and populates the ChartRenderingInfo object which can be used to generate an HTML image map.
saveChartAsPDF(File, JFreeChart, int, int, FontMapper) - Static method in class jminhep.gui.MainFrame
 
saveChartAsPNG(File, JFreeChart, int, int) - Static method in class org.jfree.chart.ChartUtilities
Saves a chart to the specified file in PNG format.
saveChartAsPNG(File, JFreeChart, int, int, ChartRenderingInfo) - Static method in class org.jfree.chart.ChartUtilities
Saves a chart to a file in PNG format.
saveChartAsPNG(File, JFreeChart, int, int, ChartRenderingInfo, boolean, int) - Static method in class org.jfree.chart.ChartUtilities
Saves a chart to a file in PNG format.
saveChartAsPNG(JFreeChart, int, int, HttpSession) - Static method in class org.jfree.chart.servlet.ServletUtilities
Saves the chart as a PNG format file in the temporary directory.
saveChartAsPNG(JFreeChart, int, int, ChartRenderingInfo, HttpSession) - Static method in class org.jfree.chart.servlet.ServletUtilities
Saves the chart as a PNG format file in the temporary directory and populates the ChartRenderingInfo object which can be used to generate an HTML image map.
saveImage(String) - Method in class jplot3dp.ModelView
 
saveToFile(boolean) - Method in class jplot3dp.MainComponent
 
scalarAdd(T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Increment each entry of this matrix.
scalarAdd(double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of adding d to each entry of this.
scalarAdd(T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Increment each entry of this matrix.
scalarAdd(double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the result of adding d to each entry of this.
scalarAdd(T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Increment each entry of this matrix.
scalarAdd(double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of adding d to each entry of this.
scalarMultiply(double, double[]) - Static method in class jhplot.math.ArrayMathUtils
Multiplies every component of an array by a scalar.
scalarMultiply(double, int[]) - Static method in class jhplot.math.ArrayMathUtils
Multiplies every component of an array by a scalar.
scalarMultiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Multiply the instance by a scalar.
scalarMultiply(T) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Multiply the instance by a scalar.
scalarMultiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Multiply the instance by a scalar.
scalarMultiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Multiply the instance by a scalar.
scalarMultiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Multiply the instance by a scalar.
scalarMultiply(double) - Method in interface org.apache.commons.math3.geometry.Vector
Multiply the instance by a scalar.
scalarMultiply(T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Multiply each entry by d.
scalarMultiply(double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of multiplying each entry of this by d.
scalarMultiply(T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Multiply each entry by d.
scalarMultiply(double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the result of multiplying each entry of this by d.
scalarMultiply(T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Multiply each entry by d.
scalarMultiply(double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of multiplying each entry of this by d.
scalarMultiplyFast(double, double[]) - Static method in class jhplot.math.ArrayMathUtils
Fast scalar multiplication for sparse arrays.
scalarMultiplyFast(double, int[]) - Static method in class jhplot.math.ArrayMathUtils
Fast scalar multiplication for sparse arrays.
scalarProduct(double[], double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the scalar product of two array as if they were vectors.
scalarProduct(double[][], double[][]) - Static method in class jhplot.math.ArrayMathUtils
Computes the scalar product of two array as if they were matrices.
scalarProduct(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the scalar product of two array as if they were vectors.
scalarProduct(int[][], int[][]) - Static method in class jhplot.math.ArrayMathUtils
Computes the scalar product of two array as if they were matrices.
scalb(float, int) - Static method in class net.jafama.FastMath
Precision may be lost if the result is subnormal.
scalb(double, int) - Static method in class net.jafama.FastMath
Precision may be lost if the result is subnormal.
scalb(float, int) - Static method in class net.jafama.StrictFastMath
Precision may be lost if the result is subnormal.
scalb(double, int) - Static method in class net.jafama.StrictFastMath
Precision may be lost if the result is subnormal.
scalb(int) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Multiply the instance by a power of 2.
scalb(int) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Multiply the instance by a power of 2.
scalb(int) - Method in class org.apache.commons.math3.dfp.Dfp
Multiply the instance by a power of 2.
scalb(int) - Method in interface org.apache.commons.math3.RealFieldElement
Multiply the instance by a power of 2.
scalb(int) - Method in class org.apache.commons.math3.util.Decimal64
Multiply the instance by a power of 2.
scalb(double, int) - Static method in class org.apache.commons.math3.util.FastMath
Multiply a double number by a power of 2.
scalb(float, int) - Static method in class org.apache.commons.math3.util.FastMath
Multiply a float number by a power of 2.
scale - Variable in class graph.VectorSet
This is the scaling to be used when drawing vectors.
scale(String, double) - Method in class jhplot.H1D
Scale the histogram.
scale(double) - Method in class jhplot.H1D
Scale the histogram.
scale(String, double) - Method in class jhplot.H2D
Scale the histogram.
scale(double) - Method in class jhplot.H2D
Scale the histogram.
scale(String, double) - Method in class jhplot.HProf1D
Scale the histogram.
scale(double) - Method in class jhplot.HProf1D
Scale the histogram.
scale(int, double) - Method in class jhplot.stat.DataKeeper
Scale values and errors by a factor
scale(double) - Method in class jhplot.stat.DataKeeper
Scale all values and errors by a factor
scale(double, double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Create a copy of an array scaled by a value.
scale(Rectangle2D) - Method in class org.jfree.chart.ChartPanel
Applies any scaling that is in effect for the chart drawing to the given rectangle.
scale(double, double) - Method in class org.jfree.chart.fx.FXGraphics2D
Applies a scale transformation.
scale(Range, double) - Static method in class org.jfree.data.Range
Scales the range by the specified factor.
SCALE_AREA_TO_1 - Static variable in class org.jfree.data.statistics.HistogramType
Scale area to one.
SCALE_BOX_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
SCALE_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
SCALE_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
SCALE_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
SCALE_ON_BOTH_AXES - Static variable in class org.jfree.chart.renderer.xy.XYBubbleRenderer
A constant to specify that the bubbles drawn by this renderer should be scaled on both axes (see XYBubbleRenderer.XYBubbleRenderer(int)).
SCALE_ON_DOMAIN_AXIS - Static variable in class org.jfree.chart.renderer.xy.XYBubbleRenderer
A constant to specify that the bubbles drawn by this renderer should be scaled on the domain axis (see XYBubbleRenderer.XYBubbleRenderer(int)).
SCALE_ON_RANGE_AXIS - Static variable in class org.jfree.chart.renderer.xy.XYBubbleRenderer
A constant to specify that the bubbles drawn by this renderer should be scaled on the range axis (see XYBubbleRenderer.XYBubbleRenderer(int)).
SCALE_PDF_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
SCALE_PDF_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
scaleArray(double[], double) - Static method in class org.apache.commons.math3.transform.TransformUtils
Multiply every component in the given real array by the given real number.
scaleArray(Complex[], double) - Static method in class org.apache.commons.math3.transform.TransformUtils
Multiply every component in the given complex array by the given real number.
scaleErrors(double) - Method in class jhplot.H1D
Rescale errors by a some factor.
scaleInPlace(double, double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Multiply each element of an array by a value.
SCALEPDF_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
SCALEPDF_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
SCALEPDF_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
SCALEPDF_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
SCALEPDF_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
scalePxPyPzE(double) - Method in class hephysics.particle.LParticle
Scale all components (Px,Py,Px,E) by a factor C.
Scaler - Class in org.lsmp.djep.vectorJep.values
Degenerate i.e.
scaleXYZT(double) - Method in class hephysics.particle.LParticle
Scale all components (X,Y,Z,T) by a factor This means all components are multiplied by this factor.
scalingFrame - Variable in class jplot.GraphGeneral
 
scalingFrameX - Variable in class jplot.GraphGeneral
 
scalingFrameY - Variable in class jplot.GraphGeneral
 
ScalingPanel() - Method in class jplot.JPlot
 
scan(int) - Method in class org.freehep.math.minuit.MnScan
 
scan(int, int) - Method in class org.freehep.math.minuit.MnScan
 
scan(int, int, double, double) - Method in class org.freehep.math.minuit.MnScan
Scans the value of the user function by varying parameter number par, leaving all other parameters fixed at the current value.
ScanString - Class in graph
This class is similar to the ScanWord class, except it scans a string for keywords rather than an input stream.
ScanString() - Constructor for class graph.ScanString
Instantiate the Class
ScanString(String) - Constructor for class graph.ScanString
Instantaite the Class
scanTree(String, String, int, boolean) - Method in class org.jlab.groot.tree.Tree
Scan a tree with expressions defined in expression string, multiple expressions are separated by ":".
scanTreeItem(TreePath) - Method in class org.jlab.groot.studio.StudioUI
 
scanTreeItemH2F(TreePath) - Method in class org.jlab.groot.studio.StudioUI
 
ScanWord - Class in graph
This class extends the StreamTokenizer class.
ScanWord(InputStream) - Constructor for class graph.ScanWord
Instantiate the class with the parsed input stream.
ScatterRenderer - Class in org.jfree.chart.renderer.category
A renderer that handles the multiple values from a MultiValueCategoryDataset by plotting a shape for each value for each given item in the dataset.
ScatterRenderer() - Constructor for class org.jfree.chart.renderer.category.ScatterRenderer
Constructs a new renderer.
Schur - Class in Jampack
Schur implements the Schur decomposition of a matrix.
Schur(Zmat) - Constructor for class Jampack.Schur
Creats a Schur decomposition from a square Zmat.
SCIENTIFIC - Static variable in class graph.TextLine
Format to use when parsing a double
SCJet - Class in hephysics.jet
SCJet is an implementation of the longitudinally-invariant kT, anti-KT and Cambridge/Aachen clustering algorithms.
SCJet(double, int, int, double, boolean) - Constructor for class hephysics.jet.SCJet
Initialize calculations of the longitudinally invariant kT algorithm in inclusive mode.
SCJet(double, int, int, double) - Constructor for class hephysics.jet.SCJet
Initialize calculations of the longitudinally invariant kT algorithm in inclusive mode.
SCJet(double, double) - Constructor for class hephysics.jet.SCJet
Initialize calculations of the kT algorithm.
score(List<? extends Cluster<T>>) - Method in class org.apache.commons.math3.ml.clustering.evaluation.ClusterEvaluator
Computes the evaluation score for the given list of clusters.
score(List<? extends Cluster<T>>) - Method in class org.apache.commons.math3.ml.clustering.evaluation.SumOfClusterVariances
Computes the evaluation score for the given list of clusters.
ScrollHandlerFX - Class in org.jfree.chart.fx.interaction
Handles scroll events (mouse wheel etc) on a ChartCanvas.
ScrollHandlerFX(String) - Constructor for class org.jfree.chart.fx.interaction.ScrollHandlerFX
Creates a new instance with the specified ID.
search(double) - Method in class jhplot.P0D
Search for the first occurrence of the given argument
search(int) - Method in class jhplot.P0I
Search for the first occurrence of the given argument
search(double[], double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.LineSearch
Finds the number alpha that optimizes f(startPoint + alpha * direction).
search(UnivariateFunction, GoalType, double, double) - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
Search new points that bracket a local optimum of the function.
search(UnivariateFunction, GoalType, double, double) - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.
Search new points that bracket a local optimum of the function.
searchForFitnessUpdate(Population) - Method in class org.apache.commons.math3.genetics.Chromosome
Searches the population for a chromosome representing the same solution, and if it finds one, updates the fitness to its value.
SearchInterval - Class in org.apache.commons.math3.optim.univariate
Search interval and (optional) start value.
SearchInterval(double, double, double) - Constructor for class org.apache.commons.math3.optim.univariate.SearchInterval
 
SearchInterval(double, double) - Constructor for class org.apache.commons.math3.optim.univariate.SearchInterval
 
searchReplace(String, String, String) - Static method in class org.jfree.chart.servlet.ServletUtilities
Perform a search/replace operation on a String There are String methods to do this since (JDK 1.4)
sec(double) - Method in class jhplot.math.ValueErr
Secant
SEC - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
SecantRootFinder - Class in jhplot.math.num.root
The secant method (1) for finding roots of functions.
SecantRootFinder(Function) - Constructor for class jhplot.math.num.root.SecantRootFinder
Create a root finder for the given function.
SecantRootFinder(Function, int, double) - Constructor for class jhplot.math.num.root.SecantRootFinder
Create a root finder for the given function.
SecantSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Secant method for root-finding (approximating a zero of a univariate real function).
SecantSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.SecantSolver
Construct a solver with default accuracy (1e-6).
SecantSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.SecantSolver
Construct a solver.
SecantSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.SecantSolver
Construct a solver.
sech(double) - Method in class jhplot.math.ValueErr
Hyperbolic secant
SECH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
second - Static variable in class cern.clhep.Units
 
second - Variable in class org.freehep.math.minuit.Point
 
SECOND - Static variable in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of version 1.0.13, use DateTickUnitType instead.
SECOND - Static variable in class org.jfree.chart.axis.DateTickUnitType
Second.
Second - Class in org.jfree.data.time
Represents a second in a particular day.
Second() - Constructor for class org.jfree.data.time.Second
Constructs a new Second, based on the system date/time.
Second(int, Minute) - Constructor for class org.jfree.data.time.Second
Constructs a new Second.
Second(int, int, int, int, int, int) - Constructor for class org.jfree.data.time.Second
Creates a new second.
Second(Date) - Constructor for class org.jfree.data.time.Second
Constructs a new instance from the specified date/time and the default time zone..
Second(Date, TimeZone) - Constructor for class org.jfree.data.time.Second
Deprecated.
As of 1.0.13, use the constructor that specifies the locale also.
Second(Date, TimeZone, Locale) - Constructor for class org.jfree.data.time.Second
Creates a new second based on the supplied time and time zone.
SecondaryEquations - Interface in org.apache.commons.math3.ode
This interface allows users to add secondary differential equations to a primary set of differential equations.
secondMaxVal - Variable in class jhplot.stat.JointProbabilityState
 
SecondMoment - Class in org.apache.commons.math3.stat.descriptive.moment
Computes a statistic related to the Second Central Moment.
SecondMoment() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Create a SecondMoment instance
SecondMoment(SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Copy constructor, creates a new SecondMoment identical to the original
SecondOrderDifferentialEquations - Interface in org.apache.commons.math3.ode
This interface represents a second order differential equations set.
SecondOrderIntegrator - Interface in org.apache.commons.math3.ode
This interface represents a second order integrator for differential equations.
secondProbMap - Variable in class jhplot.stat.JointProbabilityState
 
seconds() - Method in class cern.colt.Timer
Returns the elapsed time in seconds; does not stop the timer, if started.
SECONDS - Static variable in class jhplot.JHPlot
 
SEditor - Class in fitter
 
SEditor(JFrame, Fitter) - Constructor for class fitter.SEditor
 
SEED - Static variable in class jminhep.gui.SetEnv
 
Seeds() - Static method in class jminhep.clcontrol.Display
Show seeds
seek(long) - Method in class jhplot.math.io.LERandomAccessFile
 
Segment - Class in org.apache.commons.math3.geometry.euclidean.threed
Simple container for a two-points segment.
Segment(Vector3D, Vector3D, Line) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Segment
Build a segment.
Segment - Class in org.apache.commons.math3.geometry.euclidean.twod
Simple container for a two-points segment.
Segment(Vector2D, Vector2D, Line) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Segment
Build a segment.
SegmentedTimeline - Class in org.jfree.chart.axis
A Timeline that implements a "segmented" timeline with included, excluded and exception segments.
SegmentedTimeline(long, int, int) - Constructor for class org.jfree.chart.axis.SegmentedTimeline
Constructs a new segmented timeline, optionaly using another segmented timeline as its base.
SegmentedTimeline.Segment - Class in org.jfree.chart.axis
Internal class to represent a valid segment for this timeline.
select(Population) - Method in interface org.apache.commons.math3.genetics.SelectionPolicy
Select two chromosomes from the population.
select(Population) - Method in class org.apache.commons.math3.genetics.TournamentSelection
Select two chromosomes from the population.
select(double[], int[], int) - Method in class org.apache.commons.math3.util.KthSelector
Select Kth value in the array.
SelectCommandHandler - Class in hep.lcio.util
CommandHandler for the select command.
SelectCommandHandler() - Constructor for class hep.lcio.util.SelectCommandHandler
 
selectFarthest(Iterable<P>, EnclosingBall<S, P>) - Method in class org.apache.commons.math3.geometry.enclosing.WelzlEncloser
Select the point farthest to the current ball.
SelectionPolicy - Interface in org.apache.commons.math3.genetics
Algorithm used to select a chromosome pair from a population.
SELF_INVERSE - Static variable in class org.lsmp.djep.xjep.XOperator
self inverse operators like -(-x) !(!x)
seLocation(double, double) - Method in class jhplot.HMLabel
Sets the location of this label in data coordinates.
SEMI - Static variable in interface org.nfunk.jep.ParserConstants
 
semiBandwidth(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Returns the semi-bandwidth of the given square matrix A.
SEMICOLON - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
SemiVariance - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the semivariance of a set of values with respect to a given cutoff value.
SemiVariance() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with default (true) biasCorrected property and default (Downside) varianceDirection property.
SemiVariance(boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with the specified biasCorrected property and default (Downside) varianceDirection property.
SemiVariance(SemiVariance.Direction) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with the specified Direction property and default (true) biasCorrected property
SemiVariance(boolean, SemiVariance.Direction) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with the specified isBiasCorrected property and the specified Direction property.
SemiVariance(SemiVariance) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Copy constructor, creates a new SemiVariance identical to the original
SemiVariance.Direction - Enum in org.apache.commons.math3.stat.descriptive.moment
The direction of the semivariance - either upside or downside.
sendTempFile(String, HttpServletResponse) - Static method in class org.jfree.chart.servlet.ServletUtilities
Binary streams the specified file in the temporary directory to the HTTP response in 1KB chunks.
sendTempFile(File, HttpServletResponse) - Static method in class org.jfree.chart.servlet.ServletUtilities
Binary streams the specified file to the HTTP response in 1KB chunks.
sendTempFile(File, HttpServletResponse, String) - Static method in class org.jfree.chart.servlet.ServletUtilities
Binary streams the specified file to the HTTP response in 1KB chunks.
separatorsToSystem(String) - Static method in class org.apache.commons.io.FilenameUtils
Converts all separators to the system separator.
separatorsToUnix(String) - Static method in class org.apache.commons.io.FilenameUtils
Converts all separators to the Unix separator of forward slash.
separatorsToWindows(String) - Static method in class org.apache.commons.io.FilenameUtils
Converts all separators to the Windows separator of backslash.
sepField - Variable in class jhplot.utils.GHFontChooser
 
SeqBlas - Class in cern.colt.matrix.linalg
Sequential implementation of the Basic Linear Algebra System.
seqBlas - Static variable in class cern.colt.matrix.linalg.SeqBlas
Little trick to allow for "aliasing", that is, renaming this class.
sequence(int, int, int) - Static method in class org.apache.commons.math3.util.MathArrays
Returns an array of size integers starting at start, skipping stride numbers.
SequenceReader - Class in org.apache.commons.io.input
Provides the contents of multiple Readers in sequence.
SequenceReader(Iterable<? extends Reader>) - Constructor for class org.apache.commons.io.input.SequenceReader
Construct a new instance with readers
SequenceReader(Reader...) - Constructor for class org.apache.commons.io.input.SequenceReader
Construct a new instance with readers
serializeAttributes(int, DatasetAttributes) - Static method in class org.jlab.groot.data.DataSetSerializer
 
Serialized - Class in jhplot.io
Methods used for serialization.
Serialized() - Constructor for class jhplot.io.Serialized
 
serializeDataAttributes(int, int, DatasetAttributes) - Static method in class org.jlab.groot.data.DataSetSerializer
 
serializeDataGroupDescriptor(DataGroupDescriptor) - Static method in class org.jlab.groot.data.DataSetSerializer
 
serializeDataSet(IDataSet) - Static method in class org.jlab.groot.data.DataSetSerializer
 
serializeF1D(Func1D) - Static method in class org.jlab.groot.data.DataSetSerializer
 
serializeGraphErrors(GraphErrors) - Static method in class org.jlab.groot.data.DataSetSerializer
 
serializeH1F(H1F) - Static method in class org.jlab.groot.data.DataSetSerializer
serialization of H1F into HipoNodes
serializeH2F(H2F) - Static method in class org.jlab.groot.data.DataSetSerializer
 
serializeRealMatrix(RealMatrix, ObjectOutputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Serialize a RealMatrix.
serializeRealVector(RealVector, ObjectOutputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Serialize a RealVector.
serialVersionUID - Static variable in class cern.colt.PersistentObject
 
serialVersionUID - Static variable in interface colt.hep.aida.IAxis
 
serialVersionUID - Static variable in interface colt.hep.aida.IHistogram
 
serialVersionUID - Static variable in class jminhep.clcontrol.ClControl
 
serialVersionUID - Static variable in class jminhep.clcontrol.TableOptions
 
serialVersionUID - Static variable in class jminhep.clcontrol.TableResults
 
serialVersionUID - Static variable in class jminhep.clcontrol.TableSettings
 
serialVersionUID - Static variable in class jminhep.gui.FontChooser.NwList
 
serialVersionUID - Static variable in class jminhep.gui.FontChooser
 
serialVersionUID - Static variable in class jminhep.gui.MainFrame
 
serialVersionUID - Static variable in class jminhep.gui.Plotter
 
serialVersionUID - Static variable in class jminhep.gui.TableSummary
 
serialVersionUID - Static variable in class org.jfree.chart.renderer.xy.XYBubbleRenderer
For serialization.
Series - Class in jhplot.math.num
This class provides the means to evaluate infinite series (1).
Series - Class in org.jfree.data.general
Base class representing a data series.
SERIES_TAG - Static variable in interface org.jfree.data.xml.DatasetTags
The 'Series' element name.
seriesChanged(SeriesChangeEvent) - Method in class org.jfree.data.gantt.TaskSeriesCollection
Called when a series belonging to the dataset changes.
seriesChanged(SeriesChangeEvent) - Method in class org.jfree.data.general.AbstractSeriesDataset
Called when a series belonging to the dataset changes.
seriesChanged(SeriesChangeEvent) - Method in interface org.jfree.data.general.SeriesChangeListener
Called when an observed series changes in some way.
seriesChanged(SeriesChangeEvent) - Method in class org.jfree.data.time.TimeSeriesTableModel
Receives notification that the time series has been changed.
seriesChanged(SeriesChangeEvent) - Method in class org.jfree.data.xy.DefaultTableXYDataset
This method receives notification when a series belonging to the dataset changes.
SeriesChangeEvent - Class in org.jfree.data.general
An event with details of a change to a series.
SeriesChangeEvent(Object) - Constructor for class org.jfree.data.general.SeriesChangeEvent
Constructs a new event.
SeriesChangeListener - Interface in org.jfree.data.general
Methods for receiving notification of changes to a data series.
SeriesDataset - Interface in org.jfree.data.general
The interface for a dataset consisting of one or many series of data.
SeriesException - Exception in org.jfree.data.general
A general purpose exception class for data series.
SeriesException(String) - Constructor for exception org.jfree.data.general.SeriesException
Constructs a new series exception.
seriesNameListFromDataArray(Object[][]) - Static method in class org.jfree.data.xy.DefaultWindDataset
Utility method for automatically generating series names.
seriesPath - Variable in class org.jfree.chart.renderer.xy.StandardXYItemRenderer.State
The path for the current series.
seriesPath - Variable in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer.State
The path for the current series.
SeriesRenderingOrder - Class in org.jfree.chart.plot
Defines the tokens that indicate the rendering order for series in a XYPlot.
service(HttpServletRequest, HttpServletResponse) - Method in class org.jfree.chart.servlet.DisplayChart
Service method.
ServletUtilities - Class in org.jfree.chart.servlet
Utility class used for servlet related JFreeChart operations.
ServletUtilities() - Constructor for class org.jfree.chart.servlet.ServletUtilities
 
set(int) - Method in class cern.colt.bitvector.BitVector
Changes the bit with index bitIndex to the "set" (true) state.
set(long[], int) - Static method in class cern.colt.bitvector.QuickBitVector
Changes the bit with index bitIndex in the bitvector bits to the "set" (true) state.
set(int, boolean) - Method in class cern.colt.list.AbstractBooleanList
Replaces the element at the specified position in the receiver with the specified element.
set(int, byte) - Method in class cern.colt.list.AbstractByteList
Replaces the element at the specified position in the receiver with the specified element.
set(int, char) - Method in class cern.colt.list.AbstractCharList
Replaces the element at the specified position in the receiver with the specified element.
set(int, double) - Method in class cern.colt.list.AbstractDoubleList
Replaces the element at the specified position in the receiver with the specified element.
set(int, float) - Method in class cern.colt.list.AbstractFloatList
Replaces the element at the specified position in the receiver with the specified element.
set(int, int) - Method in class cern.colt.list.AbstractIntList
Replaces the element at the specified position in the receiver with the specified element.
set(int, long) - Method in class cern.colt.list.AbstractLongList
Replaces the element at the specified position in the receiver with the specified element.
set(int, short) - Method in class cern.colt.list.AbstractShortList
Replaces the element at the specified position in the receiver with the specified element.
set(int, Object) - Method in class cern.colt.list.adapter.DoubleListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, Object) - Method in class cern.colt.list.adapter.FloatListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, Object) - Method in class cern.colt.list.adapter.IntListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, Object) - Method in class cern.colt.list.adapter.LongListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, Object) - Method in class cern.colt.list.adapter.ObjectListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, boolean) - Method in class cern.colt.list.BooleanArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, byte) - Method in class cern.colt.list.ByteArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, char) - Method in class cern.colt.list.CharArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, double) - Method in class cern.colt.list.DoubleArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, float) - Method in class cern.colt.list.FloatArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, int) - Method in class cern.colt.list.IntArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, long) - Method in class cern.colt.list.LongArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, Object) - Method in class cern.colt.list.ObjectArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, short) - Method in class cern.colt.list.ShortArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, double) - Method in class cern.colt.matrix.DoubleMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, int, double) - Method in class cern.colt.matrix.DoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, int, double) - Method in class cern.colt.matrix.DoubleMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int, Object) - Method in class cern.colt.matrix.ObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, int, Object) - Method in class cern.colt.matrix.ObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, int, Object) - Method in class cern.colt.matrix.ObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int, int, double) - Method in class j4np.physics.TransMatrix
 
set(int, int, double) - Method in class Jama.Matrix
Set a single element.
set(FProxy) - Method in class jhplot.F1D
Set proxy function
set - Variable in class jhplot.HChart
 
set - Variable in class jhplot.HPlot3D
 
set - Variable in class jhplot.HPlot3DP
 
set(int, int, double) - Method in class jhplot.math.kalman.jama.Matrix
Set a single element.
set(int, double) - Method in class jhplot.math.num.DoubleArray
Modify the element at the given index.
set(int, double, double) - Method in class jhplot.P1D
Sets the values of a plot-point pair (X,Y).
set(int, double, double, double, double) - Method in class jhplot.P1D
Sets the values of a plot-point pair (x,y).
set(int, double, double, double) - Method in class jhplot.P1D
Sets the values of a plot-point pair (x,y).
set(int, double, double, double, double, double, double) - Method in class jhplot.P1D
Sets the values of a plot-point pair (x,y).
set(int, double, double, double, double, double, double, double, double, double, double) - Method in class jhplot.P1D
Sets the values of a plot-point pair (x,y).
set(int, double, double, double) - Method in class jhplot.P2D
Sets the values of (x,y,z).
set(int, double, double, double, double, double, double) - Method in class jhplot.P3D
Sets the values of (x,dx,y,dy,z,dz).
set(int, double[]) - Method in class jhplot.PND
Sets (replace) the specified row.
set(int, P0D) - Method in class jhplot.PND
Sets (replace) the specified element with P0D.
set(int, int[]) - Method in class jhplot.PNI
Sets (replace) the specified row.
set(int, P0I) - Method in class jhplot.PNI
Sets (replace) the specified element with P0D.
Set(String) - Method in class jminhep.clcontrol.SummaryPad
 
set(int, double, double, int) - Method in class jminhep.cluster.Partition
Set parameters for clustering
set(String) - Method in class jplot.XMLWrite
Adds a key to a string(buffer).
set(String, Color) - Method in class jplot.XMLWrite
Adds a color setting to a string(buffer).
set(String, Font) - Method in class jplot.XMLWrite
Adds a font setting to a string(buffer).
set(String, BasicStroke) - Method in class jplot.XMLWrite
Adds a font setting to a string(buffer).
set(int, ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Set a set of consecutive elements.
set(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Set all elements to a single value.
set(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Set all elements to a single value.
set(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Set all elements to a single value.
set(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Set all elements to a single value.
set(double) - Method in class org.apache.commons.math3.linear.RealVector
Set all elements to a single value.
set(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Set all elements to a single value.
set(int, int, double) - Method in class org.freehep.math.minuit.MnUserCovariance
 
set(int) - Method in class org.jlab.groot.base.ColorPalette
 
set(double[]) - Method in class org.jlab.groot.data.DataVector
Initialize the array with given values.
set(List<Double>) - Method in class org.jlab.groot.data.DataVector
 
set(int, double) - Method in class org.jlab.groot.data.DataVector
 
set(int, double, double) - Method in class org.jlab.groot.data.H1F
Sets the specified number of bins, min and max to the x axis and creates a standard Y axis with a min value of 0 and a max value of 0.
set(int, double, double, int, double, double) - Method in class org.jlab.groot.data.H2F
Sets the bins to the x and y axes and creates the buffer of the histogram
set(double[]) - Method in class org.jlab.groot.math.Axis
Sets the specified limits to the axis
set(int, double, double) - Method in class org.jlab.groot.math.Axis
Sets the number of bins, the min, and the max to the axis as well as calculates the bin widths.
set(double, double, double, double) - Method in class org.jlab.groot.math.Dimension2D
 
set(double, double, double, double, double, double) - Method in class org.jlab.groot.math.Dimension3D
 
set(double, double) - Method in class org.jlab.groot.math.StatNumber
Sets the number and error of the StatNumber object
set(double, double, double) - Method in class org.jlab.groot.math.UserParameter
 
set(EvaluatorI, Node, Object) - Method in class org.lsmp.djep.vectorJep.function.ArrayAccess
Sets the LValue.
set(EvaluatorI, Node, Object) - Method in class org.nfunk.jep.function.Ele
 
set(EvaluatorI, Node, Object) - Method in interface org.nfunk.jep.function.LValueI
Performs appropriate action to set an LValue.
set(Complex) - Method in class org.nfunk.jep.type.Complex
Copies the values from the parameter object to this object
set(double, double) - Method in class org.nfunk.jep.type.Complex
Sets the real and imaginary values of the object.
set2D_xTranslation(int) - Method in class jplot3d.Projector
Sets the 2D x translation.
set2D_yTranslation(int) - Method in class jplot3d.Projector
Sets the 2D y translation.
set2DScaling(float) - Method in class jplot3d.Projector
Sets the 2D scaling factor.
set2DScaling(float) - Method in class jplot3d.SurfaceModelCanvas
 
set2DTranslation(int, int) - Method in class jplot3d.Projector
Sets the 2D translation.
set2DType(int) - Method in class jplot.GraphSettings
Returns the current graph type.
set3D(boolean) - Method in class jhplot.Plottable
Set 3D if this is for 3D canvas.
setActive(boolean) - Method in class jplot.GraphLabel
 
setActive(boolean) - Method in class org.jlab.groot.tree.TreeCut
 
setActiveEuler(double, double, double) - Method in class hep.physics.vec.BasicHep3Matrix
Defines a rotation matrix via Euler angles.
setActiveEuler(double, double, double) - Method in class hephysics.vec.Hep3Matrix
Defines a rotation matrix via Euler angles.
setADCValues(short[]) - Method in class hep.lcio.implementation.event.ITrackerRawData
 
setAdditionalItemLabelGenerator(XYItemLabelGenerator) - Method in class org.jfree.chart.renderer.xy.YIntervalRenderer
Sets the generator for the item labels that appear near the lower y-value and sends a RendererChangeEvent to all registered listeners.
setAdditioner(float) - Method in class jplot.LinePars
Sets the additioner for this line, a value which will be used to increase each value of the dataset before plotting.
setAdjustForBinSize(boolean) - Method in class org.jfree.data.statistics.SimpleHistogramDataset
Sets the flag that controls whether or not the bin count is divided by the bin size in the SimpleHistogramDataset.getYValue(int, int) method, and sends a DatasetChangeEvent to all registered listeners.
setAdjustForDaylightSaving(boolean) - Method in class org.jfree.chart.axis.SegmentedTimeline
Sets the flag that controls whether or not the daylight saving adjustment is applied.
setAdvanceLinePaint(Paint) - Method in class org.jfree.chart.axis.CyclicNumberAxis
The advance line is the line drawn at the limit of the current cycle, when erasing the previous cycle.
setAdvanceLineStroke(Stroke) - Method in class org.jfree.chart.axis.CyclicNumberAxis
The advance line is the line drawn at the limit of the current cycle, when erasing the previous cycle.
setAdvanceLineVisible(boolean) - Method in class org.jfree.chart.axis.CyclicNumberAxis
The advance line is the line drawn at the limit of the current cycle, when erasing the previous cycle.
setAggregatedItemsKey(Comparable) - Method in class org.jfree.chart.plot.MultiplePiePlot
Sets the key for aggregated items in the pie plots.
setAggregatedItemsPaint(Paint) - Method in class org.jfree.chart.plot.MultiplePiePlot
Sets the paint used to draw the pie section representing the aggregated items and sends a PlotChangeEvent to all registered listeners.
setAlgorithmType(int) - Method in class hep.lcio.implementation.event.IParticleID
 
setAlgorithmType(String) - Method in class hep.lcio.implementation.event.IVertex
 
setAlignment(String) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the column alignment (left,center,right,decimal).
setAllentries(int) - Method in class promc.io.PBufFile.Record.H1D.Builder
optional int32 allentries = 11;
setAllentries(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
optional int32 allentries = 11;
setAllocatedY(double) - Method in class org.jfree.chart.plot.PieLabelRecord
Sets the allocated y-coordinate.
setAllowAssignment(boolean) - Method in class org.nfunk.jep.JEP
Sets whether assignment equations like y=x+1 are allowed.
setAllowNegativesFlag(boolean) - Method in class org.jfree.chart.axis.LogarithmicAxis
Sets the 'allowNegativesFlag' flag; true to allow negative values in data, false to be able to plot positive values arbitrarily close to zero.
setAllowUndeclared(boolean) - Method in class org.nfunk.jep.JEP
Sets the value for the undeclared variables option.
setAlpha(double) - Method in class jhplot.math.num.pdf.Beta
Modify the alpha parameter.
setAlpha(double) - Method in class jhplot.math.num.pdf.Gamma
Modify the alpha parameter.
setAlpha(float) - Method in class org.jfree.chart.plot.Marker
Sets the alpha transparency that should be used when drawing the marker, and sends a MarkerChangeEvent to all registered listeners.
setAlpha(float) - Method in class org.jfree.chart.renderer.xy.DeviationRenderer
Sets the alpha transparency for the background shading, and sends a RendererChangeEvent to all registered listeners.
setAlphaQCD(float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QCD = 13;
setAlphaQCD(float) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QCD = 13;
setAlphaQCD(int, float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQCD = 13;
setAlphaQED(float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QED = 11;
setAlphaQED(float) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Alpha_QED = 11;
setAlphaQED(int, float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float AlphaQED = 11;
setAmplitude(int) - Method in class hep.lcio.implementation.event.IRawCalorimeterHit
 
setAnchor(Point2D) - Method in class org.jfree.chart.fx.ChartCanvas
Set the anchor point and forces a redraw of the chart (the anchor point is used to determine the position of the crosshairs on the chart, if they are visible).
setAnchor(Point2D) - Method in class org.jfree.chart.plot.CrosshairState
Sets the anchor point.
setAnchor(TextAnchor) - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Sets the text anchor point and sends a DialLayerChangeEvent to all registered listeners.
setAnchorValue(double) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the anchor value and sends a PlotChangeEvent to all registered listeners.
setAnchorValue(double, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the anchor value and, if requested, sends a PlotChangeEvent to all registered listeners.
setAnchorX(double) - Method in class org.jfree.chart.plot.CrosshairState
Sets the x-coordinate (in data space) for the anchor point.
setAnchorY(double) - Method in class org.jfree.chart.plot.CrosshairState
Sets the y-coordinate (in data space) for the anchor point.
setAngle(double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Set the angle of the line.
setAngle(double) - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Sets the angle of the arrow and sends an AnnotationChangeEvent to all registered listeners.
setAngle(double) - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Sets the angle of the arrow and sends an AnnotationChangeEvent to all registered listeners.
setAngle(double) - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Sets the angle used to calculate the anchor point and sends a DialLayerChangeEvent to all registered listeners.
setAngle(double) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the angle for the anchor point and sends a DialLayerChangeEvent to all registered listeners.
setAngleGridlinePaint(Paint) - Method in class org.jfree.chart.plot.PolarPlot
Sets the paint for the grid lines plotted against the angular axis.
setAngleGridlineStroke(Stroke) - Method in class org.jfree.chart.plot.PolarPlot
Sets the stroke for the grid lines plotted against the angular axis and sends a PlotChangeEvent to all registered listeners.
setAngleGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.PolarPlot
Sets the flag that controls whether or not the angular grid-lines are visible.
setAngleLabelFont(Font) - Method in class org.jfree.chart.plot.PolarPlot
Sets the font used to display the angle labels and sends a PlotChangeEvent to all registered listeners.
setAngleLabelPaint(Paint) - Method in class org.jfree.chart.plot.PolarPlot
Sets the paint used to display the angle labels and sends a PlotChangeEvent to all registered listeners.
setAngleLabelsVisible(boolean) - Method in class org.jfree.chart.plot.PolarPlot
Sets the flag that controls whether or not the angle labels are visible, and sends a PlotChangeEvent to all registered listeners.
setAngleOffset(double) - Method in class org.jfree.chart.plot.PolarPlot
Sets the offset that is used for all angles and sends a PlotChangeEvent to all registered listeners.
setAngleTickUnit(TickUnit) - Method in class org.jfree.chart.plot.PolarPlot
Sets the tick unit that controls the spacing of the angular grid lines, and sends a PlotChangeEvent to all registered listeners.
setAntiAlias(boolean) - Method in class jhplot.HChart
Set antialiasing for the graphics of the current plot
setAntiAlias(boolean) - Method in class jhplot.HPlot
Set antialiasing for the graphics of the current plot
setAntiAlias(boolean) - Method in class jplot.GraphSettings
set antialiasing
setAntiAlias(boolean) - Method in class org.jfree.chart.JFreeChart
Sets a flag that indicates whether or not anti-aliasing is used when the chart is drawn.
setAntiAliasAll(boolean) - Method in class jhplot.HPlot
Set antialiasing for the graphics of all plots
setArea(Shape) - Method in class org.jfree.chart.entity.ChartEntity
Sets the area for the entity.
setArity(int) - Method in class org.apache.commons.math3.genetics.TournamentSelection
Sets the arity (number of chromosomes drawn to the tournament).
setArrangement(Arrangement) - Method in class org.jfree.chart.block.BlockContainer
Sets the arrangement (layout) manager.
setArray(double[]) - Method in class jhplot.P0D
Set a double array.
setArray(int[]) - Method in class jhplot.P0D
Set an integer array.
setArray(int[]) - Method in class jhplot.P0I
Set a double array.
setArray(double[][]) - Method in class jhplot.PND
Set values from double array Old content will be lost.
setArray(int[][]) - Method in class jhplot.PNI
Set values from double array Old content will be lost.
setArrayList(ArrayList<Double>) - Method in class jhplot.P0D
Set the data in form of ArrayList
setArrayList(ArrayList<Integer>) - Method in class jhplot.P0I
Set the data in form of ArrayList
setArrayList(ArrayList<double[]>) - Method in class jhplot.PND
Set the data in form of ArrayList
setArrayList(ArrayList<int[]>) - Method in class jhplot.PNI
Set the data in form of ArrayList
setArrayX(double[]) - Method in class jhplot.P1D
Set array at once
setArrayY(double[]) - Method in class jhplot.P1D
Set array at once
setArrowLength(double) - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Sets the arrow length and sends an AnnotationChangeEvent to all registered listeners.
setArrowLength(double) - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Sets the arrow length and sends an AnnotationChangeEvent to all registered listeners.
setArrowPaint(Paint) - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Sets the paint used for the arrow and sends an AnnotationChangeEvent to all registered listeners.
setArrowPaint(Paint) - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Sets the paint used for the arrow and sends an AnnotationChangeEvent to all registered listeners.
setArrowStroke(Stroke) - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Sets the stroke used to draw the arrow line and sends an AnnotationChangeEvent to all registered listeners.
setArrowStroke(Stroke) - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Sets the stroke used to draw the arrow line and sends an AnnotationChangeEvent to all registered listeners.
setArrowWidth(double) - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Sets the arrow width and sends an AnnotationChangeEvent to all registered listeners.
setArrowWidth(double) - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Sets the arrow width and sends an AnnotationChangeEvent to all registered listeners.
setArtifactPaint(Paint) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Sets the paint used to color the median and average markers and sends a RendererChangeEvent to all registered listeners.
setArtifactPaint(Paint) - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Sets the paint used to paint the various artifacts such as outliers, farout symbol, median line and the averages ellipse, and sends a RendererChangeEvent to all registered listeners.
setAssociatedParticle(ReconstructedParticle) - Method in class hep.lcio.implementation.event.IVertex
 
setAssumedMassFor3Vectors(double) - Method in class hep.physics.jet.AbstractJetFinder
Set the mass to use when converting 3-vectors to 4-vectors This is a static method so the mass applies to all instances of AbstractJetFinder.
setAttResizable(boolean) - Method in class jhplot.HPlot
Set canvas attributes resizable (line widths, symbols, fonts) or not.
setAttResizable(boolean) - Method in class jplot.GraphSettings
 
setAttResizableAll(boolean) - Method in class jhplot.HPlot
Set canvas attributes resizable (line widths, symbols, fonts) or not.
setAttribute(Object) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Associate an attribute with the instance.
setAttributedLabel(String) - Method in class org.jfree.chart.axis.Axis
Sets the attributed label for the axis and sends an AxisChangeEvent to all registered listeners.
setAttributedLabel(AttributedString) - Method in class org.jfree.chart.axis.Axis
Sets the attributed label for the axis and sends an AxisChangeEvent to all registered listeners.
setAttributedLabel(int, AttributedString) - Method in class org.jfree.chart.labels.StandardPieSectionLabelGenerator
Sets the attributed label for a section.
setAttributes(AttributeSet) - Method in class jhplot.utils.GHFontChooser
 
setAttributes(AxisAttributes) - Method in class org.jlab.groot.base.AxisAttributes
 
setAttributes(DatasetAttributes) - Method in class org.jlab.groot.base.DatasetAttributes
 
setAttributes(AxisAttributes) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
setAutoLevels(boolean) - Method in class graph.Contour
If true contour levels are calculated automatically.
setAutomaticTicks(int, boolean) - Method in class jplot.GraphSettings
If set to false, we stop automatically computing ticks.
setAutoPopulateSectionOutlinePaint(boolean) - Method in class org.jfree.chart.plot.PiePlot
Sets the flag that controls whether or not the section outline paint is auto-populated by the PiePlot.lookupSectionOutlinePaint(Comparable) method, and sends a PlotChangeEvent to all registered listeners.
setAutoPopulateSectionOutlineStroke(boolean) - Method in class org.jfree.chart.plot.PiePlot
Sets the flag that controls whether or not the section outline stroke is auto-populated by the PiePlot.lookupSectionOutlineStroke(Comparable) method, and sends a PlotChangeEvent to all registered listeners.
setAutoPopulateSectionPaint(boolean) - Method in class org.jfree.chart.plot.PiePlot
Sets the flag that controls whether or not the section paint is auto-populated by the PiePlot.lookupSectionPaint(Comparable) method, and sends a PlotChangeEvent to all registered listeners.
setAutoPopulateSeriesFillPaint(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether or not the series fill paint list is automatically populated when AbstractRenderer.lookupSeriesFillPaint(int) is called.
setAutoPopulateSeriesOutlinePaint(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether or not the series outline paint list is automatically populated when AbstractRenderer.lookupSeriesOutlinePaint(int) is called.
setAutoPopulateSeriesOutlineStroke(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether or not the series outline stroke list is automatically populated when AbstractRenderer.lookupSeriesOutlineStroke(int) is called.
setAutoPopulateSeriesPaint(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether or not the series paint list is automatically populated when AbstractRenderer.lookupSeriesPaint(int) is called.
setAutoPopulateSeriesShape(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether or not the series shape list is automatically populated when AbstractRenderer.lookupSeriesShape(int) is called.
setAutoPopulateSeriesStroke(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether or not the series stroke list is automatically populated when AbstractRenderer.lookupSeriesStroke(int) is called.
setAutoRange(boolean) - Method in class jhplot.HChart
Set auto-range in X and Y at the same time
setAutoRange() - Method in class jhplot.HChart
Set autorange in X and Y at the same time
setAutoRange(int, boolean) - Method in class jhplot.HPlot
Sets true or false to use automatic scaling for the current plot.
setAutoRange(boolean) - Method in class jhplot.HPlot
Set autorange in X and Y at the same time
setAutoRange() - Method in class jhplot.HPlot
Set autorange in X and Y at the same time for the current plot
setAutoRange(boolean) - Method in class jhplot.HPlot3D
Set autorange in X,Y,Z.
setAutoRange() - Method in class jhplot.HPlot3D
Set autorange in X,Y,Z at the same time for the current plot
setAutoRange(int, boolean) - Method in class jplot.GraphSettings
Sets true or false to use automatic scaling.
setAutoRange(boolean) - Method in class org.jfree.chart.axis.ValueAxis
Sets a flag that determines whether or not the axis range is automatically adjusted to fit the data, and notifies registered listeners that the axis has been modified.
setAutoRangeAll(int, boolean) - Method in class jhplot.HPlot
Sets true or false to use automatic scaling for all plots.
setAutoRangeAll(boolean) - Method in class jhplot.HPlot
Set auto-range in X and Y at the same time for all plots
setAutoRangeAll() - Method in class jhplot.HPlot
Set autorange in X and Y at the same time for all plots
setAutoRangeAll(boolean) - Method in class jhplot.HPlot3D
Set to autorange all pads
setAutoRangeIncludesZero(boolean) - Method in class org.jfree.chart.axis.NumberAxis
Sets the flag that indicates whether or not the axis range, if automatically calculated, is forced to include zero.
setAutoRangeMinimumSize(double, boolean) - Method in class org.jfree.chart.axis.CyclicNumberAxis
This function is nearly useless since the auto range is fixed for this class to the period.
setAutoRangeMinimumSize(double) - Method in class org.jfree.chart.axis.ValueAxis
Sets the auto range minimum size and sends an AxisChangeEvent to all registered listeners.
setAutoRangeMinimumSize(double, boolean) - Method in class org.jfree.chart.axis.ValueAxis
Sets the minimum size allowed for the axis range when it is automatically calculated.
setAutoRangeNextLogFlag(boolean) - Method in class org.jfree.chart.axis.LogarithmicAxis
Sets the 'autoRangeNextLogFlag' flag.
setAutoRangeStickyZero(boolean) - Method in class org.jfree.chart.axis.NumberAxis
Sets a flag that affects the auto-range when zero falls outside the data range but inside the margins defined for the axis.
setAutoRangeTimePeriodClass(Class) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the class used to create the first and last time periods for the axis range when the auto-range flag is set to true and sends an AxisChangeEvent to all registered listeners.
setAutoRangeXY() - Method in class jhplot.HPlot3D
Set autorange in Y,Z at the same time for the current plot
setAutoScale() - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setAutoScale(boolean) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
setAutoScaleXY(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setAutoScaleZ(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setAutoTickUnitSelection(boolean) - Method in class org.jfree.chart.axis.ValueAxis
Sets a flag indicating whether or not the tick unit is automatically selected from a range of standard tick units.
setAutoTickUnitSelection(boolean, boolean) - Method in class org.jfree.chart.axis.ValueAxis
Sets a flag indicating whether or not the tick unit is automatically selected from a range of standard tick units.
setAutoUpdate(boolean) - Method in class jplot.JPlot
Toggles timer which updates the graph every second.
setAutoWidth(boolean) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Sets the flag that indicates whether the interval width is automatically calculated or not.
setAutoWidth(boolean) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Sets the flag that indicates whether the interval width is automatically calculated or not.
setAutoWidth(boolean) - Method in class org.jfree.data.xy.IntervalXYDelegate
Sets the flag that indicates whether the interval width is automatically calculated.
setAutoWidth(boolean) - Method in class org.jfree.data.xy.XYSeriesCollection
Sets the flag that indicates whether the interval width is automatically calculated or not.
setAutoWidthFactor(double) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Sets the factor by which the available space automatically calculated for the candles will be multiplied to determine the actual width to use.
setAutoWidthGap(double) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Sets the amount of space to leave on the left and right of each candle when automatically calculating widths and sends a RendererChangeEvent to all registered listeners.
setAutoWidthMethod(int) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Sets the method of automatically calculating the candle width and sends a RendererChangeEvent to all registered listeners.
setAveragedOutlier(Outlier) - Method in class org.jfree.chart.renderer.OutlierList
Sets the averaged outlier.
setAxes(boolean) - Method in class jhplot.HPlot3DP
Set all axes or not
setAxes(boolean, boolean, boolean) - Method in class jhplot.HPlot3DP
Show or not axes for X, Y, Z
setAxes(boolean) - Method in class jplot3dp.MainComponent
 
setAxes(boolean) - Method in class jplot3dp.ModelView
 
setAxesArrow(int) - Method in class jplot.GraphSettings
Sets the arrows for axes.
setAxesArrows(boolean) - Method in class jhplot.HPlot3DP
Show or not small arrows on axes
setAxesColor(Color) - Method in class jhplot.HPlot
Sets the actual color of the axes of the graph.
setAxesColor(Color) - Method in class jhplot.HPlot3DP
Set Color for axes
setAxesColor(Color) - Method in class jplot.GraphSettings
Sets the actual color of the axes of the graph.
setAxesColor(Color) - Method in class jplot3dp.ModelView
 
setAxesFontColor(Color) - Method in class jhplot.HPlot3D
Get color for tic labels
setAxesFontColor(Color) - Method in interface jplot3d.SurfaceModel
 
setAxesFontColor(Color) - Method in class jplot3d.SurfaceModelCanvas
 
setAxesPenTicWidth(float) - Method in class jplot.GraphSettings
Sets the actual pen width for tic axes of the graph.
setAxesRatio(double) - Method in class jhplot.HPlot
Sets the ratio between X- and Y-axes lengths.
setAxesRatio(double) - Method in class jplot.GraphSettings
Sets the ratio between X- and Y-axes lengths.
setAxesRatioUse(boolean) - Method in class jhplot.HPlot
Sets whether or not to use a fixed ratio between X- and Y-axes lengths.
setAxis(int, ValueAxis) - Method in class jhplot.HChart
Sets axis
setAxis(int, boolean) - Method in class jhplot.HPlot
Sets whether an axis line will be drawn or not.
setAxis(ValueAxis) - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Sets the axis.
setAxis(ValueAxis) - Method in class org.jfree.chart.plot.PolarPlot
Sets the primary axis for the plot and sends a PlotChangeEvent to all registered listeners.
setAxis(int, ValueAxis) - Method in class org.jfree.chart.plot.PolarPlot
Sets an axis for the plot and sends a PlotChangeEvent to all registered listeners.
setAxis(int, ValueAxis, boolean) - Method in class org.jfree.chart.plot.PolarPlot
Sets an axis for the plot and, if requested, sends a PlotChangeEvent to all registered listeners.
setAxis(ValueAxis) - Method in class org.jfree.chart.title.PaintScaleLegend
Sets the axis for the paint scale and sends a TitleChangeEvent to all registered listeners.
setAxis(int) - Method in class org.jlab.groot.ui.GraphicsAxisFrame
sets the dimension of the graphics axis.
setAxisAll(boolean) - Method in class jhplot.HPlot
Sets whether all axis lines will be drawn or not.
setAxisArrow(int) - Method in class jhplot.HPlot
Sets axes arrows.
setAxisArrows(boolean) - Method in class jhplot.HPlot3DP
Set or not arrows for axis
setAxisArrows(boolean) - Method in class jplot3dp.ModelView
 
setAxisAttributesX(AxisAttributes) - Static method in class org.jlab.groot.base.GStyle
 
setAxisAttributesY(AxisAttributes) - Static method in class org.jlab.groot.base.GStyle
 
setAxisAttributesZ(AxisAttributes) - Static method in class org.jlab.groot.base.GStyle
 
setAxisAutoScale(boolean) - Method in class org.jlab.groot.base.AxisAttributes
 
setAxisDivisions(int) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
setAxisDivisions(int) - Method in class org.jlab.groot.ui.GraphicsAxis
 
setAxisFont(Font) - Method in class jhplot.HPlot3D
Sets font for axes
setAxisFont(Font) - Method in interface jplot3d.SurfaceModel
 
setAxisFont(Font) - Method in class jplot3d.SurfaceModelCanvas
 
setAxisFont(String) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setAxisFont(String) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
setAxisFontSize(int) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setAxisFontSize(int) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setAxisFontSize(int) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
setAxisGrid(boolean) - Method in class org.jlab.groot.base.AxisAttributes
 
setAxisLabelFontSize(int) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setAxisLabelGap(double) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the axis label gap and sends a PlotChangeEvent to all registered listeners.
setAxisLabelPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the axis label paint.
setAxisLabelSize(int) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setAxisLinePaint(Paint) - Method in class org.jfree.chart.axis.Axis
Sets the paint used to draw the axis line and sends an AxisChangeEvent to all registered listeners.
setAxisLinePaint(Paint) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the paint used to draw the axis lines and sends a PlotChangeEvent to all registered listeners.
setAxisLineStroke(Stroke) - Method in class org.jfree.chart.axis.Axis
Sets the stroke used to draw the axis line and sends an AxisChangeEvent to all registered listeners.
setAxisLineStroke(Stroke) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the stroke used to draw the axis lines and sends a PlotChangeEvent to all registered listeners.
setAxisLineVisible(boolean) - Method in class org.jfree.chart.axis.Axis
Sets a flag that controls whether or not the axis line is visible and sends an AxisChangeEvent to all registered listeners.
setAxisLocation(PolarAxisLocation) - Method in class org.jfree.chart.plot.PolarPlot
Sets the location of the primary axis and sends a PlotChangeEvent to all registered listeners.
setAxisLocation(PolarAxisLocation, boolean) - Method in class org.jfree.chart.plot.PolarPlot
Sets the location of the primary axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setAxisLocation(int, PolarAxisLocation) - Method in class org.jfree.chart.plot.PolarPlot
Sets the location for an axis and sends a PlotChangeEvent to all registered listeners.
setAxisLocation(int, PolarAxisLocation, boolean) - Method in class org.jfree.chart.plot.PolarPlot
Sets the axis location for an axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setAxisLocation(int) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the location at which the axis is displayed relative to the thermometer, and sends a PlotChangeEvent to all registered listeners.
setAxisLocation(AxisLocation) - Method in class org.jfree.chart.title.PaintScaleLegend
Sets the axis location and sends a TitleChangeEvent to all registered listeners.
setAxisMargins(PadMargins) - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
setAxisMaximum(double) - Method in class org.jlab.groot.base.AxisAttributes
 
setAxisMinimum(double) - Method in class org.jlab.groot.base.AxisAttributes
 
setAxisMirror(int, boolean) - Method in class jhplot.HPlot
Sets whether the mirror of an axis will be drawn or not.
setAxisNames(String[]) - Method in class org.jlab.groot.matrix.SparseVectorGrid
sets names for all the axis.
setAxisOffset(RectangleInsets) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the axis offsets (gap between the data area and the axes) and sends a PlotChangeEvent to all registered listeners.
setAxisOffset(RectangleInsets) - Method in class org.jfree.chart.plot.XYPlot
Sets the axis offsets (gap between the data area and the axes) and sends a PlotChangeEvent to all registered listeners.
setAxisOffset(RectangleInsets) - Method in class org.jfree.chart.StandardChartTheme
Sets the axis offset.
setAxisOffset(double) - Method in class org.jfree.chart.title.PaintScaleLegend
Sets the offset between the axis and the paint strip and sends a TitleChangeEvent to all registered listeners.
setAxisPenTicWidth(int) - Method in class jhplot.HPlot
Sets the pen width to draw tick axes.
setAxisProperties(Axis) - Method in class org.jfree.chart.editor.DefaultLogAxisEditor
Sets the properties of the specified axis to match the properties defined on this panel.
setAxisRange(double, double, double, double) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setAxisTitle(String) - Method in class org.jlab.groot.base.AxisAttributes
 
setAxisTitleFontSize(int) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setAxisTitleSize(int) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setAxisTitleString(String) - Method in class org.jlab.groot.base.AxisAttributes
 
setAxisType(int) - Method in class org.jlab.groot.base.AxisAttributes
 
setAxisType(int) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
setAxisX() - Method in class jhplot.HPlot
Sets X-axis (bottom).
setAxisY() - Method in class jhplot.HPlot
Sets Y-axis (left).
setBack(double) - Method in class jhplot.stat.limit.ExpData
Set background number
setBackgColor(Color) - Method in class jhplot.HChart
Sets the actual background color of the entire graph panel.
setBackgColor(Color) - Method in class jhplot.HPlot
Sets the actual background color of the entire graph panel.
setBackgColor(Color) - Method in class jhplot.HPlot3DP
Set background for current pad
setBackgColorForAllGraph(Color) - Method in class jhplot.HPlot
Sets the background color of all graphs.
setBackgColorGraph(Color) - Method in class jhplot.HPlot
Sets the background color of the current graph.
setBackground(Color) - Method in class graph.TextLine
Set the Background Color to use with the class
setBackground(Color) - Method in class jplot.LineStyle
 
setBackground(Color) - Method in class jplot.LineStyleButton
 
setBackground(Color) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the background color.
setBackground(DialLayer) - Method in class org.jfree.chart.plot.dial.DialPlot
Sets the background layer and sends a PlotChangeEvent to all registered listeners.
setBackground(Color) - Method in class org.jfree.chart.plot.JThermometer
Sets the background color.
setBackground(int, int, int) - Method in class org.jlab.groot.ui.PaveText
 
setBackground(int, int, int, int) - Method in class org.jlab.groot.ui.PaveText
 
setBackgroundAlpha(float) - Method in class org.jfree.chart.plot.Plot
Sets the alpha transparency of the plot area background, and notifies registered listeners that the plot has been modified.
setBackgroundColor(Color) - Method in class jplot.GraphSettings
Sets the actual background color of the entire graph panel.
setBackgroundColor(Color) - Method in class jplot3d.ColorModelSet
 
setBackgroundColor(Color) - Method in interface jplot3d.SurfaceColor
 
setBackgroundColor(Color) - Method in class org.jlab.groot.base.PadAttributes
 
setBackgroundFrame(Color) - Method in class jplot3dp.MainComponent
 
setBackgroundFrame(Color) - Method in class jplot3dp.ModelView
 
setBackgroundImage(Image) - Method in class org.jfree.chart.JFreeChart
Sets the background image for the chart and sends a ChartChangeEvent to all registered listeners.
setBackgroundImage(Image) - Method in class org.jfree.chart.plot.Plot
Sets the background image for the plot and sends a PlotChangeEvent to all registered listeners.
setBackgroundImageAlignment(int) - Method in class org.jfree.chart.JFreeChart
Sets the background alignment.
setBackgroundImageAlignment(int) - Method in class org.jfree.chart.plot.Plot
Sets the alignment for the background image and sends a PlotChangeEvent to all registered listeners.
setBackgroundImageAlpha(float) - Method in class org.jfree.chart.JFreeChart
Sets the alpha-transparency for the chart's background image.
setBackgroundImageAlpha(float) - Method in class org.jfree.chart.plot.Plot
Sets the alpha transparency used when drawing the background image.
setBackgroundPaint(Paint) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the background paint for the annotation and sends an AnnotationChangeEvent to all registered listeners.
setBackgroundPaint(Paint) - Method in class org.jfree.chart.JFreeChart
Sets the paint used to fill the chart background and sends a ChartChangeEvent to all registered listeners.
setBackgroundPaint(Paint) - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Sets the background paint and sends a DialLayerChangeEvent to all registered listeners.
setBackgroundPaint(Paint) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the background paint and sends a DialLayerChangeEvent to all registered listeners.
setBackgroundPaint(Paint) - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Sets the background paint and sends a DialLayerChangeEvent to all registered listeners.
setBackgroundPaint(Paint) - Method in class org.jfree.chart.plot.Plot
Sets the background color of the plot area and sends a PlotChangeEvent to all registered listeners.
setBackgroundPaint(Paint) - Method in class org.jfree.chart.title.CompositeTitle
Sets the background paint and sends a TitleChangeEvent to all registered listeners.
setBackgroundPaint(Paint) - Method in class org.jfree.chart.title.LegendTitle
Sets the background paint for the legend and sends a TitleChangeEvent to all registered listeners.
setBackgroundPaint(Paint) - Method in class org.jfree.chart.title.PaintScaleLegend
Sets the background paint and sends a TitleChangeEvent to all registered listeners.
setBackgroundPaint(Paint) - Method in class org.jfree.chart.title.TextTitle
Sets the background paint and sends a TitleChangeEvent to all registered listeners.
setBackscatter(boolean) - Method in class hep.lcio.implementation.event.IMCParticle
 
setBarAlignmentFactor(double) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the bar alignment factor and sends a RendererChangeEvent to all registered listeners.
setBarcode(int) - Method in class hephysics.particle.HEParticle
Set barcode ID
setBarcode(int, int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
setBarcode(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
setBarcode(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 barcode = 12 [packed = true];
setBarPainter(BarPainter) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the bar painter for this renderer and sends a RendererChangeEvent to all registered listeners.
setBarPainter(XYBarPainter) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the bar painter and sends a RendererChangeEvent to all registered listeners.
setBarPainter(BarPainter) - Method in class org.jfree.chart.StandardChartTheme
Sets the bar painter.
setBars(boolean) - Method in class jhplot.DrawOptions
Draw a histogram using bars (default is using lines).
setBars() - Method in class jhplot.HPlot3D
Set bar type of plot
setBars(boolean) - Method in class jhplot.HPlot3D
Set bar type of plot
setBarsType(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setBarWidth(int) - Method in class jplot.Contour
 
setBarWidth(double) - Method in class org.jfree.chart.renderer.category.CategoryItemRendererState
Sets the bar width.
setBarWidth(double) - Method in class org.jfree.data.xy.XYBarDataset
Sets the bar width and sends a DatasetChangeEvent to all registered listeners.
setBase(double) - Method in class org.jfree.chart.axis.LogAxis
Sets the base for the logarithm calculation and sends a change event to all registered listeners.
setBase(double) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the base value for the bars and sends a RendererChangeEvent to all registered listeners.
setBase(double) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the base value for the bars and sends a RendererChangeEvent to all registered listeners.
setBaseCreateEntities(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base flag that controls whether entities are created for a series, and sends a RendererChangeEvent to all registered listeners.
setBaseCreateEntities(boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base flag that controls whether entities are created and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseFillPaint(Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base fill paint and sends a RendererChangeEvent to all registered listeners.
setBaseFillPaint(Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base fill paint and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseFormatter(Format) - Method in class org.jfree.chart.axis.LogAxis
Sets the formatter used to format the base value of the logarithmic scale when it is displayed numerically and sends a change event to all registered listeners.
setBaseIndex(int) - Static method in class Jampack.Parameters
Resets the default base index.
setBaseItemLabelFont(Font) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base item label font and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelFont(Font, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base item label font and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelFont(Font) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base item label font and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelFont(Font) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base item label font and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelGenerator(CategoryItemLabelGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Sets the base item label generator and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelGenerator(CategoryItemLabelGenerator) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base item label generator and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelGenerator(XYItemLabelGenerator) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Sets the base item label generator and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelGenerator(XYItemLabelGenerator) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base item label generator and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelPaint(Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base item label paint and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelPaint(Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base item label paint and, if requested, sends a RendererChangeEvent to all registered listeners..
setBaseItemLabelPaint(Paint) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base item label paint and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelPaint(Paint) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base item label paint and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelsVisible(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base flag that controls whether or not item labels are visible, and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelsVisible(Boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base setting for item label visibility and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelsVisible(Boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base visibility for item labels and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelsVisible(boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base flag that controls whether or not item labels are visible and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelsVisible(Boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base setting for item label visibility and sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelsVisible(Boolean, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base visibility for item labels and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseItemLabelsVisible(boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base flag that controls whether or not item labels are visible.
setBaseItemLabelsVisible(Boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base setting for item label visibility.
setBaseItemLabelsVisible(Boolean, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base visibility for item labels and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseItemURLGenerator(CategoryURLGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Sets the base item URL generator and sends a RendererChangeEvent to all registered listeners.
setBaseItemURLGenerator(CategoryURLGenerator) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base item URL generator and sends a RendererChangeEvent to all registered listeners.
setBaseLegendShape(Shape) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the default legend shape and sends a RendererChangeEvent to all registered listeners.
setBaseLegendTextFont(Font) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the default legend text font and sends a RendererChangeEvent to all registered listeners.
setBaseLegendTextPaint(Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the default legend text paint and sends a RendererChangeEvent to all registered listeners.
setBaselinePaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the baseline paint.
setBaseLinesVisible(boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the base 'lines visible' flag and sends a RendererChangeEvent to all registered listeners.
setBaseLinesVisible(boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the base 'lines visible' flag and sends a RendererChangeEvent to all registered listeners.
setBaseMillis(long) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the base date/time used to calculate the elapsed time for display.
setBaseNegativeItemLabelPosition(ItemLabelPosition) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base item label position for negative values and sends a RendererChangeEvent to all registered listeners.
setBaseNegativeItemLabelPosition(ItemLabelPosition, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base negative item label position and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseNegativeItemLabelPosition(ItemLabelPosition) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base item label position for negative values and sends a RendererChangeEvent to all registered listeners.
setBaseNegativeItemLabelPosition(ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base negative item label position and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseNegativeItemLabelPosition(ItemLabelPosition) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base item label position for negative values and sends a RendererChangeEvent to all registered listeners.
setBaseNegativeItemLabelPosition(ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base negative item label position and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseOutlinePaint(Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base outline paint and sends a RendererChangeEvent to all registered listeners.
setBaseOutlinePaint(Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base outline paint and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseOutlinePaint(Paint) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base outline paint and sends a RendererChangeEvent to all registered listeners.
setBaseOutlinePaint(Paint) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base outline paint and sends a RendererChangeEvent to all registered listeners.
setBaseOutlineStroke(Stroke) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base outline stroke and sends a RendererChangeEvent to all registered listeners.
setBaseOutlineStroke(Stroke, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base outline stroke and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseOutlineStroke(Stroke) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base outline stroke and sends a RendererChangeEvent to all registered listeners.
setBaseOutlineStroke(Stroke) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base outline stroke and sends a RendererChangeEvent to all registered listeners.
setBasePaint(Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base paint and sends a RendererChangeEvent to all registered listeners.
setBasePaint(Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base paint and, if requested, sends a RendererChangeEvent to all registered listeners.
setBasePaint(Paint) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base paint and sends a RendererChangeEvent to all registered listeners.
setBasePaint(Paint) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base paint and sends a RendererChangeEvent to all registered listeners.
setBasePositiveItemLabelPosition(ItemLabelPosition) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base positive item label position.
setBasePositiveItemLabelPosition(ItemLabelPosition, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base positive item label position and, if requested, sends a RendererChangeEvent to all registered listeners.
setBasePositiveItemLabelPosition(ItemLabelPosition) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base positive item label position.
setBasePositiveItemLabelPosition(ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base positive item label position and, if requested, sends a RendererChangeEvent to all registered listeners.
setBasePositiveItemLabelPosition(ItemLabelPosition) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base positive item label position.
setBasePositiveItemLabelPosition(ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base positive item label position and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseRadius(double) - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Sets the base radius and sends an AnnotationChangeEvent to all registered listeners.
setBaseRadius(double) - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Sets the base radius and sends an AnnotationChangeEvent to all registered listeners.
setBaseSectionOutlinePaint(Paint) - Method in class org.jfree.chart.plot.PiePlot
Sets the base section paint.
setBaseSectionOutlineStroke(Stroke) - Method in class org.jfree.chart.plot.PiePlot
Sets the base section stroke.
setBaseSectionPaint(Paint) - Method in class org.jfree.chart.plot.PiePlot
Sets the base section paint and sends a PlotChangeEvent to all registered listeners.
setBaseSeriesOutlinePaint(Paint) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the base series paint.
setBaseSeriesOutlineStroke(Stroke) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the base series stroke.
setBaseSeriesPaint(Paint) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the base series paint.
setBaseSeriesVisible(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base visibility and sends a RendererChangeEvent to all registered listeners.
setBaseSeriesVisible(boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base visibility and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseSeriesVisible(boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base visibility and sends a RendererChangeEvent to all registered listeners.
setBaseSeriesVisible(boolean, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base visibility and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseSeriesVisible(boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base visibility and sends a RendererChangeEvent to all registered listeners.
setBaseSeriesVisible(boolean, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base visibility and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseSeriesVisibleInLegend(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base visibility in the legend and sends a RendererChangeEvent to all registered listeners.
setBaseSeriesVisibleInLegend(boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base visibility in the legend and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseSeriesVisibleInLegend(boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base visibility in the legend and sends a RendererChangeEvent to all registered listeners.
setBaseSeriesVisibleInLegend(boolean, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base visibility in the legend and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseSeriesVisibleInLegend(boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base visibility in the legend and sends a RendererChangeEvent to all registered listeners.
setBaseSeriesVisibleInLegend(boolean, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base visibility in the legend and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseShape(Shape) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base shape and sends a RendererChangeEvent to all registered listeners.
setBaseShape(Shape, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base shape and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseShape(Shape) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base shape and sends a RendererChangeEvent to all registered listeners.
setBaseShape(Shape) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base shape and sends a RendererChangeEvent to all registered listeners.
setBaseShapesFilled(boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the base 'shapes filled' flag and sends a RendererChangeEvent to all registered listeners.
setBaseShapesFilled(boolean) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Sets the base 'shapes filled' flag and sends a RendererChangeEvent to all registered listeners.
setBaseShapesFilled(boolean) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Sets the base 'shapes filled' flag and sends a RendererChangeEvent to all registered listeners.
setBaseShapesFilled(boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the base 'shapes filled' flag and sends a RendererChangeEvent to all registered listeners.
setBaseShapesVisible(boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the base 'shapes visible' flag and sends a RendererChangeEvent to all registered listeners.
setBaseShapesVisible(boolean) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Sets the flag that controls whether or not a shape is plotted at each data point.
setBaseShapesVisible(boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the base 'shapes visible' flag and sends a RendererChangeEvent to all registered listeners.
setBaseStroke(Stroke) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base stroke and sends a RendererChangeEvent to all registered listeners.
setBaseStroke(Stroke, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the base stroke and, if requested, sends a RendererChangeEvent to all registered listeners.
setBaseStroke(Stroke) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base stroke and sends a RendererChangeEvent to all registered listeners.
setBaseStroke(Stroke) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base stroke and sends a RendererChangeEvent to all registered listeners.
setBaseSymbol(String) - Method in class org.jfree.chart.axis.LogAxis
Sets the symbol used to represent the base value of the logarithmic scale and sends a change event to all registered listeners.
setBaseTimeline(SegmentedTimeline) - Method in class org.jfree.chart.axis.SegmentedTimeline
Sets the base timeline.
setBaseToolTipGenerator(CategoryToolTipGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Sets the base tool tip generator and sends a RendererChangeEvent to all registered listeners.
setBaseToolTipGenerator(CategoryToolTipGenerator) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the base tool tip generator and sends a RendererChangeEvent to all registered listeners.
setBaseToolTipGenerator(XYToolTipGenerator) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Sets the default tool tip generator and sends a RendererChangeEvent to all registered listeners.
setBaseToolTipGenerator(XYToolTipGenerator) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Sets the base tool tip generator and sends a RendererChangeEvent to all registered listeners.
setBaseToolTipGenerator(XYToolTipGenerator) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Sets the base tool tip generator and sends a RendererChangeEvent to all registered listeners.
setBaseToolTipGenerator(XYToolTipGenerator) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the base tool tip generator and sends a RendererChangeEvent to all registered listeners.
setBaseY(double) - Method in class org.jfree.chart.plot.PieLabelRecord
Sets the base y-coordinate.
setBeta(double) - Method in class jhplot.math.num.pdf.Beta
Modify the beta parameter.
setBeta(double) - Method in class jhplot.math.num.pdf.Gamma
Modify the beta parameter.
setBiasCorrected(boolean) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Sets the biasCorrected property.
setBiasCorrected(boolean) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
 
setBiasCorrected(boolean) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
 
setBinContent(int, double) - Method in class org.jlab.groot.data.H1F
Sets the value to the specified bin.
setBinContent(int, int, double) - Method in class org.jlab.groot.data.H2F
Sets the bin to that value
setBinContent(int, double, int[]) - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
setBinError(int, int, double) - Method in class jhplot.H2D
Set the error on this bin.
setBinError(int, double) - Method in class org.jlab.groot.data.H1F
Sets the bin error to the specified bin.
setBins(int) - Method in class jhplot.H1D
Sets the number of bins
setBins(int) - Method in class jhplot.HProf1D
Sets the number of bins
setBins(double[][]) - Method in class jhplot.utils.SHisto
Set bin values
setBins(double[]) - Method in class jhplot.utils.SHisto
Set bin values assuming that there only one band
setBins(int) - Method in class promc.io.PBufFile.Record.H1D.Builder
required int32 bins = 8;
setBinWidth(double) - Method in class jhplot.DrawOptions
Set the bin width.
setBit(int) - Method in interface hep.lcio.event.LCFlag
Sets bit to 1.
setBjets(ProMC.ProMCEvent.BLJets) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.BLJets bjets = 5;
setBjets(ProMC.ProMCEvent.BLJets.Builder) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.BLJets bjets = 5;
setBlockAnchor(RectangleAnchor) - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Sets the anchor point used to align a block at its (x, y) location and sends a RendererChangeEvent to all registered listeners.
setBlockHeight(double) - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Sets the height of the blocks used to represent each data item and sends a RendererChangeEvent to all registered listeners.
setBlockWidth(double) - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Sets the width of the blocks used to represent each data item and sends a RendererChangeEvent to all registered listeners.
setBorder(BlockBorder) - Method in class org.jfree.chart.block.AbstractBlock
Deprecated.
setBorder(double, double, double, double) - Method in class org.jfree.chart.block.AbstractBlock
Sets a black border with the specified line widths.
setBorderPaint(Paint) - Method in class org.jfree.chart.JFreeChart
Sets the paint used to draw the chart border (if visible).
setBorderStroke(Stroke) - Method in class org.jfree.chart.JFreeChart
Sets the stroke used to draw the chart border (if visible).
setBorderVisible(boolean) - Method in class org.jfree.chart.JFreeChart
Sets a flag that controls whether or not a border is drawn around the outside of the chart.
setBothFunction(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setBottom(double) - Method in class org.jfree.chart.axis.AxisSpace
Sets the space reserved for axes at the bottom of the plot area.
setBottomMargin(double) - Method in class jplot.GraphSettings
Sets the distance between the bottom-border of the panel and the bottom X-axis.
setBottomMargin(int) - Method in class org.jlab.groot.base.PadMargins
 
setBoundMappedToLastCycle(boolean) - Method in class org.jfree.chart.axis.CyclicNumberAxis
The cycle bound can be associated either with the current or with the last cycle.
setBounds(int, int, int, int) - Method in class jhepsim.FontChooser.NwList
 
setBounds(int, int, int, int) - Method in class jminhep.gui.FontChooser.NwList
 
setBounds(Rectangle2D) - Method in class org.jfree.chart.block.AbstractBlock
Sets the bounds of the block.
setBounds(Rectangle2D) - Method in interface org.jfree.chart.block.Block
Sets the bounds of the block.
setBounds(double, double, double, double) - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Set the bounds of this item.
setBounds(double, double) - Method in class org.jfree.chart.plot.dial.StandardDialRange
Sets the bounds for the range and sends a DialLayerChangeEvent to all registered listeners.
setBox(boolean) - Method in class jhplot.HPlot
Sets whether or not to draw the bounding box around the graph.
setBoxColor(Color) - Method in class jhplot.HPlot
Sets the color of the bounding box drawn around a graph.
setBoxColor(Color) - Method in class jhplot.HPlot3D
Set color of the box
setBoxColor(Color) - Method in class jplot.GraphSettings
Sets the color of the bounding box drawn around a graph.
setBoxColor(Color) - Method in class jplot3d.ColorModelSet
 
setBoxColor(Color) - Method in interface jplot3d.SurfaceColor
 
setBoxed(boolean) - Method in class jhplot.HPlot3D
Set boxed frame
setBoxed(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setBoxFillColor(Color) - Method in class jhplot.HPlot
Sets the fill color of the bounding box drawn around a graph.
setBoxFillColor(Color) - Method in class jplot.GraphSettings
Sets the fill color of the bounding box drawn around a graph.
setBoxOffset(double) - Method in class jhplot.HPlot
Sets the offset of the bounding box drawn around a graph.
setBoxOffset(float) - Method in class jplot.GraphSettings
Sets the offset of the bounding box drawn around a graph.
setBoxPaint(Paint) - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Sets the paint used to fill boxes and sends a RendererChangeEvent to all registered listeners.
setBoxWidth(double) - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Sets the box width and sends a RendererChangeEvent to all registered listeners.
setBranchData(float[]) - Method in class org.jlab.groot.tree.Tree
Fills branches with values from the array.
setBtag(int, int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Btag = 5 [packed = true];
setBtag(int, int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Btag = 5 [packed = true];
setBtag(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Btag = 5 [packed = true];
setBtot(double) - Method in class jhplot.stat.ConfidenceLevel
 
setBulbRadius(int) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the bulb radius (in Java2D units) and sends a PlotChangeEvent to all registered listeners.
setCalcDivisions(int) - Method in class jplot3d.SurfaceModelCanvas
 
setCalorimeterHits(List, float[]) - Method in class hep.lcio.implementation.event.ICluster
 
setCameraPosition(double) - Method in class jhplot.HPlot3DP
Set camera position
setCan(EmbeddedCanvas) - Method in class org.jlab.groot.base.AxisAttributes
 
setCandleWidth(double) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Sets the candle width and sends a RendererChangeEvent to all registered listeners.
setCanvas(EmbeddedCanvas) - Method in class org.jlab.groot.base.AxisAttributes
 
setCanvasPads(List<EmbeddedPad>) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setCap(DialLayer) - Method in class org.jfree.chart.plot.dial.DialPlot
Sets the cap and sends a PlotChangeEvent to all registered listeners.
setCapLength(double) - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Sets the length of the cap at the end of the error bars, and sends a RendererChangeEvent to all registered listeners.
setCategory(Comparable) - Method in class org.jfree.chart.annotations.CategoryTextAnnotation
Sets the category that the annotation attaches to and sends an AnnotationChangeEvent to all registered listeners.
setCategory(Object) - Method in class org.jfree.chart.entity.CategoryItemEntity
Deprecated.
setCategory1(Comparable) - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Sets the category for the start of the line and sends an AnnotationChangeEvent to all registered listeners.
setCategory2(Comparable) - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Sets the category for the end of the line and sends an AnnotationChangeEvent to all registered listeners.
setCategoryAnchor(CategoryAnchor) - Method in class org.jfree.chart.annotations.CategoryTextAnnotation
Sets the category anchor point and sends an AnnotationChangeEvent to all registered listeners.
setCategoryIndex(int) - Method in class org.jfree.chart.entity.CategoryItemEntity
Deprecated.
As of 1.0.6, use CategoryItemEntity.setColumnKey(Comparable) to designate the category.
setCategoryKeys(Comparable[]) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Sets the categories for the dataset.
setCategoryLabelPositionOffset(int) - Method in class org.jfree.chart.axis.CategoryAxis
Sets the offset between the axis and the category labels (before label positioning is taken into account) and sends a change event to all registered listeners.
setCategoryLabelPositions(CategoryLabelPositions) - Method in class org.jfree.chart.axis.CategoryAxis
Sets the category label position specification for the axis and sends an AxisChangeEvent to all registered listeners.
setCategoryMargin(double) - Method in class org.jfree.chart.axis.CategoryAxis
Sets the category margin and sends an AxisChangeEvent to all registered listeners.
setCellID(int) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setCellID(int) - Method in class hep.lcio.implementation.event.ITPCHit
 
setCellID0(int) - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
setCellID0(int) - Method in class hep.lcio.implementation.event.IRawCalorimeterHit
 
setCellID0(int) - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
setCellID0(int) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setCellID0(int) - Method in class hep.lcio.implementation.event.ITrackerData
 
setCellID0(int) - Method in class hep.lcio.implementation.event.ITrackerHit
 
setCellID0(int) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setCellID0(int) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setCellID0(int) - Method in class hep.lcio.implementation.event.ITrackerPulse
 
setCellID0(int) - Method in class hep.lcio.implementation.event.ITrackerRawData
 
setCellID1(int) - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
setCellID1(int) - Method in class hep.lcio.implementation.event.IRawCalorimeterHit
 
setCellID1(int) - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
setCellID1(int) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setCellID1(int) - Method in class hep.lcio.implementation.event.ITrackerData
 
setCellID1(int) - Method in class hep.lcio.implementation.event.ITrackerHit
 
setCellID1(int) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setCellID1(int) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setCellID1(int) - Method in class hep.lcio.implementation.event.ITrackerPulse
 
setCellID1(int) - Method in class hep.lcio.implementation.event.ITrackerRawData
 
setCenter(float[]) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setCenterText(String) - Method in class org.jfree.chart.plot.RingPlot
Sets the text to display in the center of the plot and sends a change event to all registered listeners.
setCenterTextColor(Color) - Method in class org.jfree.chart.plot.RingPlot
Sets the color for the center text and sends a change event to all registered listeners.
setCenterTextFont(Font) - Method in class org.jfree.chart.plot.RingPlot
Sets the font used to display the center text and sends a change event to all registered listeners.
setCenterTextFormatter(Format) - Method in class org.jfree.chart.plot.RingPlot
Sets the formatter used to format the center text value and sends a change event to all registered listeners.
setCenterTextMode(CenterTextMode) - Method in class org.jfree.chart.plot.RingPlot
Sets the mode for displaying text in the center of the plot and sends a change event to all registered listeners.
setCharge(float) - Method in class hep.lcio.implementation.event.IMCParticle
 
setCharge(float) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setCharge(float) - Method in class hep.lcio.implementation.event.ITPCHit
 
setCharge(float) - Method in class hep.lcio.implementation.event.ITrackerPulse
 
setCharge(double) - Method in class hephysics.particle.LParticle
Set charge
setCharge(int, int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
setCharge(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
setCharge(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
setCharge(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
setCharge(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
setCharge(int, int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 Charge = 7 [packed = true];
setCharge(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint32 Charge = 4 [packed = true];
setCharge(int, int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 Charge = 7 [packed = true];
setCharge(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Charge = 7 [packed = true];
setCharge(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint32 Charge = 4 [packed = true];
setCharge(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 charge = 18 [packed = true];
setCharge(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Charge = 4 [packed = true];
setCharge(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional sint32 charge = 6;
setChargeParity(float) - Method in class hephysics.particle.HEParticle
Set C charge conjugation parity
setChargeValues(float[]) - Method in class hep.lcio.implementation.event.ITrackerData
 
setChart(JFreeChart) - Method in class org.jfree.chart.ChartPanel
Sets the chart that is displayed in the panel.
setChart(JFreeChart) - Method in class org.jfree.chart.event.ChartChangeEvent
Sets the chart that generated the change event.
setChart(JFreeChart) - Method in class org.jfree.chart.event.ChartProgressEvent
Sets the chart that generated the change event.
setChart(JFreeChart) - Method in class org.jfree.chart.fx.ChartCanvas
Sets the chart to be displayed by this node.
setChart(JFreeChart) - Method in class org.jfree.chart.fx.ChartViewer
Sets the chart to be displayed by this node.
setChart(JFreeChart) - Method in class org.jfree.chart.fx.ChartViewerSkin
Sets the chart displayed by this control.
setChart(JFreeChart) - Method in class org.jfree.chart.PolarChartPanel
Sets the chart that is displayed in the panel.
setChartArea() - Method in class jhplot.HChart
Make an Area chart.
setChartArea(Rectangle2D) - Method in class org.jfree.chart.ChartRenderingInfo
Sets the area in which the chart was drawn.
setChartBackgroundPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the chart background paint.
setChartBar() - Method in class jhplot.HChart
Make a Bar chart.
setChartBar3D() - Method in class jhplot.HChart
Make a Bar chart in 3D.
setChartEditorFactory(ChartEditorFactory) - Static method in class org.jfree.chart.editor.ChartEditorManager
Sets the chart editor factory.
setChartLine() - Method in class jhplot.HChart
Make a line chart.
setChartLine(double) - Method in class jhplot.HChart
Make a line chart.
setChartPie() - Method in class jhplot.HChart
Make a Pie chart.
setChartPie3D() - Method in class jhplot.HChart
Make a Pie 3D chart.
setChartPolar() - Method in class jhplot.HChart
Make a chart using polar coordinates.
setChartTheme(ChartTheme) - Static method in class org.jfree.chart.ChartFactory
Sets the current chart theme.
setCheckAnalyticalDerivatives(boolean) - Method in class org.freehep.math.minuit.MnApplication
Minuit does a check of the user gradient at the beginning, if this is not wanted the set this to "false".
setChi2(float) - Method in class hep.lcio.implementation.event.ITrack
 
setChi2(float) - Method in class hep.lcio.implementation.event.IVertex
 
setChild(boolean) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setChildren(FileEntry...) - Method in class org.apache.commons.io.monitor.FileEntry
Set the directory's files.
setChipSpace(double) - Method in class org.jfree.data.general.WaferMapDataset
Sets the space to draw between chips.
setChiSquare(double) - Method in class org.jlab.groot.math.Func1D
 
setChromosomes(List<Chromosome>) - Method in class org.apache.commons.math3.genetics.ListPopulation
setCircular(boolean) - Method in class org.jfree.chart.plot.PiePlot
A flag indicating whether the pie chart is circular, or stretched into an elliptical shape.
setCircular(boolean, boolean) - Method in class org.jfree.chart.plot.PiePlot
Sets the circular attribute and, if requested, sends a PlotChangeEvent to all registered listeners.
setClip(boolean) - Method in class org.jfree.chart.ClipPath
Deprecated.
Sets the clip.
setClip(Shape) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the user clipping region.
setClip(int, int, int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the user clipping region to the specified rectangle.
setClipPath(ClipPath) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the clipPath.
setClippingDisabled(boolean) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the flag that controls whether or not clipping is disabled.
setCloseTickPaint(Paint) - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Sets the paint used to draw the ticks for the close values and sends a RendererChangeEvent to all registered listeners.
setClusters(List) - Method in class hep.lcio.implementation.event.ICluster
 
setClusters(List) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setClusters(int) - Method in class jminhep.algorithms.FuzzyCMeansAlg
Set number of clusters for calculations.
setClusters(int) - Method in class jminhep.algorithms.HierarchicalAlg
Sets number of clusters
setClusters(int) - Method in class jminhep.algorithms.KMeansAlg
Set the designed number of clusters
setClusters(int) - Method in class jminhep.algorithms.KMeansExchangeAlg
 
setCode(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
setCode(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
setCode(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
setCode(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 code = 13;
setColor(Color) - Method in class graph.TextLine
Set the Color to use with the class
setColor(Color) - Method in class jhplot.DrawOptions
Set color for lines
setColor(Color) - Method in class jhplot.HKey
Sets the color to a specific value
setColor(Color) - Method in class jhplot.HLabel
Sets the color to a specific value
setColor(Color) - Method in class jhplot.HLabelEq
Sets the color to a specific value
setColor(Color) - Method in class jhplot.HMLabel
Sets the color to a specific value
setColor(Color) - Method in class jhplot.shapes.HShape
Sets the color to a specific value
setColor(Color) - Method in class jplot.GraphLabel
Sets the color to a specific value
setColor(Color) - Method in class jplot.LinePars
Sets the color of the pen.
setColor(int) - Method in class jplot.LinePars
Sets the color of the pen from the swatch panel.
setColor(Color) - Method in class jplot.LineStyle
 
setColor(Color) - Method in class jplot.LineStyleButton
 
setColor(Color) - Method in class jplot.SmallColorPreview
 
setColor(Color) - Method in class jplot3d.JColor
 
setColor(Color) - Method in class net.java.dev.colorchooser.ColorChooser
Set the color this color chooser currently represents.
setColor(Color) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the foreground color.
setColor(int, int, int, int, int) - Static method in class org.jlab.groot.base.ColorPalette
 
setColor(int, int, int, int) - Static method in class org.jlab.groot.base.ColorPalette
 
setColor(int) - Method in class org.jlab.groot.ui.LatexText
 
setColorBackgroud(Color) - Method in class jhplot.HLabelEq
Set background color
setColorBarAxis(ColorBar) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the colorbar for the plot.
setColorBarLocation(RectangleEdge) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the color bar location and sends a PlotChangeEvent to all registered listeners.
setColorErrorsFill(Color) - Method in class jplot.LinePars
set color for fill errors
setColorErrorsFillSys(Color) - Method in class jplot.LinePars
set color for fill errors (systematical errors)
setColorErrorsSysX(Color) - Method in class jplot.LinePars
set color sys errors on X
setColorErrorsSysY(Color) - Method in class jplot.LinePars
set color sys errors on Y
setColorErrorsX(Color) - Method in class jplot.LinePars
set color errors on X
setColorErrorsY(Color) - Method in class jplot.LinePars
set color errors on Y
setColorFill(Color) - Method in class jhplot.HPlot3D
Set color of to fill histogram bars
setColorFlow(int[]) - Method in class hep.lcio.implementation.event.IMCParticle
 
setColorLines(Color) - Method in class jhplot.HPlot3D
Set color of the lines to draw histogram bars
setColorMode(int) - Method in class jhplot.HPlot3D
Sets the color mode
setColorPalette(ColorPalette) - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Sets the color palette.
setColumn(int, T[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in column number column as a column matrix.
setColumn(int, double[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified column of this matrix to the entries of the specified array.
setColumn(int, T[]) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in column number column as a column matrix.
setColumn(int, double[]) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified column of this matrix to the entries of the specified array.
setColumn(int, T[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in column number column as a column matrix.
setColumn(int, double[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified column of this matrix to the entries of the specified array.
setColumnKey(Comparable) - Method in class org.jfree.chart.entity.CategoryItemEntity
Sets the column key.
setColumnKey(Comparable) - Method in class org.jfree.chart.plot.CategoryCrosshairState
Sets the column key.
setColumnMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in column number column as a column matrix.
setColumnMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified column of this matrix to the entries of the specified column matrix.
setColumnMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in column number column as a column matrix.
setColumnMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified column of this matrix to the entries of the specified column matrix.
setColumnMatrix(int, FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in column number column as a column matrix.
setColumnMatrix(int, RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified column of this matrix to the entries of the specified column matrix.
setColumnRadius(int) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the column radius (in Java2D units) and sends a PlotChangeEvent to all registered listeners.
setColumnRenderingOrder(SortOrder) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the column order in which the items in each dataset should be rendered and sends a PlotChangeEvent to all registered listeners.
setColumns(int) - Method in class jplot.Utils.LabeledTextField
 
setColumnSeparator(String) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the string separating any two columns from another.
setColumnVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in column number column as a vector.
setColumnVector(int, RealVector) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified column of this matrix to the entries of the specified vector.
setColumnVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in column number column as a vector.
setColumnVector(int, RealVector) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified column of this matrix to the entries of the specified vector.
setColumnVector(int, FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in column number column as a vector.
setColumnVector(int, RealVector) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified column of this matrix to the entries of the specified vector.
setCommand(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
setCompletePaint(Paint) - Method in class org.jfree.chart.renderer.category.GanttRenderer
Sets the paint used to show the percentage complete and sends a RendererChangeEvent to all registered listeners.
setCompleteState(double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Set the complete current state.
setComplex() - Method in class jhplot.FND
Treat the function as complex.
setComposite(Composite) - Method in class org.jfree.chart.ClipPath
Deprecated.
Sets the composite.
setComposite(Composite) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the composite (only AlphaComposite is handled).
setCompressionLevel(int) - Method in interface hep.lcio.io.LCWriter
Set the compression level - needs to be called before open() otherwise call will have no effect.
setConnectFirstAndLastPoint(boolean) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Set the flag that controls whether the first and last point of a series will be connected or not and sends a RendererChangeEvent to all registered listeners.
setConstituents(ArrayList<Integer>) - Method in class hephysics.jet.ParticleD
 
setContentAlignmentPoint(TextBlockAnchor) - Method in class org.jfree.chart.block.LabelBlock
Sets the content alignment point.
setContents(double[], double[]) - Method in class jhplot.H1D
Sets the content of H1D histogram.
setContents(double[], double[], int[], double[], double[]) - Method in class jhplot.H1D
Set the content of the whole Histogram at once.
setContents(double[][], double[][]) - Method in class jhplot.H2D
Set content of H2D histogram
setContents(double[][], double[][], int[][], double[][], double[][], double[][], double[][]) - Method in class jhplot.H2D
Set the content of the whole Histogram at once.
setContents(double[], double[]) - Method in class jhplot.HProf1D
Sets the content of histogram.
setContents(double[], double[], int[], double[], double[]) - Method in class jhplot.HProf1D
Set the content of the whole Histogram at once.
setContents(double[][], double[][]) - Method in class jhplot.HProf2D
Set content of H2D histogram
setContinuousPalettePreferred(boolean) - Method in class net.java.dev.colorchooser.ColorChooser
Set whether the initial palette shown when clicked with no keys pressed is one showing a continuous (rainbow) palette or a set of tiles with different colors.
setContour(boolean) - Method in class jhplot.HPlot
Set to a contour style
setContour() - Method in class jhplot.HPlot3D
Set contour style
setContour(boolean) - Method in class jhplot.HPlot3D
Set contour style
setContour_bar(boolean) - Method in class jplot.GraphSettings
Set contour bar
setContour_binsX(int) - Method in class jplot.GraphSettings
set number of bins in X
setContour_binsY(int) - Method in class jplot.GraphSettings
set number of bins in Y
setContour_gray(boolean) - Method in class jplot.GraphSettings
set color
setContour_levels(int) - Method in class jplot.GraphSettings
Set number of leves
setContourBar(boolean) - Method in class jhplot.HPlot
Show or not a bar with color levels
setContourBins(int, int) - Method in class jhplot.HPlot
How many bins used to slice the data in X (and Y)
setContourColor(Color) - Method in class graph.Contour
Set the contour's color.
setContourColor(Color) - Method in class jplot.Contour
Set the contour's color.
setContourGray(boolean) - Method in class jhplot.HPlot
Color style to show contour plot.
setContourLevels(int) - Method in class jhplot.HPlot
How many color levels shuul be shown (10 default)
setContourLines(int) - Method in class jhplot.HPlot3D
Set number of divisions for contour plots
setContourLines(int) - Method in class jplot3d.SurfaceModelCanvas
 
setContourType(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setContractionCriteria(float) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
As of 3.1 (to be removed in 4.0 as field will become "final").
setControl_matrix(Matrix) - Method in class jhplot.math.kalman.JKalman
Setter
setControlFactors(double, double, double, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Set the step size control factors.
setCosthRange(double, double) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Select the cosine theta range between -1 and 1.
setCounterClockwise(boolean) - Method in class org.jfree.chart.plot.PolarPlot
Sets the flag for increasing angle degrees direction.
setCovMatrix(float[]) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setCovMatrix(float[]) - Method in class hep.lcio.implementation.event.ITrack
 
setCovMatrix(float[]) - Method in class hep.lcio.implementation.event.ITrackerHit
 
setCovMatrix(float[]) - Method in class hep.lcio.implementation.event.ITrackerPulse
 
setCovMatrix(float[]) - Method in class hep.lcio.implementation.event.ITrackState
 
setCovMatrix(float[]) - Method in class hep.lcio.implementation.event.IVertex
 
setCreatedInSimulation(boolean) - Method in class hep.lcio.implementation.event.IMCParticle
 
setCreateEntities(Boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesCreateEntities(int, Boolean) and AbstractRenderer.setBaseCreateEntities(boolean).
setCreateEntities(Boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesItemLabelFont(int, Font, boolean) and AbstractRenderer.setBaseItemLabelFont(Font, boolean).
setCrosshairDatasetIndex(int) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the dataset index for the crosshair and sends a PlotChangeEvent to all registered listeners.
setCrosshairDatasetIndex(int, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the dataset index for the crosshair and, if requested, sends a PlotChangeEvent to all registered listeners.
setCrosshairDistance(double) - Method in class org.jfree.chart.plot.CrosshairState
Sets the distance between the anchor point and the current crosshair point.
setCrosshairPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the crosshair paint.
setCrosshairState(CategoryCrosshairState) - Method in class org.jfree.chart.renderer.category.CategoryItemRendererState
Sets the crosshair state.
setCrosshairX(double) - Method in class org.jfree.chart.plot.CrosshairState
Sets the x coordinate for the crosshair.
setCrosshairY(double) - Method in class org.jfree.chart.plot.CrosshairState
Sets the y coordinate for the crosshair.
setCrossSection(double) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
setCrossSection(double) - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
setCrossSection(double) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
setCrossSection(double) - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
setCrossSection(double) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
setCrossSection(double) - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
setCrossSection(double) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section = 14;
setCrossSection(double) - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section = 2;
setCrossSectionAccumulated(double) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
setCrossSectionAccumulated(double) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
setCrossSectionAccumulated(double) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
setCrossSectionAccumulated(double) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_accumulated = 3;
setCrossSectionError(double) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
setCrossSectionError(double) - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
setCrossSectionError(double) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
setCrossSectionError(double) - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
setCrossSectionError(double) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
setCrossSectionError(double) - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
setCrossSectionError(double) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double cross_section_error = 15;
setCrossSectionError(double) - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required double cross_section_error = 3;
setCrossSectionErrorAccumulated(double) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
setCrossSectionErrorAccumulated(double) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
setCrossSectionErrorAccumulated(double) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
setCrossSectionErrorAccumulated(double) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double cross_section_error_accumulated = 4;
setCurNumberOfParameters(int) - Method in class org.nfunk.jep.function.PostfixMathCommand
Sets the number of current number of parameters used in the next call of run().
setCurNumberOfParameters(int) - Method in interface org.nfunk.jep.function.PostfixMathCommandI
Sets the number of current number of parameters used in the next call of run().
setCursor(double) - Method in class org.jfree.chart.axis.AxisState
Sets the cursor position.
setD(double) - Method in class jplot3d.JPoint
Set the current distance value.
setD0(float) - Method in class hep.lcio.implementation.event.ITrack
 
setD0(float) - Method in class hep.lcio.implementation.event.ITrackState
 
setDa(int, double) - Method in class promc.io.PEventFile.HEvent.Builder
repeated double da = 3 [packed = true];
setDa(int, double) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated double da = 3 [packed = true];
setDarkerSides(boolean) - Method in class org.jfree.chart.plot.PiePlot3D
Sets a flag that controls whether or not the sides of the pie chart are rendered using a darker colour, and sends a PlotChangeEvent to all registered listeners.
setDashed(double) - Method in class jhplot.shapes.HShape
Set dashed line
setDashLength(float) - Method in class jplot.LinePars
Sets the dash length of the pen
setDashLength(float, int) - Method in class jplot.LinePars
Sets the dash length of the pen.
setData(double[][]) - Method in class jhplot.VHolder
Set data from 2D array
setData(double[]) - Method in class jhplot.VHolder
Set data from 1D array
setData(String, String) - Method in class jplot.XMLWrite
Adds data between within the scope of a tag.
setData(String, double) - Method in class jplot.XMLWrite
Adds data between within the scope of a tag.
setData(String, int) - Method in class jplot.XMLWrite
Adds data between within the scope of a tag.
setData(double[]) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Set the data array.
setData(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Set the data array.
setData(double[]) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Set the data array.
setData(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Set the data array.
setData(float[][]) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the data array used by the plot and sends a PlotChangeEvent to all registered listeners.
setData(List<IDataSet>) - Method in class org.jlab.groot.graphics.EmbeddedCanvasGroup
 
setDataArea(Rectangle2D) - Method in class org.jfree.chart.plot.PlotRenderingInfo
Sets the data area.
setDataAreaRatio(double) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the data area ratio.
setDataArray(DataArray) - Method in class jhplot.P1D
Set data in a form of DataArray
setDataArray(DataArray2D) - Method in class jhplot.P2D
Set data in a form of DataArray
setDataArray(DataArray3D) - Method in class jhplot.P3D
Set data in a form of DataArray
setDataAvailability(boolean) - Method in class jplot3d.JSurface
Sets the data availability flag.
setDataBackground(Color) - Method in class graph.Graph2D
Set the background color for the data window.
setDataBackground(Color) - Method in class jplot.Contour
Set the background color for the data window.
setDataBoundsIncludesVisibleSeriesOnly(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether or not the data bounds reported by this renderer will exclude non-visible series and sends a RendererChangeEvent to all registered listeners.
setDataBufferBin(int, float) - Method in class org.jlab.groot.data.H2F
 
setDataChanged(boolean) - Method in class jplot.DataChangeListener
Allows to set the flag indicating that the data has changed to true or false.
setDataChanged(boolean) - Method in class jplot.LinePars
Sets to true if the data has been changed by the user.
setDataExtractOrder(TableOrder) - Method in class org.jfree.chart.plot.MultiplePiePlot
Sets the data extract order (by row or by column) and sends a PlotChangeEvent to all registered listeners.
setDataExtractOrder(TableOrder) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the data extract order (by row or by column) and sends a PlotChangeEventto all registered listeners.
setDataFileIndex(int) - Method in class jplot.panels.PanelPlot
Sets the index of the current datafile.
setDataLocation(double, double) - Method in class jplot.GraphLabel
Sets the location of this label in data coordinates.
setDataPers(DataArray) - Method in class jhplot.HPlot
Sets the data in the form DataArray data
setDataRotation(double) - Method in class jplot.GraphLabel
Sets the rotation angle.
setDataset(CategoryDataset) - Method in class org.jfree.chart.entity.CategoryItemEntity
Sets the dataset this entity refers to.
setDataset(Dataset) - Method in class org.jfree.chart.entity.LegendItemEntity
Sets a reference to the dataset that this legend item is derived from.
setDataset(PieDataset) - Method in class org.jfree.chart.entity.PieSectionEntity
Sets the dataset this entity refers to.
setDataset(XYDataset) - Method in class org.jfree.chart.entity.XYItemEntity
Sets the dataset this entity refers to.
setDataset(Dataset) - Method in class org.jfree.chart.LegendItem
Sets the dataset.
setDataset(CategoryDataset) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the dataset for the plot, replacing the existing dataset, if there is one.
setDataset(int, CategoryDataset) - Method in class org.jfree.chart.plot.CategoryPlot
Sets a dataset for the plot and sends a change notification to all registered listeners.
setDataset(ContourDataset) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the dataset for the plot, replacing the existing dataset if there is one.
setDataset(ValueDataset) - Method in class org.jfree.chart.plot.dial.DialPlot
Sets the dataset for the plot, replacing the existing dataset, if there is one, and sends a PlotChangeEvent to all registered listeners.
setDataset(int, ValueDataset) - Method in class org.jfree.chart.plot.dial.DialPlot
Sets a dataset for the plot.
setDataset(ValueDataset) - Method in class org.jfree.chart.plot.MeterPlot
Sets the dataset for the plot, replacing the existing dataset if there is one, and triggers a PlotChangeEvent.
setDataset(CategoryDataset) - Method in class org.jfree.chart.plot.MultiplePiePlot
Sets the dataset used by the plot and sends a PlotChangeEvent to all registered listeners.
setDataset(PieDataset) - Method in class org.jfree.chart.plot.PiePlot
Sets the dataset and sends a DatasetChangeEvent to 'this'.
setDataset(XYDataset) - Method in class org.jfree.chart.plot.PolarPlot
Sets the primary dataset for the plot, replacing the existing dataset if there is one, and sends a link PlotChangeEvent to all registered listeners.
setDataset(int, XYDataset) - Method in class org.jfree.chart.plot.PolarPlot
Sets a dataset for the plot, replacing the existing dataset at the same index if there is one, and sends a link PlotChangeEvent to all registered listeners.
setDataset(CategoryDataset) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the dataset used by the plot and sends a PlotChangeEvent to all registered listeners.
setDataset(ValueDataset) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the dataset for the plot, replacing the existing dataset if there is one, and sends a PlotChangeEvent to all registered listeners.
setDataset(WaferMapDataset) - Method in class org.jfree.chart.plot.WaferMapPlot
Sets the dataset used by the plot and sends a PlotChangeEvent to all registered listeners.
setDataset(XYDataset) - Method in class org.jfree.chart.plot.XYPlot
Sets the primary dataset for the plot, replacing the existing dataset if there is one.
setDataset(int, XYDataset) - Method in class org.jfree.chart.plot.XYPlot
Sets a dataset for the plot and sends a change event to all registered listeners.
setDatasetIndex(int) - Method in class org.jfree.chart.LegendItem
Sets the dataset index for this legend item.
setDatasetIndex(int) - Method in class org.jfree.chart.plot.CrosshairState
Sets the dataset index that the current crosshair values relate to.
setDatasetIndex(int) - Method in class org.jfree.chart.plot.dial.DialPointer
Sets the dataset index for the pointer and sends a DialLayerChangeEvent to all registered listeners.
setDatasetIndex(int) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the dataset index and sends a DialLayerChangeEvent to all registered listeners.
setDatasetPlotters(List<IDataSetPlotter>) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setDatasetRenderingOrder(DatasetRenderingOrder) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the rendering order and sends a PlotChangeEvent to all registered listeners.
setDatasetRenderingOrder(DatasetRenderingOrder) - Method in class org.jfree.chart.plot.XYPlot
Sets the rendering order and sends a PlotChangeEvent to all registered listeners.
setDatasetType(int) - Method in class org.jlab.groot.base.DatasetAttributes
 
setDateFormat(int, Locale) - Method in class org.jfree.chart.title.DateTitle
Set the format of the date.
setDateFormatOverride(DateFormat) - Method in class org.jfree.chart.axis.DateAxis
Sets the date format override and sends an AxisChangeEvent to all registered listeners.
setDaughter1(int, int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
setDaughter1(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
setDaughter1(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter1 = 10 [packed = true];
setDaughter2(int, int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
setDaughter2(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
setDaughter2(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 daughter2 = 11 [packed = true];
setDayFormatter(NumberFormat) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the formatter for the days.
setDaySuffix(String) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the string that is appended to the day count.
setDebug(boolean) - Method in class hephysics.jet.JetN2
Print debugging information.
setDebug(boolean) - Method in class hephysics.jet.KTjet
Print debugging information.
setDebug(boolean) - Method in class hephysics.jet.SCJet
Print debugging information.
setDebugStream(PrintStream) - Method in class jplot3dp.MathParser.MathParserTokenManager
 
setDebugStream(PrintStream) - Method in class org.nfunk.jep.ParserTokenManager
 
setDecayedInCalorimeter(boolean) - Method in class hep.lcio.implementation.event.IMCParticle
 
setDecayedInTracker(boolean) - Method in class hep.lcio.implementation.event.IMCParticle
 
setdEdx(float) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setDEdx(float) - Method in class hep.lcio.implementation.event.ITrack
 
setdEdx(float) - Method in class hep.lcio.implementation.event.ITrackerHit
 
setdEdx(float) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setdEdx(float) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setDEdxError(float) - Method in class hep.lcio.implementation.event.ITrack
 
setDefault() - Method in class hep.lcio.implementation.event.ILCCollection
 
setDefault(boolean) - Method in class hep.lcio.implementation.event.ILCCollection
 
setDefault() - Method in class jhplot.gui.GHMargin
Set the default location
setDefault(Object) - Method in class jhplot.gui.GHMargin
Set the default location
setDefault() - Method in class org.jlab.groot.base.DatasetAttributes
 
setDefaultAutoRange(Range) - Method in class org.jfree.chart.axis.ValueAxis
Sets the default auto range and sends an AxisChangeEvent to all registered listeners.
setDefaultBarPainter(BarPainter) - Static method in class org.jfree.chart.renderer.category.BarRenderer
Sets the default bar painter.
setDefaultBarPainter(XYBarPainter) - Static method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the default bar painter.
setDefaultDirectoryForSaveAs(File) - Method in class org.jfree.chart.ChartPanel
Sets the default directory for the "save as" option.
setDefaultEntityRadius(int) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the radius of the circle used for the default entity area when no area is specified.
setDefaultPosition(boolean) - Method in class jhplot.HKey
Is this key should be set at a default position?
setDefaultShadowsVisible(boolean) - Static method in class org.jfree.chart.renderer.category.BarRenderer
Sets the default value for the shadows visible flag.
setDefaultShadowsVisible(boolean) - Static method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the default value for the shadows visible flag.
setDefaultValue(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
setDefinition(String) - Method in class promc.io.PBufFile.Record.F1D.Builder
required string definition = 2;
setDefinition(String) - Method in class promc.io.PBufFile.Record.F2D.Builder
required string definition = 2;
setDefinition(String) - Method in class promc.io.PBufFile.Record.FND.Builder
required string definition = 2;
setDefinition(String) - Method in class promc.io.PBufFile.Record.FPR.Builder
required string definition = 2;
setDefinitionBytes(ByteString) - Method in class promc.io.PBufFile.Record.F1D.Builder
required string definition = 2;
setDefinitionBytes(ByteString) - Method in class promc.io.PBufFile.Record.F2D.Builder
required string definition = 2;
setDefinitionBytes(ByteString) - Method in class promc.io.PBufFile.Record.FND.Builder
required string definition = 2;
setDefinitionBytes(ByteString) - Method in class promc.io.PBufFile.Record.FPR.Builder
required string definition = 2;
setDegreesOfFreedom(double) - Method in class jhplot.math.num.pdf.ChiSquared
Modify the degrees of freedom.
setDegreesOfFreedom(double) - Method in class jhplot.math.num.pdf.TDistribution
Modify the degrees of freedom.
setDeltaEta(int, int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
setDeltaEta(int, int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
setDeltaEta(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaEta = 8 [packed = true];
setDeltaPhi(int, int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
setDeltaPhi(int, int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
setDeltaPhi(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint32 DeltaPhi = 9 [packed = true];
setDenominatorDegreesOfFreedom(double) - Method in class jhplot.math.num.pdf.FDistribution
Modify the denominator degrees of freedom.
setDenominatorFormat(NumberFormat) - Method in class org.apache.commons.math3.fraction.AbstractFormat
Modify the denominator format.
setDensity() - Method in class jhplot.HPlot3D
Set density type of plot
setDensity(boolean) - Method in class jhplot.HPlot3D
Set density plot
setDensityType(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setDepthFactor(double) - Method in class org.jfree.chart.plot.PiePlot3D
Sets the pie depth as a percentage of the height of the plot area, and sends a PlotChangeEvent to all registered listeners.
setDerivative(Function) - Method in class jhplot.math.num.root.NewtonRootFinder
Modify the derivative of the target function.
setDescDataset(List<IDataSet>) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setDescName(String) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setDescription(String) - Method in class hep.lcio.implementation.event.ILCRunHeader
 
setDescription(String) - Method in class jhplot.io.HBook
Set a desciption which will be attached to the header of the output file.
setDescription(String) - Method in class org.jfree.chart.LegendItem
Sets the description for this legend item.
setDescription(String) - Method in class org.jfree.data.gantt.Task
Sets the task description.
setDescription(String) - Method in class org.jfree.data.general.Series
Sets the description of the series and sends a PropertyChangeEvent to all registered listeners.
setDescription(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
setDescription(String) - Method in class org.jlab.groot.tree.Branch
 
setDescription(String) - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
setDescription(String) - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
setDescription(String) - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
setDescription(String) - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
setDescriptionBytes(ByteString) - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
setDescriptionBytes(ByteString) - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
setDescriptionBytes(ByteString) - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
setDescriptionBytes(ByteString) - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required string description = 3;
setDescriptorType(int) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setDetectorName(String) - Method in class hep.lcio.implementation.event.ILCEvent
 
setDetectorName(String) - Method in class hep.lcio.implementation.event.ILCRunHeader
 
setDialBackgroundPaint(Paint) - Method in class org.jfree.chart.plot.MeterPlot
Sets the paint used to fill the dial background.
setDialFrame(DialFrame) - Method in class org.jfree.chart.plot.dial.DialPlot
Sets the dial's frame and sends a PlotChangeEvent to all registered listeners.
setDialOutlinePaint(Paint) - Method in class org.jfree.chart.plot.MeterPlot
Sets the dial outline paint and sends a PlotChangeEvent to all registered listeners.
setDialShape(DialShape) - Method in class org.jfree.chart.plot.MeterPlot
Sets the dial shape and sends a PlotChangeEvent to all registered listeners.
setDim(Dimensions) - Method in class org.lsmp.djep.matrixJep.nodeTypes.ASTMFunNode
 
setDimension(int) - Method in class jhplot.P1D
Set the dimension for the container.
setDimension(int) - Method in class jplot.DataArray
Set the dimension of this data
setDimension(int, int, int, int) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setDimension(int, int) - Method in class org.jlab.groot.graphics.GraphicsAxis
sets the dimension for the axis for plotting.
setDimension(int, int) - Method in class org.jlab.groot.ui.GraphicsAxis
sets the dimension for the axis for plotting.
setDimension(int) - Method in class promc.io.PBufFile.Record.PND.Builder
required int32 dimension = 3;
setDimension(int) - Method in class promc.io.PBufFile.Record.PNI.Builder
required int32 dimension = 3;
setDimensions(int...) - Method in class org.jlab.groot.math.MultiIndex
Sets the dimension sizes at each index and initializes every element of the current index to -1.
setDimensions(Dimensions) - Method in class org.lsmp.djep.matrixJep.MatrixPartialDerivative
 
setDimensions(Dimensions) - Method in class org.lsmp.djep.matrixJep.MatrixVariable
 
setDimensions(Dimensions) - Method in interface org.lsmp.djep.matrixJep.MatrixVariableI
Sets the dimension of the variable.
setDimention(int) - Method in class jminhep.cluster.DataHolder
Set the dimension of the data
setDirection(Rotation) - Method in class org.jfree.chart.plot.PiePlot
Sets the direction in which the pie sections are drawn and sends a PlotChangeEvent to all registered listeners.
setDirection(Rotation) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the direction in which the radar axes are drawn and sends a PlotChangeEvent to all registered listeners.
setDirectionError(float[]) - Method in class hep.lcio.implementation.event.ICluster
 
setDirectory(boolean) - Method in class org.apache.commons.io.monitor.FileEntry
Set whether the file is a directory or not.
setDirectory(TDirectory) - Method in class org.jlab.groot.ui.TBrowser
 
setDismissDelay(int) - Method in class org.jfree.chart.ChartPanel
Specifies the dismissal delay value for this chart panel.
setDispDivisions(int) - Method in class jplot3d.SurfaceModelCanvas
 
setDisplayGrids(boolean) - Method in class jhplot.HPlot3D
Display grid
setDisplayGrids(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setDisplayRange(double, double) - Method in class org.jfree.chart.axis.ModuloAxis
Sets the display range.
setDisplayRange(int, double, double) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the displayed bounds for a sub range.
setDisplayToolTips(boolean) - Method in class org.jfree.chart.ChartPanel
Switches the display of tooltips for the panel on or off.
setDisplayXY(boolean) - Method in class jhplot.HPlot3D
Display or not X and Y
setDisplayXY(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setDisplayZ(boolean) - Method in class jhplot.HPlot3D
Display or not title for Z
setDisplayZ(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setDistance(double) - Method in class jhplot.HPlot3D
Set distance to the object
setDistance(float) - Method in class jplot3d.Projector
Sets the projector distance.
setDistance(float) - Method in class jplot3d.SurfaceModelCanvas
 
setDivisions(int, int) - Method in class jhplot.FPR
Set number of divisions for parameters.
setDivisions(int) - Method in class jhplot.HPlot3D
Set number of divisions for surface plots
setDivU(int) - Method in class promc.io.PBufFile.Record.FPR.Builder
required int32 divU = 3;
setDivV(int) - Method in class promc.io.PBufFile.Record.FPR.Builder
required int32 divV = 4;
setDomainAxes(CategoryAxis[]) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the domain axes for this plot and sends a PlotChangeEvent to all registered listeners.
setDomainAxes(ValueAxis[]) - Method in class org.jfree.chart.plot.XYPlot
Sets the domain axes for this plot and sends a PlotChangeEvent to all registered listeners.
setDomainAxis(CategoryAxis) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the domain axis for the plot and sends a PlotChangeEvent to all registered listeners.
setDomainAxis(int, CategoryAxis) - Method in class org.jfree.chart.plot.CategoryPlot
Sets a domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainAxis(int, CategoryAxis, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets a domain axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setDomainAxis(ValueAxis) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the domain axis for the plot (this must be compatible with the plot type or an exception is thrown).
setDomainAxis(ValueAxis) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainAxis(ValueAxis) - Method in class org.jfree.chart.plot.XYPlot
Sets the domain axis for the plot and sends a PlotChangeEvent to all registered listeners.
setDomainAxis(int, ValueAxis) - Method in class org.jfree.chart.plot.XYPlot
Sets a domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainAxis(int, ValueAxis, boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets a domain axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setDomainAxisLocation(AxisLocation) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the location of the domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainAxisLocation(AxisLocation, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the location of the domain axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setDomainAxisLocation(int, AxisLocation) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the location for a domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainAxisLocation(int, AxisLocation, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the location for a domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainAxisLocation(AxisLocation) - Method in class org.jfree.chart.plot.XYPlot
Sets the location of the primary domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainAxisLocation(AxisLocation, boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the location of the domain axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setDomainAxisLocation(int, AxisLocation) - Method in class org.jfree.chart.plot.XYPlot
Sets the location for a domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainAxisLocation(int, AxisLocation, boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the axis location for a domain axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setDomainCrosshairColumnKey(Comparable) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the column key for the domain crosshair and sends a PlotChangeEvent to all registered listeners.
setDomainCrosshairColumnKey(Comparable, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the column key for the domain crosshair and, if requested, sends a PlotChangeEvent to all registered listeners.
setDomainCrosshairLockedOnData(boolean) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the flag indicating whether or not the domain crosshair should "lock-on" to actual data values.
setDomainCrosshairLockedOnData(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag indicating whether or not the domain crosshair should "lock-on" to actual data values.
setDomainCrosshairPaint(Paint) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the paint used to draw the domain crosshair.
setDomainCrosshairPaint(Paint) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the Paint used to color the crosshairs (if visible) and notifies registered listeners that the axis has been modified.
setDomainCrosshairPaint(Paint) - Method in class org.jfree.chart.plot.XYPlot
Sets the paint used to draw the crosshairs (if visible) and sends a PlotChangeEvent to all registered listeners.
setDomainCrosshairRowKey(Comparable) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the row key for the domain crosshair and sends a {PlotChangeEvent} to all registered listeners.
setDomainCrosshairRowKey(Comparable, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the row key for the domain crosshair and, if requested, sends a {PlotChangeEvent} to all registered listeners.
setDomainCrosshairStroke(Stroke) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the stroke used to draw the domain crosshair, and sends a PlotChangeEvent to all registered listeners.
setDomainCrosshairStroke(Stroke) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the Stroke used to draw the crosshairs (if visible) and notifies registered listeners that the axis has been modified.
setDomainCrosshairStroke(Stroke) - Method in class org.jfree.chart.plot.XYPlot
Sets the Stroke used to draw the crosshairs (if visible) and notifies registered listeners that the axis has been modified.
setDomainCrosshairValue(double) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the domain crosshair value.
setDomainCrosshairValue(double, boolean) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the domain crosshair value.
setDomainCrosshairValue(double) - Method in class org.jfree.chart.plot.XYPlot
Sets the domain crosshair value and sends a PlotChangeEvent to all registered listeners (provided that the domain crosshair is visible).
setDomainCrosshairValue(double, boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the domain crosshair value and, if requested, sends a PlotChangeEvent to all registered listeners (provided that the domain crosshair is visible).
setDomainCrosshairVisible(boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the flag that controls whether or not the domain crosshair is displayed by the plot, and sends a PlotChangeEvent to all registered listeners.
setDomainCrosshairVisible(boolean) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the flag indicating whether or not the domain crosshair is visible.
setDomainCrosshairVisible(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag indicating whether or not the domain crosshair is visible and, if the flag changes, sends a PlotChangeEvent to all registered listeners.
setDomainDescription(String) - Method in class org.jfree.data.time.TimePeriodValues
Sets the domain description and fires a property change event (with the property name Domain if the description changes).
setDomainDescription(String) - Method in class org.jfree.data.time.TimeSeries
Sets the domain description and sends a PropertyChangeEvent (with the property name Domain) to all registered property change listeners.
setDomainGridlinePaint(Paint) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the paint used to draw the grid-lines (if any) against the domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainGridlinePaint(Paint) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the paint for the grid lines plotted against the domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainGridlinePaint(Paint) - Method in class org.jfree.chart.plot.XYPlot
Sets the paint for the grid lines plotted against the domain axis, and sends a PlotChangeEvent to all registered listeners.
setDomainGridlinePaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the domain grid line paint.
setDomainGridlinePosition(CategoryAnchor) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the position used for the domain gridlines and sends a PlotChangeEvent to all registered listeners.
setDomainGridlineStroke(Stroke) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the stroke used to draw grid-lines against the domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainGridlineStroke(Stroke) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the stroke for the grid lines plotted against the domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainGridlineStroke(Stroke) - Method in class org.jfree.chart.plot.XYPlot
Sets the stroke for the grid lines plotted against the domain axis, and sends a PlotChangeEvent to all registered listeners.
setDomainGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the flag that controls whether or not grid-lines are drawn against the domain axis.
setDomainGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the flag that controls whether or not the domain grid-lines are visible.
setDomainGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag that controls whether or not the domain grid-lines are visible.
setDomainIsPointsInTime(boolean) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Deprecated.
This flag is no longer used by JFreeChart (as of version 1.0.3).
setDomainIsPointsInTime(boolean) - Method in class org.jfree.data.time.TimeSeriesCollection
Deprecated.
This flag is no longer used, as of 1.0.1. The includeInterval flag in methods such as TimeSeriesCollection.getDomainBounds(boolean) makes this unnecessary.
setDomainIsPointsInTime(boolean) - Method in class org.jfree.data.time.TimeTableXYDataset
Sets a flag that controls whether the domain is treated as 'points in time', or time periods.
setDomainMinorGridlinePaint(Paint) - Method in class org.jfree.chart.plot.XYPlot
Sets the paint for the minor grid lines plotted against the domain axis, and sends a PlotChangeEvent to all registered listeners.
setDomainMinorGridlineStroke(Stroke) - Method in class org.jfree.chart.plot.XYPlot
Sets the stroke for the minor grid lines plotted against the domain axis, and sends a PlotChangeEvent to all registered listeners.
setDomainMinorGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag that controls whether or not the domain minor grid-lines are visible.
setDomainPannable(boolean) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Sets the flag, on each of the subplots, that controls whether or not the domain is pannable.
setDomainPannable(boolean) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the flag that enables or disables panning of the plot along the domain axes.
setDomainPannable(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag that enables or disables panning of the plot along the domain axes.
setDomainTickBandPaint(Paint) - Method in class org.jfree.chart.plot.XYPlot
Sets the paint for the domain tick bands.
setDomainZeroBaselinePaint(Paint) - Method in class org.jfree.chart.plot.XYPlot
Sets the paint for the zero baseline plotted against the domain axis and sends a PlotChangeEvent to all registered listeners.
setDomainZeroBaselineStroke(Stroke) - Method in class org.jfree.chart.plot.XYPlot
Sets the stroke for the zero baseline for the domain axis, and sends a PlotChangeEvent to all registered listeners.
setDomainZeroBaselineVisible(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag that controls whether or not the zero baseline is displayed for the domain axis, and sends a PlotChangeEvent to all registered listeners.
setDomainZoomable(boolean) - Method in class org.jfree.chart.ChartPanel
Sets the flag that controls whether or not zooming is enabled for the domain axis.
setDotHeight(int) - Method in class org.jfree.chart.renderer.xy.XYDotRenderer
Sets the dot height and sends a RendererChangeEvent to all registered listeners.
setDotted(double) - Method in class jhplot.shapes.HShape
Set dotted line
setDotWidth(int) - Method in class org.jfree.chart.renderer.xy.XYDotRenderer
Sets the dot width and sends a RendererChangeEvent to all registered listeners.
setDoubleArrayLists(DoubleArrayList, DoubleArrayList, DoubleArrayList) - Method in class jhplot.P2D
Set the array from DoubleArrayLists
setDoubleVal(double, int) - Method in class hep.lcio.implementation.event.ILCGenericObject
Sets the double value at index - resizes the array if needed, thus it is more efficient to fill the largest index first.
setDoubleVals(double[]) - Method in class hep.lcio.implementation.event.ILCGenericObject
Set all double values at once
setDownArrow(Shape) - Method in class org.jfree.chart.axis.ValueAxis
Sets the shape that can be displayed as an arrow pointing downwards at the end of an axis line and sends an AxisChangeEvent to all registered listeners.
setDownPaint(Paint) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Sets the paint used to fill candles when the price moves down from open to close and sends a RendererChangeEvent to all registered listeners.
setDrawAsLine(boolean) - Method in class org.jfree.chart.plot.CategoryMarker
Sets the flag that controls whether the marker is drawn as a region or as a line, and sends a MarkerChangeEvent to all registered listeners.
setDrawAxis(int, boolean) - Method in class jplot.GraphSettings
Sets whether an axis will be drawn or not.
setDrawAxis(boolean) - Method in class org.jlab.groot.base.DatasetAttributes
 
setDrawAxisZ(boolean) - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
setDrawBarOutline(boolean) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the flag that controls whether or not bar outlines are drawn and sends a RendererChangeEvent to all registered listeners.
setDrawBarOutline(boolean) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the flag that controls whether or not bar outlines are drawn and sends a RendererChangeEvent to all registered listeners.
setDrawBorder(boolean) - Method in class org.jfree.chart.plot.CompassPlot
Sets a flag that controls whether or not a border is drawn.
setDrawBorder(boolean) - Method in class org.jfree.chart.plot.MeterPlot
Sets the flag that controls whether or not a rectangular border is drawn around the plot area and sends a PlotChangeEvent to all registered listeners.
setDrawBox(boolean) - Method in class jplot.GraphSettings
Sets whether or not to draw the bounding box arround the graph.
setDrawCloseTicks(boolean) - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Sets the flag that controls whether close ticks are drawn, and sends a RendererChangeEvent to all registered listeners.
setDrawFrame(boolean) - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
setDrawGrid(int, boolean) - Method in class jplot.GraphSettings
Sets whether or not using grid lines.
setDrawingComponent(Component) - Method in class graph.RTextLine
Set the Component the text will be drawn into.
setDrawingSupplier(DrawingSupplier) - Method in class org.jfree.chart.plot.Plot
Sets the drawing supplier for the plot and sends a PlotChangeEvent to all registered listeners.
setDrawingSupplier(DrawingSupplier, boolean) - Method in class org.jfree.chart.plot.Plot
Sets the drawing supplier for the plot and, if requested, sends a PlotChangeEvent to all registered listeners.
setDrawingSupplier(DrawingSupplier) - Method in class org.jfree.chart.StandardChartTheme
Sets the drawing supplier for this theme.
setDrawInner(boolean) - Method in class jplot.GraphSettings
Sets whether or not to draw the filled triangles.
setDrawLabels(boolean) - Method in class graph.Contour
If true contour levels are not labeled.
setDrawLegend(boolean) - Method in class jplot.GraphSettings
Sets whether or not to draw the legend.
setDrawLegend(boolean) - Method in class jplot.LinePars
Sets whether or not this linestyle should draw the name in the legend of the graph.
setDrawLine(boolean) - Method in class jhplot.DrawOptions
Draw lines connecting points or not.
setDrawLine(boolean) - Method in class jplot.LinePars
Sets whether or not drawing the line
setDrawLineKey(boolean) - Method in class jhplot.DrawOptions
Draw histogram key with line or not
setDrawLines(boolean) - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Sets the flag that controls whether or not lines are drawn to connect the items within a series and sends a RendererChangeEvent to all registered listeners.
setDrawMirrorAxis(int, boolean) - Method in class jplot.GraphSettings
Sets whether the mirror of an axis will be drawn or not.
setDrawMirrorTics(int, boolean) - Method in class jplot.GraphSettings
Sets true or false to draw mirror tics
setDrawOpenTicks(boolean) - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Sets the flag that controls whether open ticks are drawn, and sends a RendererChangeEvent to all registered listeners.
setDrawOption(LinePars) - Method in class jhplot.DrawOptions
Sets drawing attributes.
setDrawOptions(String) - Method in class org.jlab.groot.base.DatasetAttributes
 
setDrawOutlines(boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the flag that controls whether outlines are drawn for shapes, and sends a RendererChangeEvent to all registered listeners.
setDrawOutlines(boolean) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Sets the flag that controls whether outlines are drawn for shapes, and sends a RendererChangeEvent to all registered listeners.
setDrawOutlines(boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the flag that controls whether outlines are drawn for shapes, and sends a RendererChangeEvent to all registered listeners.
setDrawOutlines(boolean) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Sets the flag that controls whether outlines are drawn for shapes, and sends a RendererChangeEvent to all registered listeners.
setDrawOutlineWhenFilled(boolean) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Set the flag that controls whether the outline around a filled polygon will be drawn or not and sends a RendererChangeEvent to all registered listeners.
setDrawPaint(Paint) - Method in class org.jfree.chart.ClipPath
Deprecated.
Sets the drawPaint.
setDrawPath(boolean) - Method in class org.jfree.chart.ClipPath
Deprecated.
Sets the drawPath.
setDrawSeriesLineAsPath(boolean) - Method in class org.jfree.chart.renderer.xy.DeviationRenderer
This method is overridden so that this flag cannot be changed---it is set to true for this renderer.
setDrawSeriesLineAsPath(boolean) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Sets the flag that controls whether or not each series is drawn as a single path.
setDrawSeriesLineAsPath(boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the flag that controls whether or not each series is drawn as a single path and sends a RendererChangeEvent to all registered listeners.
setDrawSharedDomainAxis(boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the flag that controls whether the shared domain axis is drawn when this plot is being used as a subplot.
setDrawStroke(Stroke) - Method in class org.jfree.chart.ClipPath
Deprecated.
Sets the drawStroke.
setDrawSymbol(boolean) - Method in class jhplot.DrawOptions
Draw or not symbols
setDrawSymbol(boolean) - Method in class jplot.LinePars
Sets whether or not drawing the symbol
setDrawTds(boolean) - Method in class jplot.GraphSettings
Sets whether the tds should be drawn or not.
setDrawTicLabels(boolean) - Method in class jplot.GraphSettings
Sets whether all tic-labels will be written or not.
setDrawTicLabels(int, boolean) - Method in class jplot.GraphSettings
Sets whether ticlabels will be written or not.
setDrawTics(int, boolean) - Method in class jplot.GraphSettings
Sets whether or not to draw tics (little lines on the axes).
setDrawVolume(boolean) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Sets a flag that controls whether or not volume bars are drawn in the background and sends a RendererChangeEvent to all registered listeners.
setDrawXError(boolean) - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Sets the flag that controls whether or not the renderer draws error bars for the x-values and, if the flag changes, sends a RendererChangeEvent to all registered listeners.
setDrawYError(boolean) - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Sets the flag that controls whether or not the renderer draws error bars for the y-values and, if the flag changes, sends a RendererChangeEvent to all registered listeners.
setdRPhi(float) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setDtot(int) - Method in class jhplot.stat.ConfidenceLevel
 
setdU(float) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setDualShadeMode(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setDuration(TimePeriod) - Method in class org.jfree.data.gantt.Task
Sets the task duration (actual or estimated).
setdV(float) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setdZ(float) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setE(double) - Method in class hephysics.vec.HepLorentzVector
Set energy
setECM(double) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
setECM(double) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
setECM(double) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
setECM(double) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double eCM = 10;
setEDep(float) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setEDep(float) - Method in class hep.lcio.implementation.event.ITrackerHit
 
setEDep(float) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setEDep(float) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setEDepError(float) - Method in class hep.lcio.implementation.event.ITrackerHit
 
setEDepError(float) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setEDepError(float) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setEdges(int, double) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double edges = 7 [packed = true];
setEditable(boolean) - Method in class jplot.Utils.LabeledTextField
 
setEle(int, Object) - Method in class org.lsmp.djep.vectorJep.values.Matrix
 
setEle(int, int, Object) - Method in class org.lsmp.djep.vectorJep.values.Matrix
 
setEle(int, Object) - Method in interface org.lsmp.djep.vectorJep.values.MatrixValueI
sets the i-th element, treats data a a linear array.
setEle(int, Object) - Method in class org.lsmp.djep.vectorJep.values.MVector
 
setEle(int, Object) - Method in class org.lsmp.djep.vectorJep.values.Scaler
 
setEle(int, Object) - Method in class org.lsmp.djep.vectorJep.values.Tensor
 
setElectrons(ProMC.ProMCEvent.Electrons) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Electrons electrons = 6;
setElectrons(ProMC.ProMCEvent.Electrons.Builder) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Electrons electrons = 6;
setElement(int, int, double) - Method in class hep.physics.matrix.BasicMatrix
 
setElement(int, int, double) - Method in interface hep.physics.matrix.MutableMatrix
Set the given element of the matrix
setElement(int, int, double) - Method in class hep.physics.matrix.SymmetricMatrix
Set a specific element
setElement(int, int, double) - Method in class hep.physics.vec.BasicHep3Matrix
Sets the (row, column) element
setElement(int, int, double) - Method in class hephysics.matrix.BasicMatrix
 
setElement(int, int, double) - Method in interface hephysics.matrix.MutableMatrix
Set the given element of the matrix
setElement(int, int, double) - Method in class hephysics.matrix.SymmetricMatrix
Set a specific element
setElement(int, int, double) - Method in class hephysics.vec.Hep3Matrix
Sets the (row, column) element
setElement(int, double) - Method in interface org.apache.commons.math3.util.DoubleArray
Sets the element at the specified index.
setElement(int, double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Sets the element at the specified index.
setElementMultiply(boolean) - Method in class org.lsmp.djep.vectorJep.VectorJep
When set the multiplication of vectors and matrices will be element by element.
setElementMultiply(boolean) - Method in class org.lsmp.djep.vectorJep.VOperatorSet
When set the multiplication of vectors and matricies will be element by element.
setEles(MatrixValueI) - Method in class org.lsmp.djep.vectorJep.values.Matrix
sets the elements to those of the arguments.
setEles(MatrixValueI) - Method in interface org.lsmp.djep.vectorJep.values.MatrixValueI
sets the elements to those of the arguments.
setEles(MatrixValueI) - Method in class org.lsmp.djep.vectorJep.values.MVector
sets the elements to those of the arguments.
setEles(MatrixValueI) - Method in class org.lsmp.djep.vectorJep.values.Scaler
sets the elements to those of the arguments.
setEles(MatrixValueI) - Method in class org.lsmp.djep.vectorJep.values.Tensor
sets the elements to those of the arguments.
setElevationAngle(double) - Method in class jhplot.HPlot3D
Set the elevation angle
setElevationAngle(float) - Method in class jplot3d.Projector
Sets the elevation angle.
setElevationAngle(float) - Method in class jplot3d.SurfaceModelCanvas
 
setElitismRate(double) - Method in class org.apache.commons.math3.genetics.ElitisticListPopulation
Sets the elitism rate, i.e.
setEmbeddedPad(EmbeddedPad) - Method in class org.jlab.groot.graphics.EmbeddedPad.EmbeddedPadConfigurationPane
 
setEmpty() - Method in class jplot3d.JSurfacePanel
Set empty frame
setEmpty() - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
setEmpty() - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
Empty plot
setEnabled(boolean) - Method in class jplot.Utils.LabeledTextField
 
setEnabled(boolean) - Method in class org.jfree.chart.fx.interaction.AbstractMouseHandlerFX
Sets the flag that controls the enabled/disabled state of the handler.
setEncodingAlpha(boolean) - Method in interface org.jfree.chart.encoders.ImageEncoder
Set whether the encoder should encode alpha transparency (not supported by all ImageEncoders).
setEncodingAlpha(boolean) - Method in class org.jfree.chart.encoders.KeypointPNGEncoderAdapter
Set whether the encoder should encode alpha transparency (supported).
setEncodingAlpha(boolean) - Method in class org.jfree.chart.encoders.SunJPEGEncoderAdapter
Set whether the encoder should encode alpha transparency (this is not supported for JPEG, so this method does nothing).
setEncodingAlpha(boolean) - Method in class org.jfree.chart.encoders.SunPNGEncoderAdapter
Set whether the encoder should encode alpha transparency (not supported in this ImageEncoder).
setEndLength(double) - Method in class jhplot.shapes.Arrow
Set lenght of the ends
setEndPercent(double) - Method in class org.jfree.chart.renderer.category.GanttRenderer
Sets the position of the end of the progress indicator, as a percentage of the bar width, and sends a RendererChangeEvent to all registered listeners.
setEndpoint(double[]) - Method in class hep.lcio.implementation.event.IMCParticle
 
setEndType(AreaRendererEndType) - Method in class org.jfree.chart.renderer.category.AreaRenderer
Sets a token that controls how the renderer draws the end points, and sends a RendererChangeEvent to all registered listeners.
setEndValue(double) - Method in class org.jfree.chart.plot.IntervalMarker
Sets the end value for the marker and sends a MarkerChangeEvent to all registered listeners.
setEndValue(int, Comparable, Number) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Sets the end data value for one category in a series.
setEndWidth(double) - Method in class jhplot.shapes.Arrow
Set width of the ends
setEnergy(float) - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
setEnergy(float) - Method in class hep.lcio.implementation.event.ICluster
 
setEnergy(float) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setEnergy(float) - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
setEnergy(double) - Method in class hephysics.jet.ParticleD
Set energy.
setEnergy(int, float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float energy = 19 [packed = true];
setEnergy(int, long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 energy = 19 [packed = true];
setEnergy(int, long) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Energy = 3 [packed = true];
setEnergy(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Energy = 4 [packed = true];
setEnergyError(float) - Method in class hep.lcio.implementation.event.ICluster
 
setEnforceFileExtensions(boolean) - Method in class org.jfree.chart.ChartPanel
Sets a flag that controls whether or not file extensions are enforced.
setEntityCollection(EntityCollection) - Method in class org.jfree.chart.block.BlockResult
Sets the entities for the block.
setEntityCollection(EntityCollection) - Method in class org.jfree.chart.ChartRenderingInfo
Sets the entity collection.
setEntries(int, int) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated int32 entries = 6 [packed = true];
setEntries(int, int) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated int32 entries = 6 [packed = true];
setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Set the entry in the specified row and column.
setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Set the entry in the specified row and column.
setEntry(int, T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Set a single element.
setEntry(int, double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Set a single element.
setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Set the entry in the specified row and column.
setEntry(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entry in the specified row and column.
setEntry(int, T) - Method in interface org.apache.commons.math3.linear.FieldVector
Set a single element.
setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Set the entry in the specified row and column.
setEntry(int, double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Set a single element.
setEntry(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Set the entry in the specified row and column.
setEntry(int, double) - Method in class org.apache.commons.math3.linear.RealVector
Set a single element.
setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Set the entry in the specified row and column.
setEntry(int, T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Set a single element.
setEntry(int, PEventFile.HEvent.Entry) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
setEntry(int, PEventFile.HEvent.Entry.Builder) - Method in class promc.io.PEventFile.HEvent.Group.Builder
repeated .promc.HEvent.Entry entry = 2;
SetEnv - Class in jhepsim
 
SetEnv() - Constructor for class jhepsim.SetEnv
 
SetEnv - Class in jminhep.gui
Class to keep some global variables
SetEnv() - Constructor for class jminhep.gui.SetEnv
 
setEpochMax(int) - Method in class jminhep.algorithms.KMeansExchangeAlg
 
setEquation(Node) - Method in class org.lsmp.djep.djep.DVariable
sets the equation
setEquation(Node) - Method in class org.lsmp.djep.xjep.XVariable
sets the equation
setErr(boolean) - Method in class jhplot.DrawOptions
Set or not the 1st level errors on X and Y
setErr(double) - Method in class jhplot.math.ValueErr
Set error
setErrAll(boolean) - Method in class jhplot.DrawOptions
Show or not all errors (1st and 2nd level).
setErrAllToZero(String, int) - Method in class jhplot.P1D
Set all (1st and 2nd) level errors to zero.
setErrBack(double) - Method in class jhplot.stat.limit.ExpData
Set error on background
setErrColor(Color) - Method in class jhplot.DrawOptions
Set color for 1st level errors for X and Y
setErrColor(Color, double) - Method in class jhplot.DrawOptions
Set color for 1st level errors for X and Y
setErrColorX(Color) - Method in class jhplot.DrawOptions
Set color for 1st level errors in X
setErrColorY(Color) - Method in class jhplot.DrawOptions
Set color for 1st level errors in Y
setErrFill(boolean) - Method in class jhplot.DrawOptions
Fill area between lower and upper 1st-level errors
setErrFillColor(Color) - Method in class jhplot.DrawOptions
Fill color area between lower and upper 1st-level errors.
setErrFillColor(Color, double) - Method in class jhplot.DrawOptions
Fill color area between lower and upper 1st-level errors and set transparency level
setError(int, double) - Method in class jhplot.stat.DataKeeper
Set a error at index
setError(int, double) - Method in class org.freehep.math.minuit.MnApplication
 
setError(String, double) - Method in class org.freehep.math.minuit.MnApplication
 
setError(int, double) - Method in class org.freehep.math.minuit.MnUserParameters
 
setError(String, double) - Method in class org.freehep.math.minuit.MnUserParameters
 
setError(int, double) - Method in class org.freehep.math.minuit.MnUserParameterState
 
setError(String, double) - Method in class org.freehep.math.minuit.MnUserParameterState
 
setError(int, double, double) - Method in class org.jlab.groot.data.GraphErrors
 
setError(double) - Method in class org.jlab.groot.math.UserParameter
 
setError_cov_post(Matrix) - Method in class jhplot.math.kalman.JKalman
Setter
setError_cov_pre(Matrix) - Method in class jhplot.math.kalman.JKalman
Setter
setErrorDef(double) - Method in class org.freehep.math.minuit.MnApplication
errorDef() is the error definition of the function.
setErrorFillColorTransp(float) - Method in class jplot.LinePars
Sets transparancy for the color used to fill an area with errors.
setErrorFillColorTranspSys(float) - Method in class jplot.LinePars
Sets transparancy for the color used to fill an area with system errors.
setErrorIndicatorPaint(Paint) - Method in class org.jfree.chart.renderer.category.StatisticalBarRenderer
Sets the paint used for the error indicators (if null, the item outline paint is used instead) and sends a RendererChangeEvent to all registered listeners.
setErrorIndicatorPaint(Paint) - Method in class org.jfree.chart.renderer.category.StatisticalLineAndShapeRenderer
Sets the paint used for the error indicators (if null, the item paint is used instead) and sends a RendererChangeEvent to all registered listeners.
setErrorIndicatorPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the error indicator paint.
setErrorIndicatorStroke(Stroke) - Method in class org.jfree.chart.renderer.category.StatisticalBarRenderer
Sets the stroke used to draw the error indicators, and sends a RendererChangeEvent to all registered listeners.
setErrorIndicatorStroke(Stroke) - Method in class org.jfree.chart.renderer.category.StatisticalLineAndShapeRenderer
Sets the stroke used for the error indicators (if null, the item outline stroke is used instead) and sends a RendererChangeEvent to all registered listeners.
setErrorPaint(Paint) - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Sets the paint used to draw the error bars and sends a RendererChangeEvent to all registered listeners.
setErrors(double[]) - Method in class jhplot.H1D
Sets errors of H1D histogram (for heights).
setErrors(double[]) - Method in class jhplot.stat.DataKeeper
 
setErrors(int, double) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double errors = 3 [packed = true];
setErrors(int, double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double errors = 3 [packed = true];
setErrorStroke(Stroke) - Method in class org.jfree.chart.renderer.xy.XYErrorRenderer
Sets the stroke used to draw the error bars and sends a RendererChangeEvent to all registered listeners.
setErrSqrt(int) - Method in class jhplot.P1D
Set 1st level error to sqrt of X or Y values.
setErrSys(boolean) - Method in class jhplot.DrawOptions
Show or not the 2nd level errors for X and Y values
setErrSysFill(boolean) - Method in class jhplot.DrawOptions
Fill area between lower and upper 2st-level errors
setErrSysFillColor(Color) - Method in class jhplot.DrawOptions
Fill color area between lower and upper 1st-level errors
setErrSysFillColor(Color, double) - Method in class jhplot.DrawOptions
Fill color area between lower and upper 2nd-level errors and set transparency level
setErrSysToZero(int) - Method in class jhplot.P1D
Set 2nd level errors to zero.
setErrSysX(boolean) - Method in class jhplot.DrawOptions
Set or not the 2nd level errors in X
setErrSysY(boolean) - Method in class jhplot.DrawOptions
Show or not the 2nd level errors for Y values
setErrTicSize(double) - Method in class jhplot.DrawOptions
Set the size of small tics shown at the end of error bars.
setErrTicSize(float) - Method in class jplot.LinePars
Set the size of small tic marked end of errors The actual tic size is multiplied by penWidthErr
setErrToZero(int) - Method in class jhplot.P1D
Set 1st level errors to zero.
setErrX(boolean) - Method in class jhplot.DrawOptions
Set or not the 1st level errors in X
setErrY(boolean) - Method in class jhplot.DrawOptions
Show or not the 1st level errors for Y values.
setEt2(float) - Method in class hephysics.jet.ParticleF
 
setEta(float) - Method in class hephysics.jet.ParticleF
 
setEta(int, long) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Eta = 2 [packed = true];
setEta(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Eta = 2 [packed = true];
setEta(int, long) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Eta = 2 [packed = true];
setEta(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Eta = 2 [packed = true];
setEta(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Eta = 2 [packed = true];
setEta(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Eta = 20 [packed = true];
setEta(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Eta = 2 [packed = true];
setEta(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Eta = 2 [packed = true];
setEtaOuter(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 EtaOuter = 11 [packed = true];
setEvent(Collection) - Method in class hep.physics.jet.AbstractJetFinder
Call this to input a new event to the jet finder.
setEvent(Collection, Predicate) - Method in class hep.physics.jet.AbstractJetFinder
Call this to input a new event to the jet finder.
setEvent(Collection) - Method in class hep.physics.jet.EventShape
Call this to input a new event to the event shape routines.
setEvent(Collection, Predicate) - Method in class hep.physics.jet.EventShape
Call this to input a new event to the event shape routines.
setEvent(Collection) - Method in class hep.physics.jet.FixNumberOfJetsFinder
 
setEvent(Collection, Predicate) - Method in class hep.physics.jet.FixNumberOfJetsFinder
 
setEvent(Collection) - Method in interface hep.physics.jet.JetFinder
Set the current event data
setEvent(Collection, Predicate) - Method in interface hep.physics.jet.JetFinder
Set the current event data
setEvent(ProMC.ProMCEvent.Event) - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
setEvent(ProMC.ProMCEvent.Event.Builder) - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
setEvent(ProMC.ProMCEvent.Event) - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
setEvent(ProMC.ProMCEvent.Event.Builder) - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
setEvent(ProMC.ProMCEvent.Event) - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
setEvent(ProMC.ProMCEvent.Event.Builder) - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
setEvent(ProMC.ProMCEvent.Event) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
setEvent(ProMC.ProMCEvent.Event.Builder) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Event event = 1;
setEventNumber(int) - Method in class hep.lcio.implementation.event.ILCEvent
 
setEvents(long) - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
setEvents(long) - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
setEvents(long) - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
setEvents(long) - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 events = 2;
setExactMath() - Static method in class jhplot.HParam
Set exact math calculation using Java Math.
setExceptionSegments(List) - Method in class org.jfree.chart.axis.SegmentedTimeline
Sets the exception segments list.
setExists(boolean) - Method in class org.apache.commons.io.monitor.FileEntry
Set whether the file existed the last time it was checked.
setExpandable(ExpandableStatefulODE) - Method in class org.apache.commons.math3.ode.events.EventState
Set the equation.
setExpandToFitSpace(boolean) - Method in class org.jfree.chart.title.TextTitle
Sets the flag that controls whether the title expands to fit the available space, and sends a TitleChangeEvent to all registered listeners.
setExpansionFactor(float) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
As of 3.1 (to be removed in 4.0 as field will become "final").
setExpansionMode(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
setExpansionMode(ResizableDoubleArray.ExpansionMode) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
As of 3.1 (to be removed in 4.0 as field will become "final").
setExpectDelay(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setExplodedPieArea(Rectangle2D) - Method in class org.jfree.chart.plot.PiePlotState
Sets the exploded pie area.
setExplodePercent(Comparable, double) - Method in class org.jfree.chart.plot.PiePlot
Sets the amount that a pie section should be exploded and sends a PlotChangeEvent to all registered listeners.
setExplodePercent(int, double) - Method in class org.jfree.chart.plot.PiePlot
setExponentColor(Color) - Method in class graph.Axis
Set the color of the exponent
setExponentFont(Font) - Method in class graph.Axis
Set the font of the exponent
setExponentFormat(NumberFormat) - Method in class org.jfree.chart.util.LogFormat
Sets the number format used for the exponent.
setExpression(String, ITree) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setExpression(String) - Method in class org.jlab.groot.tree.TreeCut
 
setExpressionString(String) - Method in class org.nfunk.jepexamples.FractalCanvas
Parses a new expression
setExpressionString(String) - Method in class org.nfunk.jepexamples.GraphCanvas
Sets a new string to be used as function
setExpressionX(String) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setExpressionXerr(String) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setExpressionY(String) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setExpressionYerr(String) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setExpTickLabelsFlag(boolean) - Method in class org.jfree.chart.axis.LogarithmicAxis
Sets the 'expTickLabelsFlag' flag.
setExt(double, double, double) - Method in class jplot3d.JPoint
Sets extenstions
setExtent(double) - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Sets the extent and sends a DialLayerChangeEvent to all registered listeners.
setExtent(double) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the extent and sends a DialLayerChangeEvent to all registered listeners.
setExtraLargeFont(Font) - Method in class org.jfree.chart.StandardChartTheme
Sets the largest font for this theme.
setEyePosition(double, double, double) - Method in class jhplot.HPlot3DP
Set position oy eye
setEyePosition(double, double, double) - Method in class jplot3dp.ModelView
 
setF1D(PBufFile.Record.F1D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F1D f1D = 9;
setF1D(PBufFile.Record.F1D.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F1D f1D = 9;
setF2D(F2D) - Method in class jplot3d.JSurfacePanel
 
setF2D(ArrayList<F2D>) - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
setF2D(ArrayList<F2D>) - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
Set functions values
setF2D(PBufFile.Record.F2D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F2D f2D = 10;
setF2D(PBufFile.Record.F2D.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.F2D f2D = 10;
setFaroutCoefficient(double) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Sets the value used as the farouts coefficient.
setFast(int) - Method in class hep.physics.jet.EventShape
 
setFastMath(boolean) - Static method in class jhplot.HParam
Set fast math calculation (3-5 times faster than Java Math).
setFastMath() - Static method in class jhplot.HParam
Set fast math calculation (4-5 times faster than Java Math).
setFdata(int, float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 17;
setFdata(int, double) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated double fdata = 15 [packed = true];
setFdata(int, float) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated float fdata = 3;
setFile(File) - Method in class jplot.GraphLabel
Sets the file to which the label belongs.
setFileFilters(List<IOFileFilter>) - Method in class org.apache.commons.io.filefilter.AndFileFilter
Sets the list of file filters, replacing any previously configured file filters on this filter.
setFileFilters(List<IOFileFilter>) - Method in interface org.apache.commons.io.filefilter.ConditionalFileFilter
Sets the list of file filters, replacing any previously configured file filters on this filter.
setFileFilters(List<IOFileFilter>) - Method in class org.apache.commons.io.filefilter.OrFileFilter
Sets the list of file filters, replacing any previously configured file filters on this filter.
setFill(boolean) - Method in class jhplot.DrawOptions
Fill or not histogram or function.
setFill(boolean) - Method in class jhplot.HPlot3D
Set fill color or not for histogram bars
setFill(boolean) - Method in class jhplot.shapes.HShape
Fill a primitive
setFill(boolean) - Method in class jplot3dp.MainComponent
 
setFillBox(boolean) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Sets the flag that controls whether or not the box is filled and sends a RendererChangeEvent to all registered listeners.
setFillBox(boolean) - Method in class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Sets the flag that controls whether or not the box is filled and sends a RendererChangeEvent to all registered listeners.
setFillColor(Color) - Method in class jhplot.DrawOptions
Fill color of a drawing object.
setFillColor(Color) - Method in class jhplot.FPR
Set color for fill
setFillColor(Color) - Method in class jplot.LinePars
Sets the color used to fill an area with.
setFillColor(Color) - Method in class jplot3d.ColorModelSet
 
setFillColor(Color) - Method in interface jplot3d.SurfaceColor
 
setFillColor(Color) - Method in class jplot3dp.MainComponent
 
setFillColor(int) - Method in class org.jlab.groot.base.DatasetAttributes
 
setFillColor(int) - Method in class org.jlab.groot.data.H1F
ROOT COMPATABILITY Functions
setFillColorTransparency(double) - Method in class jhplot.DrawOptions
Set color transparency used to fill an object.
setFillColorTransparency(float) - Method in class jplot.LinePars
Sets transparancy for the color used to fill an area with.
setFillComposite(Composite) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Sets the composite which will be used for filling polygons and sends a RendererChangeEvent to all registered listeners.
setFilled(boolean) - Method in class jhplot.FPR
Set filled area or not
setFillPaint(Paint) - Method in class org.jfree.chart.ClipPath
Deprecated.
Sets the fillPaint.
setFillPaint(Paint) - Method in class org.jfree.chart.LegendItem
Sets the fill paint.
setFillPaint(Paint) - Method in class org.jfree.chart.needle.MeterNeedle
Sets the fill paint.
setFillPaint(Paint) - Method in class org.jfree.chart.plot.dial.DialCap
Sets the paint for the cap background and sends a DialLayerChangeEvent to all registered listeners.
setFillPaint(Paint) - Method in class org.jfree.chart.plot.dial.DialPointer.Pointer
Sets the fill paint and sends a DialLayerChangeEvent to all registered listeners.
setFillPaint(Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesFillPaint(int, Paint) and AbstractRenderer.setBaseFillPaint(Paint).
setFillPaint(Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesFillPaint(int, Paint, boolean) and AbstractRenderer.setBaseFillPaint(Paint, boolean).
setFillPaint(Paint) - Method in class org.jfree.chart.title.LegendGraphic
Sets the paint used to fill the shape.
setFillPaintTransformer(GradientPaintTransformer) - Method in class org.jfree.chart.LegendItem
Sets the transformer used when the fill paint is an instance of GradientPaint.
setFillPaintTransformer(GradientPaintTransformer) - Method in class org.jfree.chart.title.LegendGraphic
Sets the transformer used when the fill paint is an instance of GradientPaint.
setFillPath(boolean) - Method in class org.jfree.chart.ClipPath
Deprecated.
Sets the fillPath.
setFillStyle(int) - Method in class org.jlab.groot.base.DatasetAttributes
 
setFillType(XYSplineRenderer.FillType) - Method in class org.jfree.chart.renderer.xy.XYSplineRenderer
Set the fill type and sends a RendererChangeEvent to all registered listeners.
setFillZoomRectangle(boolean) - Method in class org.jfree.chart.ChartPanel
A flag that controls how the zoom rectangle is drawn.
setFirst(RegularTimePeriod) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the first time period in the axis range and sends an AxisChangeEvent to all registered listeners.
setFirstBarPaint(Paint) - Method in class org.jfree.chart.renderer.category.WaterfallBarRenderer
Sets the paint that will be used to draw the first bar and sends a RendererChangeEvent to all registered listeners.
setFirstCategoryIndex(int) - Method in class org.jfree.data.category.SlidingCategoryDataset
Sets the index of the first category that should be used from the underlying dataset, and sends a DatasetChangeEvent to all registered listeners.
setFirstCategoryIndex(int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Sets the index of the first category that should be used from the underlying dataset, and sends a DatasetChangeEvent to all registered listeners.
setFirstFunctionOnly(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setFirstTickLabelVisible(boolean) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets a flag that controls whether or not the first tick label is visible, and sends a DialLayerChangeEvent to all registered listeners.
setFitMethod(String) - Method in class jhplot.HFitter
Sets the fit method.
setFixed(boolean) - Method in class org.jlab.groot.base.PadMargins
 
setFixedAutoRange(double) - Method in class org.jfree.chart.axis.CyclicNumberAxis
The auto range is fixed for this class to the period by default.
setFixedAutoRange(double) - Method in class org.jfree.chart.axis.ValueAxis
Sets the fixed auto range for the axis.
setFixedDimension(double) - Method in class org.jfree.chart.axis.Axis
Sets the fixed dimension for the axis.
setFixedDomainAxisSpace(AxisSpace) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the fixed domain axis space and sends a PlotChangeEvent to all registered listeners.
setFixedDomainAxisSpace(AxisSpace, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the fixed domain axis space and sends a PlotChangeEvent to all registered listeners.
setFixedDomainAxisSpace(AxisSpace) - Method in class org.jfree.chart.plot.XYPlot
Sets the fixed domain axis space and sends a PlotChangeEvent to all registered listeners.
setFixedDomainAxisSpace(AxisSpace, boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the fixed domain axis space and, if requested, sends a PlotChangeEvent to all registered listeners.
setFixedIntervalWidth(double) - Method in class org.jfree.data.xy.IntervalXYDelegate
Sets the fixed interval width and, as a side effect, sets the autoWidth flag to false.
setFixedLegendItems(LegendItemCollection) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the fixed legend items for the plot.
setFixedLegendItems(LegendItemCollection) - Method in class org.jfree.chart.plot.PolarPlot
Sets the fixed legend items for the plot.
setFixedLegendItems(LegendItemCollection) - Method in class org.jfree.chart.plot.XYPlot
Sets the fixed legend items for the plot.
setFixedOrder(boolean) - Method in class cern.hep.aida.bin.DynamicBin1D
Determines whether the receivers internally preserved elements may be reordered or not.
setFixedRangeAxisSpace(AxisSpace) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the fixed range axis space and sends a PlotChangeEvent to all registered listeners.
setFixedRangeAxisSpace(AxisSpace, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the fixed range axis space and sends a PlotChangeEvent to all registered listeners.
setFixedRangeAxisSpace(AxisSpace) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Sets the fixed range axis space and sends a PlotChangeEvent to all registered listeners.
setFixedRangeAxisSpace(AxisSpace) - Method in class org.jfree.chart.plot.XYPlot
Sets the fixed range axis space and sends a PlotChangeEvent to all registered listeners.
setFixedRangeAxisSpace(AxisSpace, boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the fixed range axis space and, if requested, sends a PlotChangeEvent to all registered listeners.
setFlag(int) - Method in interface hep.lcio.event.LCCollection
Set the flag word.
setFlag(int) - Method in class hep.lcio.implementation.event.ILCCollection
 
setFloatVal(float, int) - Method in class hep.lcio.implementation.event.ILCGenericObject
Sets the float value at index - resizes the array if needed, thus it is more efficient to fill the largest index first.
setFloatVals(float[]) - Method in class hep.lcio.implementation.event.ILCGenericObject
Set all float values at once
setFlush(int) - Method in class jhplot.io.HFile
Set after how many events data will be flushed.
setFND(PBufFile.Record.FND) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FND fND = 11;
setFND(PBufFile.Record.FND.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FND fND = 11;
setFog(boolean) - Method in class jhplot.HPlot3DP
Set fog for objects
setFog(boolean) - Method in class jplot3dp.MainComponent
 
setFog(boolean) - Method in class jplot3dp.ModelView
 
setFogMode(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setFollowDataInSubranges(boolean) - Method in class org.jfree.chart.plot.JThermometer
Sets the flag that controls whether or not the display range follows the data value.
setFollowDataInSubranges(boolean) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the flag that controls whether or not the thermometer axis zooms to display the subrange within which the data value falls.
setFont(Font) - Method in class graph.TextLine
Set the Font to use with the class
setFont(Font) - Method in class jhplot.HKey
Sets the font to a specific value
setFont(Font) - Method in class jhplot.HLabel
Sets the font to a specific value
setFont(Font) - Method in class jhplot.HMLabel
Sets the font to a specific value
setFont(Font) - Method in class jhplot.shapes.Text
Set the font for this text.
setFont(Font) - Method in class jplot.GraphLabel
Sets the font to a specific value
setFont(Font) - Method in class jplot.PrintFilePainter
 
setFont(Font) - Method in class jplot.PrintTextPainter
 
setFont(Font) - Method in class org.jfree.chart.annotations.TextAnnotation
Sets the font for the annotation and sends an AnnotationChangeEvent to all registered listeners.
setFont(Font) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the font for the annotation and sends an AnnotationChangeEvent to all registered listeners.
setFont(Font) - Method in class org.jfree.chart.block.LabelBlock
Sets the font and regenerates the label.
setFont(Font) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the font to be used for drawing text.
setFont(Font) - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Sets the font used to display the label and sends a DialLayerChangeEvent to all registered listeners.
setFont(Font) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the font and sends a DialLayerChangeEvent to all registered listeners.
setFont(Font) - Method in class org.jfree.chart.title.TextTitle
Sets the font used to display the title string.
setFont(String) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setFont(String) - Method in class org.jlab.groot.ui.LatexText
 
setFont(String) - Method in class org.jlab.groot.ui.PaveText
 
setFontAxisX(Font, Color) - Method in class jhplot.HChart
Set font and color for X-axis (for X-Y plots)
setFontAxisY(Font, Color) - Method in class jhplot.HChart
Set font and color for Y-axis (for X-Y plots)
setFontChanged(boolean) - Method in class jplot.GraphSettings
Sets a flag to indicate that some of the graph-fonts have changed.
setFontColorLabel(Color) - Method in interface jplot3d.SurfaceModel
 
setFontColorLabel(Color) - Method in class jplot3d.SurfaceModelCanvas
 
setFontLegent(Font) - Method in class jhplot.HChart
Set font for legend title
setFontName(String) - Method in class graph.TextLine
Set the Logical font name of the current font
setFontName(String) - Method in class org.jlab.groot.base.FontProperties
 
setFontName(String) - Method in class org.jlab.groot.ui.GraphicsAxisLabels
set Font name for all axis labels.
setFontNameAll(String) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setFontSize(int) - Method in class graph.TextLine
Set the Font size of the current font
setFontSize(int) - Method in class jhplot.HLabelEq
Sets the font to a specific value
setFontSize(int) - Method in class org.jlab.groot.base.FontProperties
 
setFontSize(int) - Method in class org.jlab.groot.ui.GraphicsAxisLabels
set font size for all axis labels.
setFontSize(int) - Method in class org.jlab.groot.ui.LatexText
 
setFontSize(int) - Method in class org.jlab.groot.ui.PaveText
 
setFontStyle(int) - Method in class graph.TextLine
Set the Font style of the current font
setFontTitle(Font) - Method in class jhplot.HChart
Set font for legend title.
setFontValue(Font) - Method in class jhplot.HPlot3DP
Set Font for axis numbers
setForeground(Color) - Method in class jplot.PrintFilePainter
 
setForeground(Color) - Method in class jplot.PrintTextPainter
 
setForeground(Color) - Method in class org.jfree.chart.plot.JThermometer
Sets the foreground color.
setForegroundAlpha(float) - Method in class org.jfree.chart.plot.Plot
Sets the alpha-transparency for the plot and sends a PlotChangeEvent to all registered listeners.
setForegroundPaint(Paint) - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Sets the foreground paint and sends a DialLayerChangeEvent to all registered listeners.
setForegroundPaint(Paint) - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Sets the foreground paint and sends a DialLayerChangeEvent to all registered listeners.
setFormat(String) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the way a single cell value is to be formatted.
setFormat(DecimalFormat) - Method in class jhplot.io.HBook
Set format for writting double values.
setFov(double) - Method in class jhplot.HPlot3DP
Set field of vision
setFov(double) - Method in class jplot3d.OptionsDialog
 
setFov(double) - Method in class jplot3dp.MainComponent
 
setFov(double) - Method in class jplot3dp.ModelView
 
setFPR(PBufFile.Record.FPR) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FPR fPR = 12;
setFPR(PBufFile.Record.FPR.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.FPR fPR = 12;
setFrame(JFrame) - Method in class jplot.DataChangeListener
 
setFrame(BlockFrame) - Method in class org.jfree.chart.block.AbstractBlock
Sets the frame (or border).
setFrameAnchor(RectangleAnchor) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the frame anchor and sends a DialLayerChangeEvent to all registered listeners.
setFrameColor(Color) - Method in class jhplot.HPlot3D
Set color of the frame
setFrameDimensions(double, double, double, double) - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
setFrameScale(float) - Method in interface jplot3d.SurfaceModel
 
setFrameScale(float) - Method in class jplot3d.SurfaceModelCanvas
 
setFree() - Method in class org.jlab.groot.math.UserParameter
 
setFunc(IFunction) - Method in class jhplot.HFitter
Set fit functions
setFunc(String) - Method in class jhplot.HFitter
Set fit functions from predefined string.
setFunc(String, int, String, String) - Method in class jhplot.HFitter
Set functions from a script.
setFunction(Function) - Method in class jhplot.math.num.integration.AdaptiveIntegrator
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.integration.RombergIntegrator
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.integration.SimpsonsIntegrator
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.integration.TrapezoidalIntegrator
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.BisectionRootFinder
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.Bracket
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.BrentRootFinder
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.FalsePositionRootFinder
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.NewtonRootFinder
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.SecantRootFinder
Modify the target function.
setFunction(FPR) - Method in class jplot3dp.MainComponent
set function
setFunction(Func1D) - Method in class org.jlab.groot.data.GraphErrors
 
setFunction(Func1D) - Method in class org.jlab.groot.data.H1F
 
setFunction(String, PostfixMathCommandI) - Method in class org.nfunk.jep.ASTFunNode
Sets the function for a node.
setFunctionAttributes(DatasetAttributes) - Static method in class org.jlab.groot.base.GStyle
 
setGain(Matrix) - Method in class jhplot.math.kalman.JKalman
Setter
setGap(double) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Sets the amount of space between subplots and sends a PlotChangeEvent to all registered listeners.
setGap(double) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Sets the amount of space between subplots and sends a PlotChangeEvent to all registered listeners.
setGap(double) - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Sets the amount of space between subplots and sends a PlotChangeEvent to all registered listeners.
setGap(double) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Sets the amount of space between subplots.
setGap(int) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the gap (in Java2D units) between the two outlines that represent the thermometer, and sends a PlotChangeEvent to all registered listeners.
setGapThreshold(double) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Sets the gap threshold for discontinuous lines and sends a RendererChangeEvent to all registered listeners.
setGapThresholdType(UnitType) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Sets the gap threshold type and sends a RendererChangeEvent to all registered listeners.
setGBackground(Color) - Method in class jhplot.gui.GHMargin
Set the background of this panel
setGColor(Color) - Method in class jhplot.gui.GHMargin
Set the color on this panel.
setGenerateEntities(boolean) - Method in class org.jfree.chart.block.BlockParams
Sets the flag that controls whether or not chart entities are generated.
setGenerator(int) - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
optional int32 generator = 5;
setGeneratorStatus(int) - Method in class hep.lcio.implementation.event.IMCParticle
 
setGenjets(ProMC.ProMCEvent.GenJets) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.GenJets genjets = 4;
setGenjets(ProMC.ProMCEvent.GenJets.Builder) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.GenJets genjets = 4;
setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the geometric mean.
setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the geometric mean.
setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the geometric mean.
setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the geometric mean.
setGeometricMeanImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the gemoetric mean.
setGFont(Font) - Method in class jhplot.gui.GHMargin
Set the font.
setGoodnessOfPID(float) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setGradientNCycles(int) - Method in class org.freehep.math.minuit.MnStrategy
 
setGradientPaintTransformer(GradientPaintTransformer) - Method in class org.jfree.chart.plot.dial.DialBackground
Sets the transformer used to adjust the coordinates of any GradientPaint instance used for the background paint, and sends a DialLayerChangeEvent to all registered listeners.
setGradientPaintTransformer(GradientPaintTransformer) - Method in class org.jfree.chart.plot.IntervalMarker
Sets the gradient paint transformer and sends a MarkerChangeEvent to all registered listeners.
setGradientPaintTransformer(GradientPaintTransformer) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the gradient paint transformer and sends a RendererChangeEvent to all registered listeners.
setGradientPaintTransformer(GradientPaintTransformer) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the gradient paint transformer and sends a RendererChangeEvent to all registered listeners.
setGradientPaintTransformer(GradientPaintTransformer) - Method in class org.jfree.chart.renderer.xy.XYSplineRenderer
Sets the gradient paint transformer and sends a RendererChangeEvent to all registered listeners.
setGradientStepTolerance(double) - Method in class org.freehep.math.minuit.MnStrategy
 
setGradientTolerance(double) - Method in class org.freehep.math.minuit.MnStrategy
 
setGradientTransformer(GradientPaintTransformer) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Sets the gradient paint transformer and sends a RendererChangeEvent to all registered listeners.
setGraph() - Method in class jhplot.HPlot
Set the graph from JPLot
setGraphBackground(Color) - Method in class graph.Graph2D
Set the background color for the entire canvas.
setGraphBackground(Color) - Method in class jplot.Contour
Set the background color for the entire canvas.
setGraphBackgroundColor(Color) - Method in class jplot.GraphSettings
Sets the background color of the graph.
setGraphErrorsAttributes(DatasetAttributes) - Static method in class org.jlab.groot.base.GStyle
 
setGraphicsFrameLineWidth(int) - Static method in class org.jlab.groot.base.GStyle
 
setGraphLocation(int, int) - Method in class jplot.JPlot
Sets the location at which we put the graph
setGraphSettings(GraphSettings) - Method in class jhplot.HPlot
Set a new graph settings for the current plot
setGraphSettings(GraphSettings) - Method in class jplot.JPlot
 
setGraphStyle(int) - Method in class jhplot.DrawOptions
Set the style of the graph
setGraphStyle(int) - Method in class jplot.LinePars
Sets the graph style.
setGraphType(int) - Method in class jplot.GraphSettings
Sets the graph type.
setGrayScaleMode(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setGRecBackground(Color) - Method in class jhplot.gui.GHMargin
Set the background for rectangle with the text
setGrid(double[], int, int) - Method in class graph.Contour
Set the grid to be contoured.
setGrid(double[], int, int) - Method in class graph.IsoCurve
Set the grid to be contoured
setGrid(boolean) - Method in class jhplot.HChart
Sets whether or not using grid lines.
setGrid(int, boolean) - Method in class jhplot.HChart
Sets whether or not using grid lines.
setGrid(int, boolean) - Method in class jhplot.HPlot
Sets whether or not using grid lines.
setGrid(boolean) - Method in class jhplot.HPlot
Sets whether or not using grid lines.
setGrid(boolean) - Method in class org.jlab.groot.base.AxisAttributes
 
setGrid(boolean) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
setGridAll(int, boolean) - Method in class jhplot.HPlot
Sets or not the grid lines for all plots on the same canvas
setGridBandAlternatePaint(Paint) - Method in class org.jfree.chart.axis.SymbolAxis
Sets the paint used for alternate grid bands and sends a AxisChangeEvent to all registered listeners.
setGridBandAlternatePaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the grid band alternate paint (used for a SymbolAxis).
setGridBandPaint(Paint) - Method in class org.jfree.chart.axis.SymbolAxis
Sets the grid band paint and sends an AxisChangeEvent to all registered listeners.
setGridBandPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the grid band paint.
setGridBandsVisible(boolean) - Method in class org.jfree.chart.axis.SymbolAxis
Sets the visibility of the grid bands and notifies registered listeners that the axis has been modified.
setGridColor(Color) - Method in class jhplot.HChart
Sets color of the grid lines for all plots on the same canvas
setGridColor(Color) - Method in class jplot.GraphSettings
Sets the color used by the grid.
setGridColorAll(Color) - Method in class jhplot.HPlot
Sets color of the grid lines for all plots on the same canvas
setGridPenWidth(double) - Method in class jhplot.HChart
Sets width of the line for the grid
setGridPenWidth(int, double) - Method in class jhplot.HChart
Sets the width of the line for grid
setGridToFront(boolean) - Method in class jhplot.HPlot
Setting the flag to true, this will draw the grid after drawing all the lines and point stuff, hence on the foreground.
setGridToFront(boolean) - Method in class jplot.GraphSettings
Setting the flag to true, this will draw the grid after drawing all the lines and point stuff, hence on the foreground.
setGridX(boolean) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setGridY(boolean) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setGroup(DatasetGroup) - Method in class org.jfree.data.general.AbstractDataset
Sets the dataset group for the dataset.
setGroup(DatasetGroup) - Method in interface org.jfree.data.general.Dataset
Sets the dataset group.
setGroup(int, PEventFile.HEvent.Group) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
setGroup(int, PEventFile.HEvent.Group.Builder) - Method in class promc.io.PEventFile.HEvent.Builder
repeated .promc.HEvent.Group group = 5;
setGroupPaint(Paint) - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Sets the paint used to draw the line between the minimum and maximum value items in each category and sends a RendererChangeEvent to all registered listeners.
setGroupStroke(Stroke) - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Sets the stroke of the line between the minimum value and the maximum value and sends a RendererChangeEvent to all registered listeners.
setGS(GraphSettings) - Method in class jplot.JPlot
 
setGTitle(String, Font, Color) - Method in class jhplot.gui.GHPanel
Sets the global title
setGTitle(String, Font) - Method in class jhplot.gui.GHPanel
Sets the global title using black color.
setGTitle(String) - Method in class jhplot.gui.GHPanel
Set the global title with default attributes.
setGTitle(String, double) - Method in class jhplot.gui.GHPanel
Set the global title with default attributes.
setGTitle(String, Color) - Method in class jhplot.gui.GHPanel
Set the global title.
setGUI() - Method in class jplot3d.JSurfacePanel
Set GUI
setGUI() - Method in class jplot3d.OptionsDialog
 
setGuideLinePaint(Paint) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Sets the paint used to draw the guide lines and sends a RendererChangeEvent to all registered listeners.
setGuideLineStroke(Stroke) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Sets the stroke used to draw the guide lines and sends a RendererChangeEvent to all registered listeners.
setGuideLinesVisible(boolean) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Sets the flag that controls whether or not guide lines are drawn for each data item and sends a RendererChangeEvent to all registered listeners.
setH1D(PBufFile.Record.H1D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H1D h1D = 7;
setH1D(PBufFile.Record.H1D.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H1D h1D = 7;
setH1FAttributes(DatasetAttributes) - Static method in class org.jlab.groot.base.GStyle
 
setH2D(H2D) - Method in class jplot3d.JSurfacePanel
 
setH2D(ArrayList<H2D>) - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
setH2D(ArrayList<H2D>) - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
Set histogram values
setH2D(PBufFile.Record.H2D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H2D h2D = 8;
setH2D(PBufFile.Record.H2D.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.H2D h2D = 8;
setH2DF2D(ArrayList<H2D>, ArrayList<F2D>) - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
setH2DF2D(ArrayList<H2D>, ArrayList<F2D>) - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
Draw histogram and then function at the same time
setH2FAttributes(DatasetAttributes) - Static method in class org.jlab.groot.base.GStyle
 
setHadOverEem(int, int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
setHadOverEem(int, int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
setHadOverEem(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 HadOverEem = 10 [packed = true];
setHasLeftDetector(boolean) - Method in class hep.lcio.implementation.event.IMCParticle
 
setHeadPercent(double) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the head percent and sends a PlotChangeEvent to all registered listeners.
setHeight(double) - Method in class org.jfree.chart.block.AbstractBlock
Sets the natural width of the block, if this is known in advance.
setHeights(double[]) - Method in class jhplot.H1D
Sets the content of H1D histogram (heights).
setHeights(int, double) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double heights = 2 [packed = true];
setHeights(int, double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double heights = 2 [packed = true];
setHessianG2Tolerance(double) - Method in class org.freehep.math.minuit.MnStrategy
 
setHessianGradientNCycles(int) - Method in class org.freehep.math.minuit.MnStrategy
 
setHessianNCycles(int) - Method in class org.freehep.math.minuit.MnStrategy
 
setHessianStepTolerance(double) - Method in class org.freehep.math.minuit.MnStrategy
 
setHiddenMode(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setHighFarOut(boolean) - Method in class org.jfree.chart.renderer.OutlierListCollection
Sets the flag that indicates the presence of one or more far out values at the top end of the range.
setHighlightPaint(Paint) - Method in class org.jfree.chart.needle.MeterNeedle
Sets the highlight paint.
setHistogram(H2D) - Method in class jplot.Contour
Set histogram and find all attributes
setHistogram(H2F) - Method in class org.jlab.groot.fitter.ParallelSliceFitter
 
setHistory() - Static method in class Jampack.Parameters
Sets the history flag.
setHorizontalAlignment(HorizontalAlignment) - Method in class org.jfree.chart.title.Title
Sets the horizontal alignment for the title and sends a TitleChangeEvent to all registered listeners.
setHorizontalAxisTrace(boolean) - Method in class org.jfree.chart.ChartPanel
A flag that controls trace lines on the horizontal axis.
setHourFormatter(NumberFormat) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the formatter for the hours.
setHourSuffix(String) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the string that is appended to the hour count.
setHtml(String) - Method in class fitter.Fitter
 
setID(int) - Method in class jplot.GraphLabel
Sets the current identity of the label to some specific value The idientity must be an int and, in principle, something predefined such as GraphLabel.XLABEL).
setID(String) - Method in class org.jfree.chart.block.AbstractBlock
Sets the id for the block.
setID(String) - Method in interface org.jfree.chart.block.Block
Sets the ID for the block.
setId(int, int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
setId(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
setId(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
setId(long) - Method in class promc.io.PEventFile.HEvent.Builder
optional int64 id = 1;
setId(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
setId(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
setId(int) - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
setId(int, int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
setId(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
setId(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
setId(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 id = 1 [packed = true];
setId(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required sint32 id = 1;
setId(int) - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required sint32 id = 1;
setID1(int) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID1 = 4;
setId1(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
setID1(int) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID1 = 4;
setId1(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
setId1(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
setID1(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID1 = 4 [packed = true];
setId1(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id1 = 1;
setID2(int) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID2 = 5;
setId2(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
setID2(int) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 ID2 = 5;
setId2(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
setId2(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
setID2(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ID2 = 5 [packed = true];
setId2(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 id2 = 2;
setIda(int, long) - Method in class promc.io.PEventFile.HEvent.Builder
repeated int64 ida = 4 [packed = true];
setIda(int, long) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
repeated int64 ida = 2 [packed = true];
setIdata(int, long) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 18;
setIdata(int, long) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 16 [packed = true];
setIdata(int, long) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
repeated sint64 idata = 4;
setIEEEFlags(int) - Method in class org.apache.commons.math3.dfp.DfpField
Sets the IEEE 854 status flags.
setIEEEFlagsBits(int) - Method in class org.apache.commons.math3.dfp.DfpField
Sets some bits in the IEEE 854 status flags, without changing the already set bits.
setIFunction(IFunction) - Method in class jhplot.FProxy
 
setIgnoreNullValues(boolean) - Method in class org.jfree.chart.plot.PiePlot
Sets a flag that controls whether null values are ignored, and sends a PlotChangeEvent to all registered listeners.
setIgnoreZeroValues(boolean) - Method in class org.jfree.chart.plot.PiePlot
Sets a flag that controls whether zero values are ignored, and sends a PlotChangeEvent to all registered listeners.
setIgnoreZeroValues(boolean) - Method in class org.jfree.chart.renderer.category.StackedBarRenderer3D
Sets a flag that controls whether or not zero values are drawn by the renderer, and sends a RendererChangeEvent to all registered listeners.
setIm(double) - Method in class org.nfunk.jep.type.Complex
Sets the imaginary component of the object
setImage(Image) - Method in class org.jfree.chart.title.ImageTitle
Sets the image for the title and notifies registered listeners that the title has been modified.
setImageEncoder(String, String) - Static method in class org.jfree.chart.encoders.ImageEncoderFactory
Used to set additional encoders or replace default ones.
setImplicitMul(boolean) - Method in class org.nfunk.jep.JEP
Sets the value of the implicit multiplication option.
setIncludeBaseInRange(boolean) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the flag that controls whether or not the base value for the bars is included in the range calculated by AbstractCategoryItemRenderer.findRangeBounds(CategoryDataset).
setIncompletePaint(Paint) - Method in class org.jfree.chart.renderer.category.GanttRenderer
Sets the paint used to show the percentage incomplete and sends a RendererChangeEvent to all registered listeners.
setIndent(String) - Method in class jplot.XMLWrite
Sets the indentation, a number of spaces.
setIndepVariables(boolean, boolean, boolean) - Method in class graph.ParseFunction
Set independent variables
setIndex(int) - Method in class jplot.DataFile
Sets the current datafile index to another value.
setIndex(int) - Method in class org.jfree.chart.entity.ContourEntity
Deprecated.
Sets the index.
SetInfoTable() - Static method in class jminhep.clcontrol.Global
 
setInitialDelay(int) - Method in class org.jfree.chart.ChartPanel
Specifies the initial delay value for this chart panel.
setInitialMainStateJacobian(double[][]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Set the initial value of the Jacobian matrix with respect to state.
setInitialParameterJacobian(String, double[]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Set the initial value of a column of the Jacobian matrix with respect to one parameter.
setInitialStep(double) - Method in class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
Deprecated.
Set the initial step used to bracket the optimum in line search.
setInitialStepSize(T) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
Set the initial step size.
setInitialStepSize(double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Set the initial step size.
setInitialTokenManagerState(int) - Method in class org.nfunk.jep.Parser
Sets the initial state that the token manager is in.
setInitScaling(float) - Method in interface jplot3d.SurfaceModel
 
setInitScaling(float) - Method in class jplot3d.SurfaceModelCanvas
 
setInnerColor(Color) - Method in class jhplot.HPlot
Sets the color used to fill the inner triangles.
setInnerColor(Color) - Method in class jplot.GraphSettings
Sets the color used to fill the inner triangles.
setInnerRadius(double) - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Sets the inner radius and sends a DialLayerChangeEvent to all registered listeners.
setInnerRadius(double) - Method in class org.jfree.chart.plot.dial.StandardDialRange
Sets the inner radius and sends a DialLayerChangeEvent to all registered listeners.
setInnerSeparatorExtension(double) - Method in class org.jfree.chart.plot.RingPlot
Sets the length of the inner extension of the separator line that is drawn between sections, as a percentage of the depth of the sections, and sends a change event to all registered listeners.
setInsets(RectangleInsets) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the insets and sends a DialLayerChangeEvent to all registered listeners.
setInsets(RectangleInsets) - Method in class org.jfree.chart.plot.Plot
Sets the insets for the plot and sends a PlotChangeEvent to all registered listeners.
setInsets(RectangleInsets, boolean) - Method in class org.jfree.chart.plot.Plot
Sets the insets for the plot and, if requested, and sends a PlotChangeEvent to all registered listeners.
setInteriorGap(double) - Method in class org.jfree.chart.plot.PiePlot
Sets the interior gap and sends a PlotChangeEvent to all registered listeners.
setInteriorGap(double) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the interior gap and sends a PlotChangeEvent to all registered listeners.
setInterpolatedTime(double) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Set the time of the interpolated point.
setInterpolatedTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Set the time of the interpolated point.
setInterpolatedTime(double) - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Set the time of the interpolated point.
setInterpolationControl(boolean, int) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Set the interpolation order control parameter.
setIntervalPositionFactor(double) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Sets the interval position factor.
setIntervalPositionFactor(double) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Sets the interval position factor.
setIntervalPositionFactor(double) - Method in class org.jfree.data.xy.IntervalXYDelegate
Sets the interval position factor.
setIntervalPositionFactor(double) - Method in class org.jfree.data.xy.XYSeriesCollection
Sets the interval position factor.
setIntervalWidth(double) - Method in class org.jfree.data.xy.CategoryTableXYDataset
Sets the interval width to a fixed value, and sends a DatasetChangeEvent to all registered listeners.
setIntervalWidth(double) - Method in class org.jfree.data.xy.DefaultTableXYDataset
Sets the interval width to a fixed value, and sends a DatasetChangeEvent to all registered listeners.
setIntervalWidth(double) - Method in class org.jfree.data.xy.XYSeriesCollection
Sets the interval width and sends a DatasetChangeEvent to all registered listeners.
setIntOption(String, int) - Static method in class jhepsim.Options
Sets an integer value for the parameter option name.
setIntVal(int, int) - Method in class hep.lcio.implementation.event.ILCGenericObject
Sets the int value at index - resizes the array if needed, thus it is more efficient to fill the largest index first.
setIntVals(int[]) - Method in class hep.lcio.implementation.event.ILCGenericObject
Set all int values at once
setInverse(boolean) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Sets the inverse flag.
setInverted(boolean) - Method in class org.jfree.chart.axis.ValueAxis
Sets a flag that controls the direction of values on the axis, and notifies registered listeners that the axis has changed.
setIPhi(float) - Method in class hep.lcio.implementation.event.ICluster
 
setIsConstant(boolean) - Method in class org.nfunk.jep.Variable
 
setIsFixedBins(boolean) - Method in class promc.io.PBufFile.Record.H1D.Builder
required bool isFixedBins = 17;
setIsFixedBins(boolean) - Method in class promc.io.PBufFile.Record.H2D.Builder
required bool isFixedBins = 13;
setIsospin(float) - Method in class hephysics.particle.HEParticle
Set isospin
setItem(int) - Method in class org.jfree.chart.entity.XYItemEntity
Sets the item index.
setItemCount(int) - Method in class org.jfree.data.statistics.SimpleHistogramBin
Sets the item count.
setItemFont(Font) - Method in class org.jfree.chart.title.LegendTitle
Sets the item font and sends a TitleChangeEvent to all registered listeners.
setItemLabelAnchorOffset(double) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the item label anchor offset.
setItemLabelFont(Font) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesItemLabelFont(int, Font) and AbstractRenderer.setBaseItemLabelFont(Font).
setItemLabelFont(Font, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesItemLabelFont(int, Font, boolean) and AbstractRenderer.setBaseItemLabelFont(Font, boolean).
setItemLabelFont(Font) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesItemLabelFont(int, Font) and CategoryItemRenderer.setBaseItemLabelFont(Font).
setItemLabelFont(Font) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesItemLabelFont(int, Font) and XYItemRenderer.setBaseItemLabelFont(Font).
setItemLabelGenerator(CategoryItemLabelGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
setItemLabelGenerator(CategoryItemLabelGenerator) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
setItemLabelGenerator(XYItemLabelGenerator) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Deprecated.
As of version 1.0.6, this override setting should not be used. You can use the base setting instead (AbstractXYItemRenderer.setBaseItemLabelGenerator(XYItemLabelGenerator)).
setItemLabelGenerator(XYItemLabelGenerator) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
As of version 1.0.6, this override setting should not be used. You can use the base setting instead (XYItemRenderer.setBaseItemLabelGenerator(XYItemLabelGenerator)).
setItemLabelPadding(RectangleInsets) - Method in class org.jfree.chart.title.LegendTitle
Sets the padding used for the item labels in the legend.
setItemLabelPaint(Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesItemLabelPaint(int, Paint) and AbstractRenderer.setBaseItemLabelPaint(Paint).
setItemLabelPaint(Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesItemLabelPaint(int, Paint, boolean) and AbstractRenderer.setBaseItemLabelPaint(Paint, boolean).
setItemLabelPaint(Paint) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesItemLabelPaint(int, Paint) and CategoryItemRenderer.setBaseItemLabelPaint(Paint).
setItemLabelPaint(Paint) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesItemLabelPaint(int, Paint) and XYItemRenderer.setBaseItemLabelPaint(Paint).
setItemLabelPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the item label paint.
setItemLabelsVisible(boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesItemLabelsVisible(int, Boolean) and AbstractRenderer.setBaseItemLabelsVisible(boolean).
setItemLabelsVisible(Boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesItemLabelsVisible(int, Boolean) and AbstractRenderer.setBaseItemLabelsVisible(boolean).
setItemLabelsVisible(Boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesItemLabelsVisible(int, Boolean, boolean) and AbstractRenderer.setBaseItemLabelsVisible(Boolean, boolean).
setItemLabelsVisible(boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesItemLabelsVisible(int, Boolean) and CategoryItemRenderer.setBaseItemLabelsVisible(boolean).
setItemLabelsVisible(Boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesItemLabelsVisible(int, Boolean) and CategoryItemRenderer.setBaseItemLabelsVisible(boolean).
setItemLabelsVisible(Boolean, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesItemLabelsVisible(int, Boolean, boolean) and CategoryItemRenderer.setBaseItemLabelsVisible(Boolean, boolean).
setItemLabelsVisible(boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesItemLabelsVisible(int, Boolean) and XYItemRenderer.setBaseItemLabelsVisible(boolean).
setItemLabelsVisible(Boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesItemLabelsVisible(int, Boolean) and XYItemRenderer.setBaseItemLabelsVisible(boolean).
setItemLabelsVisible(Boolean, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesItemLabelsVisible(int, Boolean, boolean) and XYItemRenderer.setBaseItemLabelsVisible(Boolean, boolean).
setItemMargin(double) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the item margin and sends a RendererChangeEvent to all registered listeners.
setItemMargin(double) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Sets the item margin and sends a RendererChangeEvent to all registered listeners.
setItemMargin(double) - Method in class org.jfree.chart.renderer.category.LevelRenderer
Sets the item margin and sends a RendererChangeEvent to all registered listeners.
setItemMargin(double) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the item margin, which is the gap between items within a category (expressed as a percentage of the overall category width), and sends a RendererChangeEvent to all registered listeners.
setItemMargin(double) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Sets the item margin, which is the gap between items within a category (expressed as a percentage of the overall category width), and sends a RendererChangeEvent to all registered listeners.
setItemPaint(Paint) - Method in class org.jfree.chart.title.LegendTitle
Sets the item paint.
setItemURLGenerator(CategoryURLGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Deprecated.
setItemURLGenerator(CategoryURLGenerator) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesItemURLGenerator(int, CategoryURLGenerator) and CategoryItemRenderer.setBaseItemURLGenerator(CategoryURLGenerator).
setIterations(int) - Method in class org.nfunk.jepexamples.FractalCanvas
 
setITheta(float) - Method in class hep.lcio.implementation.event.ICluster
 
setJets(ProMC.ProMCEvent.Jets) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Jets jets = 3;
setJets(ProMC.ProMCEvent.Jets.Builder) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Jets jets = 3;
setJustification(int) - Method in class graph.TextLine
Set the Justification to use with the class
setKey(int, float, Color) - Method in class jhplot.HKey
Sets a key
setKey(int, float, Color) - Method in class jplot.GraphLabel
Sets a key
setKey(Comparable) - Method in class org.jfree.chart.plot.CategoryMarker
Sets the key and sends a MarkerChangeEvent to all registered listeners.
setKey(Comparable) - Method in class org.jfree.data.general.Series
Sets the key for the series and sends a VetoableChangeEvent (with the property name "Key") to all registered listeners.
setKey(Comparable) - Method in class org.jfree.data.xml.ItemHandler
Sets the key.
setKey(String) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
setKey(String) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
setKey(String) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
required string key = 1;
setKey(String) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
required string key = 1;
setKey(String) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
setKey(String) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
setKey(String) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
setKey(String) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
setKey(String) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
setKey(String) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
setKeyBytes(ByteString) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
setKeyBytes(ByteString) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
setKeyBytes(ByteString) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
required string key = 1;
setKeyBytes(ByteString) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
required string key = 1;
setKeyBytes(ByteString) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
setKeyBytes(ByteString) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
setKeyBytes(ByteString) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
setKeyBytes(ByteString) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
setKeyBytes(ByteString) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required string key = 1;
setKeyBytes(ByteString) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required string key = 1;
setKeyLineWidth(float) - Method in class jplot.GraphLabel
Sets a key line width
setKeySpace(float) - Method in class jhplot.HKey
Sets a space between the key and the text describing the key
setKeySpace(float) - Method in class jplot.GraphLabel
Sets a space between the key and the text describing the key
setKurtosisImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the kurtosis.
setLabel(GraphLabel) - Method in class jplot.GraphSettings
Adds a label or, if already in the list, replaces a label with an identical text (the first one uncounted) with the new one.
setLabel(String) - Method in class org.jfree.chart.axis.Axis
Sets the label for the axis and sends an AxisChangeEvent to all registered listeners.
setLabel(String) - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Sets the label and sends a DialLayerChangeEvent to all registered listeners.
setLabel(String) - Method in class org.jfree.chart.plot.Marker
Sets the label (if null no label is displayed) and sends a MarkerChangeEvent to all registered listeners.
setLabelAnchor(RectangleAnchor) - Method in class org.jfree.chart.plot.Crosshair
Sets the label anchor point and sends a property change event (with the name 'labelAnchor') to all registered listeners.
setLabelAnchor(RectangleAnchor) - Method in class org.jfree.chart.plot.Marker
Sets the label anchor and sends a MarkerChangeEvent to all registered listeners.
setLabelAngle(double) - Method in class org.jfree.chart.axis.Axis
Sets the angle for the label and sends an AxisChangeEvent to all registered listeners.
setLabelBackgroundColor(Color) - Method in class org.jfree.chart.plot.Marker
Sets the label background color.
setLabelBackgroundPaint(Paint) - Method in class org.jfree.chart.plot.Crosshair
Sets the label background paint and sends a property change event with the name 'labelBackgroundPaint') to all registered listeners.
setLabelBackgroundPaint(Paint) - Method in class org.jfree.chart.plot.PiePlot
Sets the section label background paint and sends a PlotChangeEvent to all registered listeners.
setLabelColor(Color) - Method in class graph.Axis
Set the color of the labels
setLabelColor(Color) - Method in class graph.Contour
Set the Color to be used with all the labels.
setLabelColor(Color) - Method in class jhplot.HChart
Set color of the labels.
setLabelColor(Color) - Method in class jhplot.HPlot3D
Set color of the label
setLabelColor(Color) - Method in class jhplot.HPlot3DP
Set Color for the labels
setLabelColor(Color) - Method in class jplot.Contour
Set the Color to be used with all the labels.
setLabelColor(Color) - Method in interface jplot3d.SurfaceModel
 
setLabelColor(Color) - Method in class jplot3d.SurfaceModelCanvas
 
setLabelColor(Color) - Method in class jplot3dp.ModelView
 
setLabelDistributor(AbstractPieLabelDistributor) - Method in class org.jfree.chart.plot.PiePlot
Sets the label distributor and sends a PlotChangeEvent to all registered listeners.
setLabelFont(Font) - Method in class graph.Axis
Set the font of the labels.
setLabelFont(Font) - Method in class graph.Contour
Set the font to be used with All the labels
setLabelFont(Font) - Method in class jhplot.HChart
Set fonts of the labels.
setLabelFont(Font) - Method in class jhplot.HPlot3D
Set Font for the labels
setLabelFont(Font) - Method in class jhplot.HPlot3DP
Set Font for the labels
setLabelFont(Font) - Method in class jplot.Contour
Set the font to be used with All the labels
setLabelFont(Font) - Method in interface jplot3d.SurfaceModel
 
setLabelFont(Font) - Method in class jplot3d.SurfaceModelCanvas
 
setLabelFont(Font) - Method in class jplot3dp.ModelView
 
setLabelFont(Font) - Method in class org.jfree.chart.axis.Axis
Sets the font for the axis label and sends an AxisChangeEvent to all registered listeners.
setLabelFont(Font) - Method in class org.jfree.chart.LegendItem
Sets the label font.
setLabelFont(Font) - Method in class org.jfree.chart.plot.CompassPlot
Sets the label font and sends a PlotChangeEvent to all registered listeners.
setLabelFont(Font) - Method in class org.jfree.chart.plot.Crosshair
Sets the label font and sends a property change event (with the name 'labelFont') to all registered listeners.
setLabelFont(Font) - Method in class org.jfree.chart.plot.Marker
Sets the label font and sends a MarkerChangeEvent to all registered listeners.
setLabelFont(Font) - Method in class org.jfree.chart.plot.PiePlot
Sets the section label font and sends a PlotChangeEvent to all registered listeners.
setLabelFont(Font) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the series label font and sends a PlotChangeEvent to all registered listeners.
setLabelFontColor(Color) - Method in class jhplot.HPlot3D
Set color for labels
setLabelFontName(String) - Method in class org.jlab.groot.base.AxisAttributes
 
setLabelFontSize(int) - Method in class org.jlab.groot.base.AxisAttributes
 
setLabelGap(double) - Method in class org.jfree.chart.plot.PiePlot
Sets the gap between the edge of the pie and the labels (expressed as a percentage of the plot width) and sends a PlotChangeEvent to all registered listeners.
setLabelGenerator(CrosshairLabelGenerator) - Method in class org.jfree.chart.plot.Crosshair
Sets the crosshair label generator and sends a property change event (with the name 'labelGenerator') to all registered listeners.
setLabelGenerator(PieSectionLabelGenerator) - Method in class org.jfree.chart.plot.PiePlot
Sets the section label generator and sends a PlotChangeEvent to all registered listeners.
setLabelGenerator(CategoryItemLabelGenerator) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the label generator and sends a PlotChangeEvent to all registered listeners.
setLabelInfo(PeriodAxisLabelInfo[]) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the array of label info records and sends an AxisChangeEvent to all registered listeners.
setLabelInsets(RectangleInsets) - Method in class org.jfree.chart.axis.Axis
Sets the insets for the axis label, and sends an AxisChangeEvent to all registered listeners.
setLabelInsets(RectangleInsets, boolean) - Method in class org.jfree.chart.axis.Axis
Sets the insets for the axis label, and sends an AxisChangeEvent to all registered listeners.
setLabelledContourColor(Color) - Method in class graph.Contour
Set the labelled contour's color.
setLabelledContourColor(Color) - Method in class jplot.Contour
Set the labelled contour's color.
setLabelLevels(int) - Method in class graph.Contour
Set the contour levels that are to have labels.
setLabelLevels(int) - Method in class jplot.Contour
Set the contour levels that are to have labels.
setLabelLinkMargin(double) - Method in class org.jfree.chart.plot.PiePlot
Sets the link margin and sends a PlotChangeEvent to all registered listeners.
setLabelLinkPaint(Paint) - Method in class org.jfree.chart.plot.PiePlot
Sets the paint used for the lines that connect pie sections to their corresponding labels, and sends a PlotChangeEvent to all registered listeners.
setLabelLinkPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the label link paint for pie charts.
setLabelLinkStroke(Stroke) - Method in class org.jfree.chart.plot.PiePlot
Sets the link stroke and sends a PlotChangeEvent to all registered listeners.
setLabelLinkStyle(PieLabelLinkStyle) - Method in class org.jfree.chart.plot.PiePlot
Sets the label link style and sends a PlotChangeEvent to all registered listeners.
setLabelLinkStyle(PieLabelLinkStyle) - Method in class org.jfree.chart.StandardChartTheme
Sets the label link style for pie charts.
setLabelLinksVisible(boolean) - Method in class org.jfree.chart.plot.PiePlot
Sets the flag that controls whether or not label linking lines are visible and sends a PlotChangeEvent to all registered listeners.
setLabelLocation(AxisLabelLocation) - Method in class org.jfree.chart.axis.Axis
Sets the axis label location and sends an AxisChangeEvent to all registered listeners.
setLabelOffset(double) - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Sets the label offset (from the arrow base, continuing in a straight line, in Java2D units) and sends an AnnotationChangeEvent to all registered listeners.
setLabelOffset(double) - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Sets the label offset (from the arrow base, continuing in a straight line, in Java2D units) and sends an AnnotationChangeEvent to all registered listeners.
setLabelOffset(RectangleInsets) - Method in class org.jfree.chart.plot.Marker
Sets the label offset and sends a MarkerChangeEvent to all registered listeners.
setLabelOffset(int) - Method in class org.jlab.groot.base.AxisAttributes
 
setLabelOffsetType(LengthAdjustmentType) - Method in class org.jfree.chart.plot.Marker
Sets the label offset type and sends a MarkerChangeEvent to all registered listeners.
setLabelOffsetX(double) - Method in class jhplot.HPlot3D
Set label offset on X
setLabelOffsetX(float) - Method in interface jplot3d.SurfaceModel
 
setLabelOffsetX(float) - Method in class jplot3d.SurfaceModelCanvas
 
setLabelOffsetY(double) - Method in class jhplot.HPlot3D
Set label offset on Y
setLabelOffsetY(float) - Method in interface jplot3d.SurfaceModel
 
setLabelOffsetY(float) - Method in class jplot3d.SurfaceModelCanvas
 
setLabelOffsetZ(double) - Method in class jhplot.HPlot3D
Set label offset on Z
setLabelOffsetZ(float) - Method in interface jplot3d.SurfaceModel
 
setLabelOffsetZ(float) - Method in class jplot3d.SurfaceModelCanvas
 
setLabelOutlinePaint(Paint) - Method in class org.jfree.chart.plot.Crosshair
Sets the label outline paint and sends a property change event (with the name "labelOutlinePaint") to all registered listeners.
setLabelOutlinePaint(Paint) - Method in class org.jfree.chart.plot.PiePlot
Sets the section label outline paint and sends a PlotChangeEvent to all registered listeners.
setLabelOutlineStroke(Stroke) - Method in class org.jfree.chart.plot.Crosshair
Sets the label outline stroke and sends a property change event (with the name 'labelOutlineStroke') to all registered listeners.
setLabelOutlineStroke(Stroke) - Method in class org.jfree.chart.plot.PiePlot
Sets the section label outline stroke and sends a PlotChangeEvent to all registered listeners.
setLabelOutlineVisible(boolean) - Method in class org.jfree.chart.plot.Crosshair
Sets the flag that controls the visibility of the label outlines and sends a property change event (with the name "labelOutlineVisible") to all registered listeners.
setLabelPadding(RectangleInsets) - Method in class org.jfree.chart.plot.PiePlot
Sets the padding between each label and its outline and sends a PlotChangeEvent to all registered listeners.
setLabelPaint(Paint) - Method in class org.jfree.chart.axis.Axis
Sets the paint used to draw the axis label and sends an AxisChangeEvent to all registered listeners.
setLabelPaint(Paint) - Method in class org.jfree.chart.LegendItem
Sets the paint used to draw the label.
setLabelPaint(Paint) - Method in class org.jfree.chart.plot.Crosshair
Sets the label paint and sends a property change event (with the name 'labelPaint') to all registered listeners.
setLabelPaint(Paint) - Method in class org.jfree.chart.plot.Marker
Sets the label paint and sends a MarkerChangeEvent to all registered listeners.
setLabelPaint(Paint) - Method in class org.jfree.chart.plot.PiePlot
Sets the section label paint and sends a PlotChangeEvent to all registered listeners.
setLabelPaint(Paint) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the series label paint and sends a PlotChangeEvent to all registered listeners.
setLabelPosition(Point2D) - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Sets the label position.
setLabelPrecision(int) - Method in class graph.Contour
Set the label precision.
setLabels(TextLine[], int) - Method in class graph.Contour
Manually set the Contour labels.
setLabels(Vector<GraphLabel>) - Method in class jplot.GraphSettings
Set new labels for the plot
setLabelShadowPaint(Paint) - Method in class org.jfree.chart.plot.PiePlot
Sets the section label shadow paint and sends a PlotChangeEvent to all registered listeners.
setLabelSignificance(int) - Method in class graph.Contour
Set the label significant figures.
setLabelStyle(int) - Method in class graph.Contour
Set the label style, either TextLine.SCIENTIFIC or TextLine.ALGEBRAIC.
setLabelTextAnchor(TextAnchor) - Method in class org.jfree.chart.plot.Marker
Sets the label text anchor and sends a MarkerChangeEvent to all registered listeners.
setLabelTicks(int, Vector<String>) - Method in class jplot.GraphSettings
Set and overwrite the tick labels.
setLabelType(int) - Method in class org.jfree.chart.plot.CompassPlot
Sets the label type (either CompassPlot.NO_LABELS or CompassPlot.VALUE_LABELS.
setLabelVisible(boolean) - Method in class org.jfree.chart.plot.Crosshair
Sets the flag that controls whether or not a label is drawn for the crosshair and sends a property change event (with the name 'labelVisible') to all registered listeners.
setLabelX(String) - Method in class jhplot.Plottable
Set lablel for X axis
setLabelXOffset(double) - Method in class org.jfree.chart.plot.Crosshair
Sets the x-offset and sends a property change event (with the name 'labelXOffset') to all registered listeners.
setLabelY(String) - Method in class jhplot.Plottable
Set lablel for Y axis
setLabelYOffset(double) - Method in class org.jfree.chart.plot.Crosshair
Sets the y-offset and sends a property change event (with the name 'labelYOffset') to all registered listeners.
setLabelZ(String) - Method in class jhplot.Plottable
Set lablel for Z axis if applicable.
setLargeFont(Font) - Method in class org.jfree.chart.StandardChartTheme
Sets the large font for this theme.
setLast(RegularTimePeriod) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the last time period in the axis range and sends an AxisChangeEvent to all registered listeners.
setLastBarPaint(Paint) - Method in class org.jfree.chart.renderer.category.WaterfallBarRenderer
Sets the paint that will be used to draw the last bar and sends a RendererChangeEvent to all registered listeners.
setLastModified(long) - Method in class jplot.DataFile
Sets the modification date of the file to a specific value.
setLastModified(long) - Method in class org.apache.commons.io.monitor.FileEntry
Return the last modified time from the last time it was checked.
setLastPointGood(boolean) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer.State
Sets a flag that indicates if the last point drawn (in the current series) was 'good' (non-null).
setLastPointGood(boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer.State
Sets a flag that indicates if the last point drawn (in the current series) was 'good' (non-null).
setLatestAngle(double) - Method in class org.jfree.chart.plot.PiePlotState
Sets the latest angle.
setLeft(double) - Method in class org.jfree.chart.axis.AxisSpace
Sets the space reserved for axes at the left of the plot area.
setLeftArrow(Shape) - Method in class org.jfree.chart.axis.ValueAxis
Sets the shape that can be displayed as an arrow pointing left at the end of an axis line and sends an AxisChangeEvent to all registered listeners.
setLeftMargin(double) - Method in class jplot.GraphSettings
Sets the distance between the left-border of the panel and the left Y-axis.
setLeftMargin(int) - Method in class org.jlab.groot.base.PadMargins
 
setLegacyAlpha(boolean) - Static method in class org.jfree.chart.util.PaintAlpha
Per default PaintAlpha will try to honour alpha-channel information.
setLegend(boolean) - Method in class jhplot.DrawOptions
Sets whether or not this line style should draw the name in the legend of the graph.
setLegend(boolean) - Method in class jhplot.HChart
Sets whether or not this line style should draw the name in the legend of the graph.
setLegend(boolean) - Method in class jhplot.HPlot
Sets whether or not to draw the legend.
setLegendArea(Shape) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Sets the shape used as an area in each legend item and sends a RendererChangeEvent to all registered listeners.
setLegendArea(Shape) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer2
Sets the shape used as an area in each legend item and sends a RendererChangeEvent to all registered listeners.
setLegendBackgroundPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the legend background paint.
setLegendBar(Shape) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the shape used to represent bars in each legend item and sends a RendererChangeEvent to all registered listeners.
setLegendFont(Font) - Method in class jhplot.HPlot
Sets the actual font of the legend.
setLegendFont(String) - Method in class jhplot.HPlot
Set the label font, which is used for axis labels and legend labels.
setLegendFont(Font) - Method in class jplot.GraphSettings
Sets the actual font of the legend.
setLegendItemGraphicAnchor(RectangleAnchor) - Method in class org.jfree.chart.title.LegendTitle
Sets the anchor point used for the graphic in each legend item.
setLegendItemGraphicEdge(RectangleEdge) - Method in class org.jfree.chart.title.LegendTitle
Sets the location of the shape within each legend item.
setLegendItemGraphicLocation(RectangleAnchor) - Method in class org.jfree.chart.title.LegendTitle
Sets the legend item graphic location.
setLegendItemGraphicPadding(RectangleInsets) - Method in class org.jfree.chart.title.LegendTitle
Sets the padding that will be applied to each item graphic in the legend and sends a TitleChangeEvent to all registered listeners.
setLegendItemLabelGenerator(CategorySeriesLabelGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Sets the legend item label generator and sends a RendererChangeEvent to all registered listeners.
setLegendItemLabelGenerator(XYSeriesLabelGenerator) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Sets the legend item label generator and sends a RendererChangeEvent to all registered listeners.
setLegendItemLabelGenerator(XYSeriesLabelGenerator) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the legend item label generator and sends a RendererChangeEvent to all registered listeners.
setLegendItemPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the legend item paint.
setLegendItemShape(Shape) - Method in class org.jfree.chart.plot.MultiplePiePlot
Sets the shape used for legend items and sends a PlotChangeEvent to all registered listeners.
setLegendItemShape(Shape) - Method in class org.jfree.chart.plot.PiePlot
Sets the shape used for legend items and sends a PlotChangeEvent to all registered listeners.
setLegendItemShape(Shape) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the shape used for legend items and sends a PlotChangeEvent to all registered listeners.
setLegendItemToolTipGenerator(CategorySeriesLabelGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Sets the legend item tool tip generator and sends a RendererChangeEvent to all registered listeners.
setLegendItemToolTipGenerator(XYSeriesLabelGenerator) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Sets the legend item tool tip generator and sends a RendererChangeEvent to all registered listeners.
setLegendItemToolTipGenerator(XYSeriesLabelGenerator) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Sets the legend item tool tip generator and sends a RendererChangeEvent to all registered listeners.
setLegendItemURLGenerator(CategorySeriesLabelGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Sets the legend item URL generator and sends a RendererChangeEvent to all registered listeners.
setLegendItemURLGenerator(XYSeriesLabelGenerator) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Sets the legend item URL generator and sends a RendererChangeEvent to all registered listeners.
setLegendItemURLGenerator(XYSeriesLabelGenerator) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Sets the legend item URL generator and sends a RendererChangeEvent to all registered listeners.
setLegendLabelGenerator(PieSectionLabelGenerator) - Method in class org.jfree.chart.plot.PiePlot
Sets the legend label generator and sends a PlotChangeEvent to all registered listeners.
setLegendLabelToolTipGenerator(PieSectionLabelGenerator) - Method in class org.jfree.chart.plot.PiePlot
Sets the legend label tool tip generator and sends a PlotChangeEvent to all registered listeners.
setLegendLabelURLGenerator(PieURLGenerator) - Method in class org.jfree.chart.plot.PiePlot
Sets the legend label URL generator and sends a PlotChangeEvent to all registered listeners.
setLegendLine(Shape) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Sets the shape used as a line in each legend item and sends a RendererChangeEvent to all registered listeners.
setLegendLine(Shape) - Method in class org.jfree.chart.renderer.xy.SamplingXYLineRenderer
Deprecated.
As of version 1.0.14, this method is deprecated. You should use the AbstractRenderer.setBaseLegendShape(java.awt.Shape) method instead.
setLegendLine(Shape) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Sets the shape used as a line in each legend item and sends a RendererChangeEvent to all registered listeners.
setLegendLine(Shape) - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Sets the shape used as a line in each legend item and sends a RendererChangeEvent to all registered listeners.
setLegendLine(Shape) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the shape used as a line in each legend item and sends a RendererChangeEvent to all registered listeners.
setLegendPos(int, double) - Method in class jhplot.HPlot
Sets the x or y coordinates (defined relative to the data ranges on the axes) of the legend.
setLegendPos(double, double, String) - Method in class jhplot.HPlot
Sets the x and y coordinates of the legend.
setLegendPosition(RectangleEdge) - Method in class jhplot.HChart
Legend position
setLegendPosition(int, double) - Method in class jplot.GraphSettings
Sets the x or y coordinates (defined relative to the data ranges on the axes) of the legend.
setLegendPosition(double, double) - Method in class jplot.GraphSettings
Sets the x and y coordinates (defined relative to the actual axes values) of the legend.
setLegendPosUse(boolean) - Method in class jhplot.HPlot
Sets whether or not to set the legend position in X,Y coordinates as defined by the graph.
setLegendShape(int, Shape) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the shape used for the legend item for the specified series, and sends a RendererChangeEvent to all registered listeners.
setLegendShape(Shape) - Method in class org.jfree.chart.renderer.xy.XYDotRenderer
Sets the shape used as a line in each legend item and sends a RendererChangeEvent to all registered listeners.
setLegendSpac(double) - Method in class jhplot.HPlot
Sets the vertical spacing, between each line of the legend.
setLegendSpacing(double) - Method in class jplot.GraphSettings
Sets the vertical spacing, between each line of the legend.
setLegendTextFont(int, Font) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the font used for the legend text for the specified series, and sends a RendererChangeEvent to all registered listeners.
setLegendTextPaint(int, Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the paint used for the legend text for the specified series, and sends a RendererChangeEvent to all registered listeners.
setLength(long) - Method in class org.apache.commons.io.monitor.FileEntry
Set the length.
setLengthFromBeginning(double[], int) - Static method in class jhplot.math.ArrayMathUtils
Sets an array to the specified length scraping or padding the end if necessary.
setLengthFromBeginning(int[], int) - Static method in class jhplot.math.ArrayMathUtils
Sets an array to the specified length scraping or padding the end if necessary.
setLengthFromEnd(double[], int) - Static method in class jhplot.math.ArrayMathUtils
Sets an array to the specified length scraping or padding the beginning if necessary.
setLengthFromEnd(int[], int) - Static method in class jhplot.math.ArrayMathUtils
Sets an array to the specified length scraping or padding the beginning if necessary.
setLengthUnit(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
setLengthUnit(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
setLengthUnit(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
setLengthUnit(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 LengthUnit = 17;
setLevels(double[], int) - Method in class graph.Contour
Manually set the contour levels.
setLifetime(float) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
setLifetime(float) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
setLifetime(float) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
setLifetime(float) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float lifetime = 5;
setLiftPen(int) - Method in class jplot.DataArray
Defines that, for this plotpoint, the pen should lift.
setLiftPen(boolean) - Method in class jplot.PlotPoint
Sets whether or not the drawing pen should be lifted after this point.
setLikelihood(float) - Method in class hep.lcio.implementation.event.IParticleID
 
setLimit(int, double) - Method in class jhplot.FProxy
Set limit entry
setLimit(double) - Method in class org.jfree.chart.plot.MultiplePiePlot
Sets the limit below which pie sections are aggregated.
setLimitGuess(double) - Method in class jhplot.stat.limit.StatConfidence
Set new limit
setLimits(double[]) - Method in class jhplot.FProxy
Limits if function is ranged.
setLimits(int, double, double) - Method in class org.freehep.math.minuit.MnApplication
 
setLimits(String, double, double) - Method in class org.freehep.math.minuit.MnApplication
 
setLimits(int, double, double) - Method in class org.freehep.math.minuit.MnUserParameters
Set the lower and upper bound on the specified variable.
setLimits(String, double, double) - Method in class org.freehep.math.minuit.MnUserParameters
Set the lower and upper bound on the specified variable.
setLimits(int, double, double) - Method in class org.freehep.math.minuit.MnUserParameterState
 
setLimits(String, double, double) - Method in class org.freehep.math.minuit.MnUserParameterState
 
setLimits(double, double) - Method in class org.jlab.groot.math.UserParameter
 
setLimitsToGrid(boolean) - Method in class graph.Contour
If true the limits of the plot will be the grid limits.
setLimitsToGrid(boolean) - Method in class jplot.Contour
If true the limits of the plot will be the grid limits.
setLine(Line2D) - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Sets the line used to label this series.
setLine(Shape) - Method in class org.jfree.chart.LegendItem
Sets the line.
setLine(Shape) - Method in class org.jfree.chart.title.LegendGraphic
Sets the line.
setLineBoxColor(Color) - Method in class jplot3d.ColorModelSet
 
setLineBoxColor(Color) - Method in interface jplot3d.SurfaceColor
 
setLineColor(Color) - Method in class jhplot.FPR
Set color for lines
setLineColor(Color) - Method in class jplot3d.ColorModelSet
 
setLineColor(Color) - Method in interface jplot3d.SurfaceColor
 
setLineColor(Color) - Method in class jplot3dp.MainComponent
 
setLineColor(int) - Method in class org.jlab.groot.base.AxisAttributes
 
setLineColor(int) - Method in class org.jlab.groot.base.DatasetAttributes
 
setLineColor(int) - Method in class org.jlab.groot.data.GraphErrors
 
setLineColor(int) - Method in class org.jlab.groot.data.H1F
 
setLineColor(int) - Method in class org.jlab.groot.math.Func1D
 
setLinePaint(Paint) - Method in class org.jfree.chart.LegendItem
Sets the line paint.
setLinePaint(Paint) - Method in class org.jfree.chart.title.LegendGraphic
Sets the line paint.
setLinePars(LinePars) - Method in class jhplot.P1D
Sets LinePars class for graphical attributes
setLinePars(LinePars) - Method in class jplot.DataArray
Sets the drawing style parameters at once.
setLinePars(LinePars) - Method in class jplot.DataArray3D
Sets the drawing style parameters at once.
setLinePars(int, LinePars) - Method in class jplot.DataFile
sets the linestyle of one of the vector items.
setLinePars(LinePars) - Method in class jplot.DataFile
sets the linestyle of all the vector items.
setLinePars(LinePars) - Method in class jplot.LineStyle
 
setLinePars(LinePars) - Method in class jplot.LineStyleButton
 
setLineStroke(Stroke) - Method in class org.jfree.chart.LegendItem
Sets the line stroke.
setLineStroke(Stroke) - Method in class org.jfree.chart.title.LegendGraphic
Sets the line stroke.
setLineStyle(int) - Method in class jhplot.DrawOptions
Set line styles (important for functions).
setLineStyle(int) - Method in class org.jlab.groot.base.AxisAttributes
 
setLineStyle(int) - Method in class org.jlab.groot.base.DatasetAttributes
 
setLineStyle(int) - Method in class org.jlab.groot.base.PadAttributes
 
setLineStyle(int) - Method in class org.jlab.groot.math.Func1D
 
setLinesVisible(Boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Deprecated.
As of 1.0.7 (the override facility is unnecessary, just use the per-series and base (default) settings).
setLinesVisible(boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Deprecated.
As of 1.0.7 (the override facility is unnecessary, just use the per-series and base (default) settings).
setLinesVisible(Boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Deprecated.
As of 1.0.7, use the per-series and base level settings.
setLinesVisible(boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Deprecated.
As of 1.0.7, use the per-series and base level settings.
setLineThickness(int) - Method in class org.jlab.groot.data.GraphErrors
 
setLineVisible(boolean) - Method in class org.jfree.chart.LegendItem
Sets the flag that controls whether or not the line shape is visible for this legend item.
setLineVisible(boolean) - Method in class org.jfree.chart.title.LegendGraphic
Sets the flag that controls whether or not the line is visible.
setLineWidth(int) - Method in class jhplot.HKey
Sets key line width
setLineWidth(int) - Method in class org.jlab.groot.base.AxisAttributes
 
setLineWidth(int) - Method in class org.jlab.groot.base.DatasetAttributes
 
setLineWidth(int) - Method in class org.jlab.groot.base.PadAttributes
 
setLineWidth(int) - Method in class org.jlab.groot.data.H1F
 
setLineWidth(int) - Method in class org.jlab.groot.math.Func1D
 
setLinkArea(Rectangle2D) - Method in class org.jfree.chart.plot.PiePlotState
Sets the label link area.
setListDeliminator(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
setLocale(Locale) - Method in class org.jfree.chart.axis.DateAxis
Sets the locale for the axis and sends a change event to all registered listeners.
setLocation(int) - Method in class hep.lcio.implementation.event.ITrackState
 
setLocation(double, double) - Method in class jhplot.HKey
Sets the location of the label in data coordinates.
setLocation(double, double, String) - Method in class jhplot.HKey
Sets the location of the label in data coordinates.
setLocation(double, double) - Method in class jhplot.HLabel
Sets the location of the label in the NDC coordinates.
setLocation(double, double, String) - Method in class jhplot.HLabel
Sets the location of the label in data coordinates.
setLocation(double, double) - Method in class jhplot.HLabelEq
Sets the location of the label in data coordinates.
setLocation(double, double, String) - Method in class jhplot.HLabelEq
Sets the location of the label in data coordinates.
setLocation(double) - Method in class jhplot.math.num.pdf.Weibull
Modify the location parameter.
setLocation(double, double) - Method in class jplot.GraphLabel
This function sets the text location of the label text itself, slightly different from the x,y position of the box.
setLocation(double, double) - Method in class org.jlab.groot.ui.LatexText
 
setLog(boolean) - Method in class org.jlab.groot.base.AxisAttributes
 
setLog(boolean) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
setLog(boolean) - Method in class org.jlab.groot.math.Dimension1D
 
setLog(boolean) - Method in class org.jlab.groot.ui.GraphicsAxis
Sets logarithmic scale for the axis
setLog10TickLabelsFlag(boolean) - Method in class org.jfree.chart.axis.LogarithmicAxis
Sets the 'log10TickLabelsFlag' flag.
setLogLevels(boolean) - Method in class graph.Contour
If true contour levels are calculated on a log scale.
setLogScale(int, boolean) - Method in class jhplot.HChart
Sets true or false to plot on a log scale.
setLogScale(int, boolean) - Method in class jhplot.HPlot
Sets true or false to plot on a log scale.
setLogscale(boolean) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Sets the 'log-scale' flag.
setLower(double) - Method in class jhplot.math.num.pdf.Uniform
Modify the lower bound parameter.
setLowerBound(double) - Method in class org.jfree.chart.axis.ValueAxis
Sets the lower bound for the axis range.
setLowerBound(double) - Method in class org.jfree.chart.plot.dial.StandardDialRange
Sets the lower bound of the dial range and sends a DialLayerChangeEvent to all registered listeners.
setLowerBound(double) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the lower bound for the scale and sends a DialLayerChangeEvent to all registered listeners.
setLowerBound(double) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the lower bound for the thermometer.
setLowerLimit(int, double) - Method in class org.freehep.math.minuit.MnUserParameters
 
setLowerLimit(String, double) - Method in class org.freehep.math.minuit.MnUserParameters
 
setLowerLimit(int, double) - Method in class org.freehep.math.minuit.MnUserParameterState
 
setLowerLimit(String, double) - Method in class org.freehep.math.minuit.MnUserParameterState
 
setLowerMargin(double) - Method in class org.jfree.chart.axis.CategoryAxis
Sets the lower margin for the axis and sends an AxisChangeEvent to all registered listeners.
setLowerMargin(double) - Method in class org.jfree.chart.axis.ValueAxis
Sets the lower margin for the axis (as a percentage of the axis range) and sends an AxisChangeEvent to all registered listeners.
setLowFarOut(boolean) - Method in class org.jfree.chart.renderer.OutlierListCollection
Sets the flag that indicates the presence of one or more far out values at the bottom end of the range.
setLowStrategy() - Method in class org.freehep.math.minuit.MnStrategy
 
setLRB(double[]) - Method in class jhplot.stat.ConfidenceLevel
 
setLRS(double[]) - Method in class jhplot.stat.ConfidenceLevel
 
setLU(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Sets the combined lower and upper triangular factor, LU.
setLuminosityAccumulated(double) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
setLuminosityAccumulated(double) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
setLuminosityAccumulated(double) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
setLuminosityAccumulated(double) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional double luminosity_accumulated = 5;
setMagThetaPhi(double, double, double) - Method in class j4np.physics.Vector3
 
setMajorTickIncrement(double) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the increment (in data units) between major tick labels and sends a DialLayerChangeEvent to all registered listeners.
setMajorTickLength(double) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the length factor for the major tick marks and sends a DialLayerChangeEvent to all registered listeners.
setMajorTickPaint(Paint) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the major tick paint and sends a DialLayerChangeEvent to all registered listeners.
setMajorTickStroke(Stroke) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the stroke used to draw the major tick marks and sends a DialLayerChangeEvent to all registered listeners.
setMajorTickTimePeriodClass(Class) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the class that controls the spacing of the major tick marks, and sends an AxisChangeEvent to all registered listeners.
setManualRange(boolean) - Method in class graph.Axis
Is the range of the axis to be set automatically (based on the data) or manually by setting the values Axis.minimum and Axis.maximum?
setMargin(RectangleInsets) - Method in class org.jfree.chart.block.AbstractBlock
Sets the margin (use RectangleInsets.ZERO_INSETS for no padding).
setMargin(double, double, double, double) - Method in class org.jfree.chart.block.AbstractBlock
Sets the margin.
setMargin(int) - Method in class org.jfree.chart.plot.PolarPlot
Set the margin around the plot area and sends a PlotChangeEvent to all registered listeners.
setMargin(double) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the percentage amount by which the bars are trimmed and sends a RendererChangeEvent to all registered listeners.
setMarginBackground(Color) - Method in class jhplot.gui.GHPanel
Set color for all global margins
setMarginBottom(double) - Method in class jhplot.HPlot
Sets the distance between the bottom-border of the panel and the bottom X-axis.
setMarginLeft(double) - Method in class jhplot.HPlot
Sets the distance between the left-border of the panel and the left Y-axis.
setMarginRight(double) - Method in class jhplot.HPlot
Sets the distance between the right-border of the panel and the right Y-axis.
setMargins(PadMargins) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setMarginSizeBottom(double) - Method in class jhplot.gui.GHPanel
Set size of the bottom margin of global canvas in terms of the ratio to the size of the main panel
setMarginSizeLeft(double) - Method in class jhplot.gui.GHPanel
Set the size of left margin in term of the ratio to the global panel
setMarginSizeRight(double) - Method in class jhplot.gui.GHPanel
Set the size of right margin of the global canvas in terms of the ration to the global panel in X
setMarginSizeTop(double) - Method in class jhplot.gui.GHPanel
Set size of the top margin of global canvas in terms of the ratio to the size of the main panel
setMarginTop(double) - Method in class jhplot.HPlot
Sets the distance between the top-border of the panel and the top X-axis.
setMarker(Shape) - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Set the marker.
setMarkerBand(MarkerAxisBand) - Method in class org.jfree.chart.axis.NumberAxis
Sets the marker band for the axis.
setMarkerColor(int) - Method in class org.jlab.groot.base.DatasetAttributes
 
setMarkerColor(int) - Method in class org.jlab.groot.data.GraphErrors
 
setMarkers(Markers) - Method in class graph.Graph2D
Set the markers for the plot.
setMarkerSize(int) - Method in class org.jlab.groot.base.DatasetAttributes
 
setMarkerSize(int) - Method in class org.jlab.groot.data.GraphErrors
 
setMarkerStyle(int) - Method in class org.jlab.groot.base.DatasetAttributes
 
setMarkerStyle(int) - Method in class org.jlab.groot.data.GraphErrors
 
setMass(float) - Method in class hep.lcio.implementation.event.IMCParticle
 
setMass(float) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setMass(double) - Method in class hep.physics.particle.BasicParticle
Overrides the mass obtained from the particle type.
setMass(double) - Method in class hephysics.particle.LParticle
Set a mass
setMass(int, float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float mass = 4 [packed = true];
setMass(double) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
setMass(int, long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
setMass(double) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
setMass(double) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
setMass(int, long) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 Mass = 4 [packed = true];
setMass(int, long) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 Mass = 4 [packed = true];
setMass(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 Mass = 4 [packed = true];
setMass(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 mass = 4 [packed = true];
setMass(double) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required double mass = 2;
setMatrix(int, int, int, int, Matrix) - Method in class Jama.Matrix
Set a submatrix.
setMatrix(int[], int[], Matrix) - Method in class Jama.Matrix
Set a submatrix.
setMatrix(int[], int, int, Matrix) - Method in class Jama.Matrix
Set a submatrix.
setMatrix(int, int, int[], Matrix) - Method in class Jama.Matrix
Set a submatrix.
setMatrix(int, int, int, int, Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Set a submatrix.
setMatrix(int[], int[], Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Set a submatrix.
setMatrix(int[], int, int, Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Set a submatrix.
setMatrix(int, int, int[], Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Set a submatrix.
setMax(double) - Method in class jhplot.F1D
Set the maximum value in X
setMax(double) - Method in class jhplot.FND
Set the maximum value in X
setMax(double) - Method in class jhplot.H1D
Set Maximum value of axis
setMax(double) - Method in class jhplot.HProf1D
Set Maximum value of axis
setMax(double) - Method in class org.jfree.chart.axis.AxisState
Sets the maximum width/height.
setMax(double) - Method in class promc.io.PBufFile.Record.F1D.Builder
optional double max = 4;
setMax(double) - Method in class promc.io.PBufFile.Record.H1D.Builder
required double max = 10;
setMaxCandleWidthInMilliseconds(double) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Sets the maximum candle width (in milliseconds) and sends a RendererChangeEvent to all registered listeners.
setMaxChipX(int) - Method in class org.jfree.data.general.WaferMapDataset
Sets wafer x dimension.
setMaxChipY(int) - Method in class org.jfree.data.general.WaferMapDataset
Sets the number of chips in the y-dimension.
setMaxColumns(int) - Method in class org.jlab.groot.ui.TreeEditor
 
setMaxEvaluations(int) - Method in class org.apache.commons.math3.ode.AbstractFieldIntegrator
Set the maximal number of differential equations function evaluations.
setMaxEvaluations(int) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Set the maximal number of differential equations function evaluations.
setMaxEvaluations(int) - Method in interface org.apache.commons.math3.ode.FirstOrderFieldIntegrator
Set the maximal number of differential equations function evaluations.
setMaxEvaluations(int) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Set the maximal number of differential equations function evaluations.
setMaxEvents(int) - Static method in class hep.lcio.util.SIODump
 
setMaxGrowth(double) - Method in class org.apache.commons.math3.ode.MultistepFieldIntegrator
Set the maximal growth factor for stepsize control.
setMaxGrowth(double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Set the maximal growth factor for stepsize control.
setMaxGrowth(T) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Set the maximal growth factor for stepsize control.
setMaxGrowth(double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Set the maximal growth factor for stepsize control.
setMaxHeight(double) - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Sets the maximum height and sends an AnnotationChangeEvent to all registered listeners.
setMaxIcon(Icon) - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Sets the icon displayed for the maximum value data item within each category and sends a RendererChangeEvent to all registered listeners.
setMaximalCount(int) - Method in class org.apache.commons.math3.util.Incrementor
Deprecated.
Sets the upper limit for the counter.
setMaxImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the maximum.
setMaximumBarWidth(double) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the maximum bar width, which is specified as a percentage of the available space for all bars, and sends a RendererChangeEvent to all registered listeners.
setMaximumBarWidth(double) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Sets the maximum bar width, which is specified as a percentage of the available space for all bars, and sends a RendererChangeEvent to all registered listeners.
setMaximumCategoryCount(int) - Method in class org.jfree.data.category.SlidingCategoryDataset
Sets the maximum category count and sends a DatasetChangeEvent to all registered listeners.
setMaximumCategoryCount(int) - Method in class org.jfree.data.gantt.SlidingGanttCategoryDataset
Sets the maximum category count and sends a DatasetChangeEvent to all registered listeners.
setMaximumCategoryLabelLines(int) - Method in class org.jfree.chart.axis.CategoryAxis
Sets the maximum number of lines to use for each category label and sends an AxisChangeEvent to all registered listeners.
setMaximumCategoryLabelWidthRatio(float) - Method in class org.jfree.chart.axis.CategoryAxis
Sets the maximum category label width ratio and sends an AxisChangeEvent to all registered listeners.
setMaximumDate(Date) - Method in class org.jfree.chart.axis.DateAxis
Sets the maximum date visible on the axis and sends an AxisChangeEvent to all registered listeners.
setMaximumDrawHeight(int) - Method in class org.jfree.chart.ChartPanel
Sets the maximum drawing height for the chart on this panel.
setMaximumDrawWidth(int) - Method in class org.jfree.chart.ChartPanel
Sets the maximum drawing width for the chart on this panel.
setMaximumItemAge(long) - Method in class org.jfree.data.time.TimeSeries
Sets the number of time units in the 'history' for the series.
setMaximumItemCount(int) - Method in class org.jfree.data.ComparableObjectSeries
Sets the maximum number of items that will be retained in the series.
setMaximumItemCount(int) - Method in class org.jfree.data.time.TimeSeries
Sets the maximum number of items that will be retained in the series.
setMaximumItemCount(int) - Method in class org.jfree.data.xy.XYSeries
Sets the maximum number of items that will be retained in the series.
setMaximumItemWidth(double) - Method in class org.jfree.chart.renderer.category.LevelRenderer
Sets the maximum item width, which is specified as a percentage of the available space for all items, and sends a RendererChangeEvent to all registered listeners.
setMaximumIterations(int) - Method in class jhplot.math.num.IterativeMethod
Modify the maximum number of iterations.
setMaximumIterations(int) - Method in class jhplot.math.num.root.Bracket
Modify the maximum number of iterations.
setMaximumLabelWidth(double) - Method in class org.jfree.chart.plot.PiePlot
Sets the maximum label width as a percentage of the plot width and sends a PlotChangeEvent to all registered listeners.
setMaximumLinesToDisplay(int) - Method in class org.jfree.chart.title.TextTitle
Sets the maximum number of lines to display and sends a TitleChangeEvent to all registered listeners.
setMaximumRelativeError(double) - Method in class jhplot.math.num.IterativeMethod
Modify the maximum relative error.
setMaximumValue(double) - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Sets the maximum value.
setMaxItemWidth(double) - Method in class org.jfree.chart.renderer.category.LevelRenderer
setMaxIterations(int) - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated.
Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in interface org.apache.commons.math3.optimization.linear.LinearOptimizer
Deprecated.
Set the maximal number of iterations of the algorithm.
setMaxLen(int) - Method in class org.lsmp.djep.xjep.PrintVisitor
Sets the maximum length printed per line.
setMaxNumberOfSubticsLog(int) - Method in class jhplot.HPlot
Sets the maximum number of subticks allowed for log10 scale.
setMaxNumberOfTics(int) - Method in class jplot.GraphSettings
Sets the maximum number of tics allowed for log scale.
setMaxRows(int) - Method in class org.jlab.groot.ui.TreeEditor
 
setMaxTemplateValue(Number) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the template value for the maximum size of the indicator bounds and sends a DialLayerChangeEvent to all registered listeners.
setMaxValue(int, double) - Method in class jhplot.HPlot
Sets the maximum data value displayed on the axis.
setMaxValue(int, double) - Method in class jplot.GraphSettings
Sets the maximum data value displayed on the axis.
setMaxValue(double) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the maximum value any category axis can take and sends a PlotChangeEvent to all registered listeners.
setMaxWidth(double) - Method in class org.jfree.chart.annotations.XYTitleAnnotation
Sets the maximum width and sends an AnnotationChangeEvent to all registered listeners.
setMaxX(double) - Method in class jhplot.F2D
Set Max value in X
setMaxX(double) - Method in class jhplot.F3D
Set Max value in X
setMaxX(double) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setMaxX(double) - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double maxX = 4;
setMaxY(double) - Method in class jhplot.F2D
Set Max value in Y
setMaxY(double) - Method in class jhplot.F3D
Set Max value in Y
setMaxY(double) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setMaxY(double) - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double maxY = 6;
setMaxZ(double) - Method in class jhplot.F3D
Set Max value in Z
setMaxZ(double) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Sets the maximum Z value.
setMCParticle(MCParticle) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setMean(double) - Method in class cern.jet.random.Poisson
Sets the mean.
setMean(double) - Method in class cern.jet.random.PoissonSlow
Sets the mean.
setMean(double) - Method in class jhplot.math.num.pdf.Exponential
Modify the mean.
setMean(double) - Method in class jhplot.math.num.pdf.Laplace
Modify the mean.
setMean(double) - Method in class jhplot.math.num.pdf.Logistic
Modify the mean.
setMean(double) - Method in class jhplot.math.num.pdf.LogNormal
Modify the mean.
setMean(double) - Method in class jhplot.math.num.pdf.Normal
Modify the mean.
setMean(double) - Method in class jhplot.math.num.pdf.Poisson
Modify the mean.
setMean(double) - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double mean = 16;
setMeanAndRms(double, double) - Method in class jhplot.H1D
Sets the Mean and RMS of H1D histogram
setMeanAndRms(double, double) - Method in class jhplot.HProf1D
Sets the Mean and RMS of H1D histogram
setMeanImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the mean.
setMeans(int, double) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double means = 4 [packed = true];
setMeansX(int, double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansX = 4 [packed = true];
setMeansY(int, double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double meansY = 7 [packed = true];
setMeanVisible(boolean) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Sets the flag that controls whether or not the mean indicator is drawn for each item, and sends a RendererChangeEvent to all registered listeners.
setMeanX(double) - Method in class jhplot.H2D
Set mean on X.
setMeanX(double) - Method in class jhplot.HProf2D
Set mean on X.
setMeanY(double) - Method in class jhplot.H2D
Set mean on Y
setMeanY(double) - Method in class jhplot.HProf2D
Set mean on Y
setMeasurement_matrix(Matrix) - Method in class jhplot.math.kalman.JKalman
Setter
setMeasurement_noise_cov(Matrix) - Method in class jhplot.math.kalman.JKalman
Setter
setMedian(double) - Method in class jhplot.math.num.pdf.Cauchy
Modify the location parameter.
setMedianVisible(boolean) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Sets the flag that controls whether or not the median indicator is drawn for each item, and sends a RendererChangeEvent to all registered listeners.
setMediumStrategy() - Method in class org.freehep.math.minuit.MnStrategy
 
setMercuryPaint(Paint) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the default mercury paint and sends a PlotChangeEvent to all registered listeners.
setMesh(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setMessage(String) - Method in class jplot3d.SurfaceModelCanvas
Sets the text of status line
setMET(int, long) - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated uint64 MET = 1 [packed = true];
setMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
setMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
setMetaFloat(int, ProMCStatFile.ProMCStat.MetaFloat) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
setMetaFloat(int, ProMCStatFile.ProMCStat.MetaFloat.Builder) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaFloat metaFloat = 12;
setMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
setMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
setMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
setMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
setMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
setMetaFloat(int, ProMCHeaderFile.ProMCHeader.MetaFloat.Builder) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaFloat metaFloat = 32;
setMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
setMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
setMetaInt(int, ProMCStatFile.ProMCStat.MetaInt) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
setMetaInt(int, ProMCStatFile.ProMCStat.MetaInt.Builder) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.MetaInt metaInt = 11;
setMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
setMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
setMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
setMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
setMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
setMetaInt(int, ProMCHeaderFile.ProMCHeader.MetaInt.Builder) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.MetaInt metaInt = 31;
setMeterAngle(int) - Method in class org.jfree.chart.plot.MeterPlot
Sets the angle (in degrees) for the whole range of the dial and sends a PlotChangeEvent to all registered listeners.
setMin(double) - Method in class jhplot.F1D
Set Min value in X
setMin(double) - Method in class jhplot.FND
Set Min value in X
setMin(double) - Method in class jhplot.H1D
Set Min value of axis
setMin(double) - Method in class jhplot.HProf1D
Set Min value of axis
setMin(double) - Method in class promc.io.PBufFile.Record.F1D.Builder
optional double min = 3;
setMin(double) - Method in class promc.io.PBufFile.Record.H1D.Builder
required double min = 9;
setMinColumnWidth(int) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the minimum number of characters a column may have.
setMinIcon(Icon) - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Sets the icon displayed for the minimum value data item within each category and sends a RendererChangeEvent to all registered listeners.
setMinImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the minimum.
setMinimumArcAngleToDraw(double) - Method in class org.jfree.chart.plot.PiePlot
Sets the minimum arc angle that will be drawn.
setMinimumBarLength(double) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the minimum bar length and sends a RendererChangeEvent to all registered listeners.
setMinimumDate(Date) - Method in class org.jfree.chart.axis.DateAxis
Sets the minimum date visible on the axis and sends an AxisChangeEvent to all registered listeners.
setMinimumDrawHeight(int) - Method in class org.jfree.chart.ChartPanel
Sets the minimum drawing height for the chart on this panel.
setMinimumDrawWidth(int) - Method in class org.jfree.chart.ChartPanel
Sets the minimum drawing width for the chart on this panel.
setMinimumValue(double) - Method in class org.jfree.chart.axis.ColorBar
Deprecated.
Sets the minimum value.
setMinMax(double, double) - Method in class org.jlab.groot.math.Dimension1D
 
setMinorTickCount(int) - Method in class org.jfree.chart.axis.ValueAxis
Sets the number of minor tick marks to display, and sends an AxisChangeEvent to all registered listeners.
setMinorTickCount(int) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the number of minor tick marks between major tick marks and sends a DialLayerChangeEvent to all registered listeners.
setMinorTickLength(double) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the length factor for the minor tick marks and sends a DialLayerChangeEvent to all registered listeners.
setMinorTickMarkInsideLength(float) - Method in class org.jfree.chart.axis.Axis
Sets the inside length of the minor tick marks and sends an AxisChangeEvent to all registered listeners.
setMinorTickMarkInsideLength(float) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the inside length of the minor tick marks and sends an AxisChangeEvent to all registered listeners.
setMinorTickMarkOutsideLength(float) - Method in class org.jfree.chart.axis.Axis
Sets the outside length of the minor tick marks and sends an AxisChangeEvent to all registered listeners.
setMinorTickMarkOutsideLength(float) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the outside length of the minor tick marks and sends an AxisChangeEvent to all registered listeners.
setMinorTickMarkPaint(Paint) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the paint used to display minor tick marks, if they are visible, and sends a AxisChangeEvent to all registered listeners.
setMinorTickMarkStroke(Stroke) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the stroke used to display minor tick marks, if they are visible, and sends a AxisChangeEvent to all registered listeners.
setMinorTickMarksVisible(boolean) - Method in class org.jfree.chart.axis.Axis
Sets the flag that indicates whether or not the minor tick marks are showing and sends an AxisChangeEvent to all registered listeners.
setMinorTickMarksVisible(boolean) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the flag that controls whether or not minor tick marks are displayed for the axis, and sends a AxisChangeEvent to all registered listeners.
setMinorTickPaint(Paint) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the paint used to draw the minor tick marks and sends a DialLayerChangeEvent to all registered listeners.
setMinorTickStroke(Stroke) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the stroke used to draw the minor tick marks and sends a DialLayerChangeEvent to all registered listeners.
setMinorTickTimePeriodClass(Class) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the class that controls the spacing of the minor tick marks, and sends an AxisChangeEvent to all registered listeners.
setMinReduction(double) - Method in class org.apache.commons.math3.ode.MultistepFieldIntegrator
Set the minimal reduction factor for stepsize control.
setMinReduction(double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Set the minimal reduction factor for stepsize control.
setMinReduction(T) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Set the minimal reduction factor for stepsize control.
setMinReduction(double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Set the minimal reduction factor for stepsize control.
setMinuteFormatter(NumberFormat) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the formatter for the minutes.
setMinuteSuffix(String) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the string that is appended to the minute count.
setMinValue(int, double) - Method in class jhplot.HPlot
Sets the start-value displayed on the axis.
setMinValue(int, double) - Method in class jplot.GraphSettings
Sets the start-value displayed on the axis.
setMinX(double) - Method in class jhplot.F2D
Set Min in X
setMinX(double) - Method in class jhplot.F3D
Set Min in X
setMinX(double) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setMinX(double) - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double minX = 3;
setMinY(double) - Method in class jhplot.F2D
Set Min value in Y
setMinY(double) - Method in class jhplot.F3D
Set Min value in Y
setMinY(double) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setMinY(double) - Method in class promc.io.PBufFile.Record.F2D.Builder
optional double minY = 5;
setMinZ(double) - Method in class jhplot.F3D
Set Min value in Z
setMinZ(double) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Sets the minimum Z value.
setMissingET(ProMC.ProMCEvent.MissingET) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.MissingET missingET = 10;
setMissingET(ProMC.ProMCEvent.MissingET.Builder) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.MissingET missingET = 10;
setMissingPaint(Paint) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the missingPaint.
setMode(int) - Method in class org.apache.commons.math3.random.ValueServer
Sets the data generation mode.
setMode(int, boolean) - Method in class org.lsmp.djep.xjep.PrintVisitor
Set printing mode.
setModel(TableXYDataset) - Method in class org.jfree.data.xy.XYDatasetTableModel
Sets the model (dataset).
setMomentum(float[]) - Method in class hep.lcio.implementation.event.IMCParticle
 
setMomentum(double[]) - Method in class hep.lcio.implementation.event.IMCParticle
 
setMomentum(double, double, double) - Method in class hep.lcio.implementation.event.IMCParticle
 
setMomentum(float[]) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setMomentum(double[]) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setMomentum(double, double, double) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setMomentum(float[]) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setMomentumAtEndpoint(float[]) - Method in class hep.lcio.implementation.event.IMCParticle
 
setMomentumAtEndpoint(double[]) - Method in class hep.lcio.implementation.event.IMCParticle
 
setMomentumRange(double, double) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Select the momentum range in GeV.
setMomentumUnit(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
setMomentumUnit(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
setMomentumUnit(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
setMomentumUnit(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 MomentumUnit = 16;
setMother1(int, int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
setMother1(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
setMother1(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother1 = 8 [packed = true];
setMother2(int, int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
setMother2(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
setMother2(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 mother2 = 9 [packed = true];
setMouseWheelEnabled(boolean) - Method in class org.jfree.chart.ChartPanel
Enables or disables mouse wheel support for the panel.
setMouseZoomable(boolean) - Method in class org.jfree.chart.ChartPanel
A convenience method that switches on mouse-based zooming.
setMouseZoomable(boolean, boolean) - Method in class org.jfree.chart.ChartPanel
A convenience method that switches on mouse-based zooming.
setMPI(int) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 MPI = 3;
setMPI(int) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 MPI = 3;
setMPI(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 MPI = 3 [packed = true];
setMu(double) - Method in class org.apache.commons.math3.random.ValueServer
Sets the mean used in data generation.
setMultiple(boolean) - Method in class org.jfree.chart.renderer.OutlierList
Sets the flag that indicates whether or not this list represents multiple outliers.
setMultiplier(float) - Method in class jplot.LinePars
Sets the multiplier for this line, a value which will be used to multiply each value of the dataset before plotting.
setMuons(ProMC.ProMCEvent.Muons) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Muons muons = 7;
setMuons(ProMC.ProMCEvent.Muons.Builder) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Muons muons = 7;
setMValue(MatrixValueI) - Method in class org.lsmp.djep.matrixJep.MatrixPartialDerivative
 
setMValue(MatrixValueI) - Method in class org.lsmp.djep.matrixJep.MatrixVariable
 
setMValue(MatrixValueI) - Method in interface org.lsmp.djep.matrixJep.MatrixVariableI
Sets the value of the variable (matrix aware).
setNAccepted(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
setNAccepted(int) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
setNAccepted(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
setNAccepted(int) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nAccepted = 8;
setName(String) - Method in class jhplot.F1D
Sets a name of the function, i.e.
setName(String) - Method in class jhplot.F2D
Sets a name of the function, i.e.
setName(String) - Method in class jhplot.F3D
Sets a name of the function, i.e.
setName(String) - Method in class jhplot.FND
Sets a name of the function, i.e.
setName(String) - Method in class jhplot.FProxy
Set actual function definition.
setName(String) - Method in class jhplot.HChart
Set global title to the current chart.
setName(String) - Method in class jhplot.HPlot
Sets a title for the current plot.
setName(String, Font, Color) - Method in class jhplot.HPlot
Sets a title for the current plot with all attributes
setName(String, Font) - Method in class jhplot.HPlot
Sets a title for the current plot with all attributes
setName(String) - Method in class jhplot.PND
Set a new title
setName(int, String) - Method in class jminhep.cluster.DataHolder
Set the title for ith component
setName(String) - Method in class jplot.LinePars
Set the name of this dataset.
setName(String) - Method in class org.apache.commons.io.monitor.FileEntry
Set the file name.
setName(String) - Method in class org.jlab.groot.data.GraphErrors
 
setName(String) - Method in class org.jlab.groot.data.H1F
Sets the specified parameter as the name of the histogram
setName(String) - Method in class org.jlab.groot.data.H2F
 
setName(String) - Method in interface org.jlab.groot.data.IDataSet
 
setName(String) - Method in class org.jlab.groot.group.DataGroup
 
setName(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
setName(String) - Method in class org.jlab.groot.math.Func1D
 
setName(String) - Method in class org.jlab.groot.math.UserParameter
 
setName(String) - Method in class org.jlab.groot.tree.AbstractDescriptor
 
setName(String) - Method in class org.jlab.groot.tree.Branch
 
setName(String) - Method in class org.jlab.groot.tree.TreeCut
 
setName(String) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
setName(String) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
setName(String) - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
setName(String) - Method in class promc.io.PBufFile.Record.Builder
optional string name = 1;
setName(String) - Method in class promc.io.PBufFile.Record.F1D.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.F2D.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.FND.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.FPR.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.H1D.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.H2D.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.P0D.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.P0I.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.P1D.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.PND.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.PNI.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.PXY.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
required string name = 1 [default = "none"];
setName(String) - Method in class promc.io.PEventFile.HEvent.Builder
optional string name = 2;
setName(String) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
optional string name = 1;
setName(String) - Method in class promc.io.PEventFile.HEvent.Group.Builder
optional string name = 1;
setName(String) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
setName(String) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
setName(String) - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
setName(String) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
setName(String) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
setName(String) - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
setName(String) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
setName(String) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
setName(String) - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
setNameBytes(ByteString) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
setNameBytes(ByteString) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
setNameBytes(ByteString) - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.Builder
optional string name = 1;
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.F1D.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.F2D.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.FND.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.FPR.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.H1D.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.H2D.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.P0D.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.P0I.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.P1D.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.PND.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.PNI.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.PXY.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
required string name = 1 [default = "none"];
setNameBytes(ByteString) - Method in class promc.io.PEventFile.HEvent.Builder
optional string name = 2;
setNameBytes(ByteString) - Method in class promc.io.PEventFile.HEvent.Entry.Builder
optional string name = 1;
setNameBytes(ByteString) - Method in class promc.io.PEventFile.HEvent.Group.Builder
optional string name = 1;
setNameBytes(ByteString) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
setNameBytes(ByteString) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
setNameBytes(ByteString) - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
setNameBytes(ByteString) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
setNameBytes(ByteString) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
setNameBytes(ByteString) - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
setNameBytes(ByteString) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string name = 12;
setNameBytes(ByteString) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
required string name = 3;
setNameBytes(ByteString) - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData.Builder
required string name = 4;
setNameLengthUnit(String) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
setNameLengthUnit(String) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
setNameLengthUnit(String) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
setNameLengthUnit(String) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
setNameLengthUnitBytes(ByteString) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
setNameLengthUnitBytes(ByteString) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
setNameLengthUnitBytes(ByteString) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
setNameLengthUnitBytes(ByteString) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameLengthUnit = 19;
setNameMomentumUnit(String) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
setNameMomentumUnit(String) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
setNameMomentumUnit(String) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
setNameMomentumUnit(String) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
setNameMomentumUnitBytes(ByteString) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
setNameMomentumUnitBytes(ByteString) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
setNameMomentumUnitBytes(ByteString) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
setNameMomentumUnitBytes(ByteString) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional string NameMomentumUnit = 18;
setNamePos(double, double, String) - Method in class jhplot.HPlot
Sets the position for the title of the current plot.
setNamePos(double, double) - Method in class jhplot.HPlot
Sets the position for the title of the current plot.
setNameX(String) - Method in class jhplot.DrawOptions
Set the name for X-axis.
setNameX(String) - Method in class jhplot.HChart
Sets the name for X axis.
setNameX(String, Font, Color) - Method in class jhplot.HPlot
Set the label for the axis in X
setNameX(String) - Method in class jhplot.HPlot
Sets the name for X axis.
setNameX(String, Font) - Method in class jhplot.HPlot
Sets the name for X axis.
setNameX(String) - Method in class jhplot.HPlot3D
Set a name for X axis
setNameX(String) - Method in class jhplot.HPlot3DP
Set a name for X axis
setNameX(String) - Method in class jplot.LinePars
Set the name of X axis
setNameX(String) - Method in class jplot3dp.ModelView
 
setNameXpos(double, double, String) - Method in class jhplot.HPlot
Sets the position for label on X axis.
setNameXpos(double, double) - Method in class jhplot.HPlot
Sets the position for label on X axis in NDC system.
setNameY(String) - Method in class jhplot.DrawOptions
Sets the name for Y-axis.
setNameY(String) - Method in class jhplot.HChart
Sets the name for Y axis.
setNameY(String) - Method in class jhplot.HPlot
Sets the name for Y axis.
setNameY(String, Font) - Method in class jhplot.HPlot
Sets the name for Y axis.
setNameY(String, Font, Color) - Method in class jhplot.HPlot
Sets the Title for Y-axis
setNameY(String) - Method in class jhplot.HPlot3D
Set a name for Y axis
setNameY(String) - Method in class jhplot.HPlot3DP
Set a name for Y axis
setNameY(String) - Method in class jplot.LinePars
Set the name of Y axis
setNameY(String) - Method in class jplot3dp.ModelView
 
setNameYpos(double, double, String) - Method in class jhplot.HPlot
Sets the position for label on Y axis.
setNameYpos(double, double) - Method in class jhplot.HPlot
Sets the position for label on Y axis in NDC system.
setNameZ(String) - Method in class jhplot.DrawOptions
Sets the title for Z-axis
setNameZ(String) - Method in class jhplot.HPlot3D
Set a name for Z axis
setNameZ(String) - Method in class jhplot.HPlot3DP
Set a name for Z axis
setNameZ(String) - Method in class jplot.LinePars
Set the name of Z axis
setNameZ(String) - Method in class jplot3dp.ModelView
 
setNandP(int, double) - Method in class cern.jet.random.Binomial
Sets the parameters number of trials and the probability of success.
setNandP(int, double) - Method in class cern.jet.random.NegativeBinomial
Sets the parameters number of trials and the probability of success.
setNbinsX(int) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setNbinsY(int) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setNdf(int) - Method in class hep.lcio.implementation.event.ITrack
 
setNDF(int) - Method in class org.jlab.groot.math.Func1D
 
setNeedlePaint(Paint) - Method in class org.jfree.chart.plot.MeterPlot
Sets the paint used to display the needle and sends a PlotChangeEvent to all registered listeners.
setNegativeArrowVisible(boolean) - Method in class org.jfree.chart.axis.ValueAxis
Sets a flag that controls whether or not the axis lines has an arrow drawn that points in the negative direction for the axis, and sends an AxisChangeEvent to all registered listeners.
setNegativeBarPaint(Paint) - Method in class org.jfree.chart.renderer.category.WaterfallBarRenderer
Sets the paint that will be used to draw bars having negative values, and sends a RendererChangeEvent to all registered listeners.
setNegativeItemLabelPosition(ItemLabelPosition) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
setNegativeItemLabelPosition(ItemLabelPosition, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
setNegativeItemLabelPosition(ItemLabelPosition) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
setNegativeItemLabelPosition(ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
setNegativeItemLabelPosition(ItemLabelPosition) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesNegativeItemLabelPosition(int, ItemLabelPosition) and XYItemRenderer.setBaseNegativeItemLabelPosition(ItemLabelPosition).
setNegativeItemLabelPosition(ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
setNegativeItemLabelPositionFallback(ItemLabelPosition) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the fallback position for negative item labels that don't fit within a bar, and sends a RendererChangeEvent to all registered listeners.
setNegativeItemLabelPositionFallback(ItemLabelPosition) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the fallback position for negative item labels that don't fit within a bar, and sends a RendererChangeEvent to all registered listeners.
setNegativePaint(Paint) - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Sets the paint used to highlight negative differences.
setNEntries(int) - Method in class jhplot.H1D
Sets number of entries of H1D histogram.
setNEntries(int) - Method in class jhplot.H2D
Set all entries.
setNEntries(int) - Method in class jhplot.HProf1D
Sets number of entries of the histogram.
setNEntries(int) - Method in class jhplot.HProf2D
Set all entries.
setNentries(int) - Method in class promc.io.PBufFile.Record.H1D.Builder
optional int32 nentries = 12;
setNentries(int) - Method in class promc.io.PBufFile.Record.H2D.Builder
optional int32 nentries = 12;
setNeventsFailed(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
setNeventsFailed(int) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
setNeventsFailed(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
setNeventsFailed(int) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_failed = 2;
setNeventsRequested(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
setNeventsRequested(int) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
setNeventsRequested(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
setNeventsRequested(int) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nevents_requested = 1;
setNJets(int) - Method in class hep.physics.jet.FixNumberOfJetsFinder
Set number of jets requested to be formed.
setNLevels(int) - Method in class graph.Contour
Set the number of contour levels.
setNLevels(int) - Method in class jplot.Contour
Set the number of contour levels.
setNMC(double) - Method in class jhplot.stat.limit.StatConfidence
Set number of MC events
setNobs(int) - Method in class jhplot.stat.limit.ExpData
Set number of observations
setNoData(boolean) - Method in class jplot.GraphSettings
Set no data flag
setNoDataMessage(String) - Method in class org.jfree.chart.plot.Plot
Sets the message that is displayed when the dataset is empty or null, and sends a PlotChangeEvent to all registered listeners.
setNoDataMessageFont(Font) - Method in class org.jfree.chart.plot.Plot
Sets the font used to display the 'no data' message and sends a PlotChangeEvent to all registered listeners.
setNoDataMessagePaint(Paint) - Method in class org.jfree.chart.plot.Plot
Sets the paint used to display the 'no data' message and sends a PlotChangeEvent to all registered listeners.
setNoIntercept(boolean) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
 
setNotify(boolean) - Method in class org.jfree.chart.annotations.AbstractAnnotation
Sets a flag that indicates whether listeners should be notified about changes of an annotation.
setNotify(boolean) - Method in class org.jfree.chart.JFreeChart
Sets a flag that controls whether or not listeners receive ChartChangeEvent notifications.
setNotify(boolean) - Method in class org.jfree.chart.plot.Plot
Sets a flag that controls whether or not listeners receive PlotChangeEvent notifications.
setNotify(boolean) - Method in class org.jfree.chart.title.Title
Sets the flag that indicates whether or not the notification mechanism is enabled.
setNotify(boolean) - Method in class org.jfree.data.general.AbstractDataset
Sets the notify flag, which controls whether or not the AbstractDataset.fireDatasetChanged() method notifies listeners.
setNotify(boolean) - Method in class org.jfree.data.general.Series
Sets the flag that controls whether or not change events are sent to registered listeners.
setNSelected(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
setNSelected(int) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
setNSelected(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
setNSelected(int) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nSelected = 7;
setNthreads(int) - Method in class org.jlab.groot.fitter.ParallelSliceFitter
 
setNTried(int) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
setNTried(int) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
setNTried(int) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
setNTried(int) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
optional int32 nTried = 6;
setNumber(int) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
setNumber(int) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
setNumber(int) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
optional int32 Number = 1;
setNumber(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 Number = 1 [packed = true];
setNumberFormat(NumberFormat) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the formatter used to format the value and sends a DialLayerChangeEvent to all registered listeners.
setNumberFormat(NumberFormat) - Method in class org.lsmp.djep.xjep.PrintVisitor
 
setNumberFormatOverride(NumberFormat) - Method in class org.jfree.chart.axis.LogAxis
Sets the number format override and sends a change event to all registered listeners.
setNumberFormatOverride(NumberFormat) - Method in class org.jfree.chart.axis.NumberAxis
Sets the number format override.
setNumberOfDigits(int) - Method in class org.jfree.chart.util.HexNumberFormat
Sets the number of digits.
setNumberOfFailures(int) - Method in class jhplot.math.num.pdf.Hypergeometric
Modify the number of failures.
setNumberOfParticles(int) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Set the number of particles to generate in a single event.
setNumberOfSuccesses(int) - Method in class jhplot.math.num.pdf.Hypergeometric
Modify the number of successes.
setNumberOfSuccesses(int) - Method in class jhplot.math.num.pdf.NegativeBinomial
Modify the number of successes.
setNumberOfTics(int, int) - Method in class jhplot.HPlot
Sets the number of ticks for the specified axis.
setNumberOfTics(int, int) - Method in class jplot.GraphSettings
Sets the number of tics for the specified axis.
setNumberOfTicsFixed(int, boolean) - Method in class jhplot.HPlot
Says whether the user fixes the number of ticks for a specific axis.
setNumberOfTicsFixed(boolean) - Method in class jhplot.HPlot
Says whether the user fixes the number of ticks for a specific for all axes.
setNumberOfTrials(int) - Method in class jhplot.math.num.pdf.Binomial
Modify the number of trials.
setNumElements(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
This function allows you to control the number of elements contained in this array, and can be used to "throw out" the last n values in an array.
setNumeratorDegreesOfFreedom(double) - Method in class jhplot.math.num.pdf.FDistribution
Modify the numerator degrees of freedom.
setNumeratorFormat(NumberFormat) - Method in class org.apache.commons.math3.fraction.AbstractFormat
Modify the numerator format.
setNumParam(int) - Method in class org.nfunk.jep.evaluation.CommandElement
 
setObject(Object) - Method in class org.jfree.data.KeyedObject
Sets the object.
setObject(Comparable, Object) - Method in class org.jfree.data.KeyedObjects
Replaces an existing object, or adds a new object to the collection.
setObject(Object, Comparable, Comparable) - Method in class org.jfree.data.KeyedObjects2D
Adds or updates an object.
setObjectIcon(Icon) - Method in class org.jfree.chart.renderer.category.MinMaxCategoryRenderer
Sets the icon drawn for each data item and sends a RendererChangeEvent to all registered listeners.
setOffset(double) - Method in class org.jfree.chart.axis.CyclicNumberAxis
The cycle bound is a multiple of the period, plus optionally a start offset.
setOmega(float) - Method in class hep.lcio.implementation.event.ITrack
 
setOmega(float) - Method in class hep.lcio.implementation.event.ITrackState
 
setOpenTickPaint(Paint) - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Sets the paint used to draw the ticks for the open values and sends a RendererChangeEvent to all registered listeners.
setOperator(Operator) - Method in class org.nfunk.jep.ASTFunNode
Sets the opID, name and pfmc for this node by looking up the values in the Operators class
setOption(String, boolean) - Static method in class jhepsim.Options
Sets a boolean value for the parameter option name.
setOption(String, String) - Static method in class jhepsim.Options
Sets a string value for the parameter option name.
setOptions(int, double, double) - Method in class jminhep.algorithms.FuzzyCMeansAlg
Set initial conditions for clustering.
setOptions(int, double) - Method in class jminhep.algorithms.KMeansAlg
Set initial options for calculations
SetOptions() - Static method in class jminhep.clcontrol.Global
 
setOptions(String) - Method in class org.jlab.groot.graphics.FunctionPlotter
 
setOptions(String) - Method in class org.jlab.groot.graphics.GraphErrorsPlotter
 
setOptions(String) - Method in class org.jlab.groot.graphics.Histogram2DPlotter
 
setOptions(String) - Method in class org.jlab.groot.graphics.HistogramPlotter
 
setOptions(String) - Method in interface org.jlab.groot.graphics.IDataSetPlotter
 
setOptStat(String) - Method in class org.jlab.groot.base.DatasetAttributes
 
setOptStat(int) - Method in class org.jlab.groot.data.H1F
 
setOptStat(String) - Method in class org.jlab.groot.data.H1F
 
setOptStat(int) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setOptStat(String) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setOptStat(int) - Method in class org.jlab.groot.math.Func1D
 
setOptStat(String) - Method in class org.jlab.groot.math.Func1D
 
setOrderControl(int, double, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Set the order control parameters.
setOrientation(PlotOrientation) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the orientation for the plot and sends a PlotChangeEvent to all registered listeners.
setOrientation(PlotOrientation) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Sets the orientation of the plot (and all subplots).
setOrientation(PlotOrientation) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Sets the orientation for the plot (also changes the orientation for all the subplots to match).
setOrientation(PlotOrientation) - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Sets the orientation for the plot (and all the subplots).
setOrientation(PlotOrientation) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Sets the orientation for the plot (and all its subplots).
setOrientation(PlotOrientation) - Method in class org.jfree.chart.plot.XYPlot
Sets the orientation for the plot and sends a PlotChangeEvent to all registered listeners.
setOrigin(double, double, double) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Select an origin for the particle.
setOriginOffset(double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Set the offset of the origin.
setOut(PrintStream) - Method in class org.jlab.groot.ui.ProgressBar
called whenever the progress bar needs to be updated.
setOuterRadius(double) - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Sets the outer radius and sends a DialLayerChangeEvent to all registered listeners.
setOuterRadius(double) - Method in class org.jfree.chart.plot.dial.StandardDialRange
Sets the outer radius and sends a DialLayerChangeEvent to all registered listeners.
setOuterSeparatorExtension(double) - Method in class org.jfree.chart.plot.RingPlot
Sets the length of the outer extension of the separator line that is drawn between sections, as a percentage of the depth of the sections, and sends a change event to all registered listeners.
setOutlierCoefficient(double) - Method in class org.jfree.data.statistics.DefaultBoxAndWhiskerXYDataset
Sets the value used as the outlier coefficient
setOutline(boolean) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Sets a flag that controls whether or not outlines of the areas are drawn and sends a RendererChangeEvent to all registered listeners.
setOutline(boolean) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer2
Sets a flag that controls whether or not outlines of the areas are drawn, and sends a RendererChangeEvent to all registered listeners.
setOutline(boolean) - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Sets a flag that controls whether or not outlines of the areas are drawn, and sends a RendererChangeEvent to all registered listeners.
setOutlinePaint(Paint) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the outline paint for the annotation and sends an AnnotationChangeEvent to all registered listeners.
setOutlinePaint(Paint) - Method in class org.jfree.chart.LegendItem
Sets the outline paint.
setOutlinePaint(Paint) - Method in class org.jfree.chart.needle.MeterNeedle
Sets the outline paint.
setOutlinePaint(Paint) - Method in class org.jfree.chart.plot.dial.DialCap
Sets the paint used to draw the outline of the cap and sends a DialLayerChangeEvent to all registered listeners.
setOutlinePaint(Paint) - Method in class org.jfree.chart.plot.dial.DialPointer.Pointer
Sets the outline paint and sends a DialLayerChangeEvent to all registered listeners.
setOutlinePaint(Paint) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the outline paint and sends a DialLayerChangeEvent to all registered listeners.
setOutlinePaint(Paint) - Method in class org.jfree.chart.plot.JThermometer
Sets the outline paint.
setOutlinePaint(Paint) - Method in class org.jfree.chart.plot.Marker
Sets the outline paint and sends a MarkerChangeEvent to all registered listeners.
setOutlinePaint(Paint) - Method in class org.jfree.chart.plot.Plot
Sets the paint used to draw the outline of the plot area and sends a PlotChangeEvent to all registered listeners.
setOutlinePaint(Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesOutlinePaint(int, Paint) and AbstractRenderer.setBaseOutlinePaint(Paint).
setOutlinePaint(Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesOutlinePaint(int, Paint, boolean) and AbstractRenderer.setBaseOutlinePaint(Paint, boolean).
setOutlinePaint(Paint) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesOutlinePaint(int, Paint) and CategoryItemRenderer.setBaseOutlinePaint(Paint).
setOutlinePaint(Paint) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesOutlinePaint(int, Paint) and XYItemRenderer.setBaseOutlinePaint(Paint).
setOutlinePaint(Paint) - Method in class org.jfree.chart.title.LegendGraphic
Sets the outline paint.
setOutlineStroke(Stroke) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the outline stroke for the annotation and sends an AnnotationChangeEvent to all registered listeners.
setOutlineStroke(Stroke) - Method in class org.jfree.chart.LegendItem
Sets the outline stroke.
setOutlineStroke(Stroke) - Method in class org.jfree.chart.needle.MeterNeedle
Sets the outline stroke.
setOutlineStroke(Stroke) - Method in class org.jfree.chart.plot.dial.DialCap
Sets the stroke used to draw the outline of the cap and sends a DialLayerChangeEvent to all registered listeners.
setOutlineStroke(Stroke) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the outline stroke and sends a DialLayerChangeEvent to all registered listeners.
setOutlineStroke(Stroke) - Method in class org.jfree.chart.plot.Marker
Sets the outline stroke and sends a MarkerChangeEvent to all registered listeners.
setOutlineStroke(Stroke) - Method in class org.jfree.chart.plot.Plot
Sets the stroke used to outline the plot area and sends a PlotChangeEvent to all registered listeners.
setOutlineStroke(Stroke) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesOutlineStroke(int, Stroke) and AbstractRenderer.setBaseOutlineStroke(Stroke).
setOutlineStroke(Stroke, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesOutlineStroke(int, Stroke, boolean) and AbstractRenderer.setBaseOutlineStroke(Stroke, boolean).
setOutlineStroke(Stroke) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesOutlineStroke(int, Stroke) and CategoryItemRenderer.setBaseOutlineStroke(Stroke).
setOutlineStroke(Stroke) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesOutlineStroke(int, Stroke) and XYItemRenderer.setBaseOutlineStroke(Stroke).
setOutlineStroke(Stroke) - Method in class org.jfree.chart.title.LegendGraphic
Sets the outline stroke.
setOutlineVisible(boolean) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the flag that controls whether or not the outline is drawn and sends an AnnotationChangeEvent to all registered listeners.
setOutlineVisible(boolean) - Method in class org.jfree.chart.plot.Plot
Sets the flag that controls whether or not the plot's outline is drawn, and sends a PlotChangeEvent to all registered listeners.
setOutofrange(int, double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double outofrange = 10 [packed = true];
setOutputParams(int, int, int) - Static method in class Jampack.Parameters
Changes the output parameters.
setOverflow(double) - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double overflow = 14;
setOverlay(boolean) - Method in class hep.lcio.implementation.event.IMCParticle
 
setOverlay(boolean) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
SetOwner() - Method in class jhplot.stat.DataSource
Initialize all arrays
setP0D(PBufFile.Record.P0D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0D p0D = 3;
setP0D(PBufFile.Record.P0D.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0D p0D = 3;
setP0I(PBufFile.Record.P0I) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0I p0I = 2;
setP0I(PBufFile.Record.P0I.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P0I p0I = 2;
setP1D(PBufFile.Record.P1D) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P1D p1D = 6;
setP1D(PBufFile.Record.P1D.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.P1D p1D = 6;
setP2D(P2D) - Method in class jplot3d.JSurfacePanel
 
setP2D(ArrayList<P2D>) - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
setP2D(ArrayList<P2D>) - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
setP3D(P3D) - Method in class jplot3d.JSurfacePanel
 
setP3D(ArrayList<P3D>) - Method in interface jplot3d.SurfaceModelCanvas.Plotter
 
setP3D(ArrayList<P3D>) - Method in class jplot3d.SurfaceModelCanvas.PlotterImpl
 
setPad(EmbeddedPad) - Method in class org.jlab.groot.ui.TransferableImage
 
setPadding(RectangleInsets) - Method in class org.jfree.chart.block.AbstractBlock
Sets the padding (use RectangleInsets.ZERO_INSETS for no padding).
setPadding(double, double, double, double) - Method in class org.jfree.chart.block.AbstractBlock
Sets the padding.
setPadding(RectangleInsets) - Method in class org.jfree.chart.JFreeChart
Sets the padding between the chart border and the chart drawing area, and sends a ChartChangeEvent to all registered listeners.
setPadding(RectangleInsets) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the padding for the thermometer and sends a PlotChangeEvent to all registered listeners.
setPadMargins(PadMargins) - Method in class org.jlab.groot.base.PadAttributes
 
setPadTitles(String) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setPadTitlesX(String) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setPadTitlesY(String) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setPaint(Paint) - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Sets the paint used to draw the connecting line and sends an AnnotationChangeEvent to all registered listeners.
setPaint(Paint) - Method in class org.jfree.chart.annotations.TextAnnotation
Sets the paint for the annotation and sends an AnnotationChangeEvent to all registered listeners.
setPaint(Paint) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the paint for the annotation and sends an AnnotationChangeEvent to all registered listeners.
setPaint(Paint) - Method in class org.jfree.chart.block.LabelBlock
Sets the paint and regenerates the label.
setPaint(Paint) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the paint used to draw or fill shapes (or text).
setPaint(Paint) - Method in class org.jfree.chart.plot.Crosshair
Sets the paint for the crosshair line and sends a property change event with the name "paint" to all registered listeners.
setPaint(Paint) - Method in class org.jfree.chart.plot.dial.DialBackground
Sets the paint for the dial background and sends a DialLayerChangeEvent to all registered listeners.
setPaint(Paint) - Method in class org.jfree.chart.plot.dial.DialPointer.Pin
Sets the paint and sends a DialLayerChangeEvent to all registered listeners.
setPaint(Paint) - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Sets the paint used to display the label and sends a DialLayerChangeEvent to all registered listeners.
setPaint(Paint) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the paint and sends a DialLayerChangeEvent to all registered listeners.
setPaint(Paint) - Method in class org.jfree.chart.plot.dial.StandardDialRange
Sets the paint used to highlight the range and sends a DialLayerChangeEvent to all registered listeners.
setPaint(Paint) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the color for the data points and sends a PlotChangeEvent to all registered listeners.
setPaint(Paint) - Method in class org.jfree.chart.plot.Marker
Sets the paint and sends a MarkerChangeEvent to all registered listeners.
setPaint(Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesPaint(int, Paint) and AbstractRenderer.setBasePaint(Paint).
setPaint(Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesPaint(int, Paint, boolean) and AbstractRenderer.setBasePaint(Paint, boolean).
setPaint(Paint) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesPaint(int, Paint) and CategoryItemRenderer.setBasePaint(Paint).
setPaint(Paint) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesPaint(int, Paint) and XYItemRenderer.setBasePaint(Paint).
setPaint(Paint) - Method in class org.jfree.chart.title.TextTitle
Sets the paint used to display the title string.
setPaintMode() - Method in class org.jfree.chart.fx.FXGraphics2D
Not implemented - the method does nothing.
setPaintScale(PaintScale) - Method in class org.jfree.chart.renderer.xy.XYBlockRenderer
Sets the paint scale used by the renderer and sends a RendererChangeEvent to all registered listeners.
setPaintScale(PaintScale) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Sets the paint scale used by the renderer and sends a RendererChangeEvent to all registered listeners.
setPalette(ColorPalette) - Method in class org.jfree.chart.editor.PaletteSample
Deprecated.
Sets the palette object being displayed.
setPaletteName(String) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Sets the palette name.
setPalettes(Palette[]) - Method in class net.java.dev.colorchooser.ColorChooser
Set the Palette objects this color chooser will display.
setPanelSize(Dimension) - Method in class jhplot.HPlot
Sets the dimensions of the panel of the graph.
setPanelSize(Dimension) - Method in class jplot.GraphSettings
Sets the dimensions of the panel of the graph.
setPar(String, double) - Method in class jhplot.F1D
Replace abstract parameter with the value (double).
setPar(String, int) - Method in class jhplot.F1D
Replace abstract parameter with the value (integer).
setPar(String, double) - Method in class jhplot.F2D
Replace abstract parameter with the value (double).
setPar(String, double) - Method in class jhplot.F3D
Replace abstract parameter with the value (double).
setPar(String, double) - Method in class jhplot.HFitter
Set parameter to a value
setParameter(String, double) - Method in interface org.apache.commons.math3.ode.ParameterizedODE
Set the value for a given parameter.
setParameter(int, double) - Method in class org.jlab.groot.math.Func1D
 
setParameterizedODE(ParameterizedODE) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Set a parameter Jacobian provider.
setParameters(LCParameters) - Method in class hep.lcio.implementation.event.ILCCollection
 
setParameters(float[]) - Method in class hep.lcio.implementation.event.IParticleID
 
setParameters(float[]) - Method in class hep.lcio.implementation.event.IVertex
 
setParameters(double[]) - Method in class org.jlab.groot.math.Func1D
 
setParameters(double[]) - Method in class org.jlab.groot.math.UserParameters
 
setParameterStep(String, double) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Set the step associated to a parameter in order to compute by finite difference the Jacobian matrix.
setParConstraint(String) - Method in class jhplot.HFitter
Set parameter constraint Example: Set parameter "mean1" to be identical to "mean2" as: "mean1=mean2"
setParent(LParticle) - Method in class hephysics.particle.LParticle
Set a parent particle
setParent(Plot) - Method in class org.jfree.chart.plot.Plot
Sets the parent plot.
setParFixed(String) - Method in class jhplot.HFitter
Fix a given parameter to a constant value
setParFixed(String, boolean) - Method in class jhplot.HFitter
Fix a given parameter to a constant value or not
setParLimits(int, double, double) - Method in class org.jlab.groot.math.Func1D
 
setParRange(String, double, double) - Method in class jhplot.HFitter
Set range for parameter during the fit
setParsed(boolean) - Method in class jhplot.FProxy
 
setParStep(String, double) - Method in class jhplot.HFitter
Set step size for parameter (say 0.01)
setParStep(int, double) - Method in class org.jlab.groot.math.Func1D
 
setParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
setParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
setParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
setParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
setParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
setParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
setParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
setParticleData(int, ProMCHeaderFile.ProMCHeader.ParticleData.Builder) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
repeated .promc.ProMCHeader.ParticleData particleData = 30;
setParticleIDs(List) - Method in class hep.lcio.implementation.event.ICluster
 
setParticleIDs(List) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setParticles(List) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setParticles(ProMC.ProMCEvent.Particles) - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
setParticles(ProMC.ProMCEvent.Particles.Builder) - Method in class proeic.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
setParticles(ProMC.ProMCEvent.Particles) - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
setParticles(ProMC.ProMCEvent.Particles.Builder) - Method in class promc.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
setParticles(ProMC.ProMCEvent.Particles) - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
setParticles(ProMC.ProMCEvent.Particles.Builder) - Method in class pronlo.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
setParticles(ProMC.ProMCEvent.Particles) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
setParticles(ProMC.ProMCEvent.Particles.Builder) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Particles particles = 2;
setParticleType(ParticleType) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Set the particle type using a Java particle type.
setPassesRequired(int) - Method in class org.jfree.chart.plot.PiePlotState
Sets the number of passes required by the renderer.
setPassiveEuler(double, double, double) - Method in class hep.physics.vec.BasicHep3Matrix
Defines a rotation matrix via Euler angles.
setPassiveEuler(double, double, double) - Method in class hephysics.vec.Hep3Matrix
Defines a rotation matrix via Euler angles.
setPathLength(float) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setPaveTexts(List<List<LatexText>>) - Method in class org.jlab.groot.ui.PaveText
 
setPDF1(float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float PDF1 = 6;
setPdf1(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
setPDF1(float) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float PDF1 = 6;
setPdf1(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
setPdf1(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
setPDF1(int, float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF1 = 6 [packed = true];
setPdf1(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf1 = 8;
setPDF2(float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float PDF2 = 7;
setPdf2(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
setPDF2(float) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float PDF2 = 7;
setPdf2(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
setPdf2(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
setPDF2(int, float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float PDF2 = 7 [packed = true];
setPdf2(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf2 = 9;
setPdfId1(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
setPdfId1(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
setPdfId1(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
setPdfId1(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id1 = 3;
setPdfId2(int) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
setPdfId2(int) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
setPdfId2(int) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
setPdfId2(int) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional int32 pdf_id2 = 4;
setPDG(int) - Method in class hep.lcio.implementation.event.IMCParticle
 
setPDG(int) - Method in class hep.lcio.implementation.event.IParticleID
 
setPdgcode(int) - Method in class hephysics.particle.HEParticle
Set PDG code
setPdgId(int, int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
setPdgId(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
setPdgId(int, int) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
setPdgId(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 pdg_id = 2 [packed = true];
setPenColor(Color) - Method in class jhplot.P3D
Sets the symbol color
setPenDash() - Method in class jhplot.DrawOptions
Set dashed style with default length
setPenDash(int) - Method in class jhplot.DrawOptions
Set dashed style with default length
setPenWidth(int) - Method in class jhplot.DrawOptions
Set width of the lines
setPenWidth(int) - Method in class jhplot.FPR
Set width of lines
setPenWidth(int) - Method in class jhplot.P3D
Set width of the lines
setPenWidth(float) - Method in class jplot.LinePars
Sets the width of the lines
setPenWidth(float) - Method in class jplot.LineStyle
 
setPenWidth(float) - Method in class jplot.LineStyleButton
 
setPenWidth(float) - Method in interface jplot3d.SurfaceModel
 
setPenWidth(float) - Method in class jplot3d.SurfaceModelCanvas
 
setPenWidthAxes(double) - Method in class jhplot.HPlot3D
Set line width to draw axes.
setPenWidthAxis(double) - Method in class jhplot.HPlot
Set pen width to draw axis
setPenWidthAxis(float) - Method in class jplot.GraphSettings
Set pen width to draw axis
setPenWidthErr(int) - Method in class jhplot.DrawOptions
Set width of the lines used to show 1st level errors
setPenWidthErr(float) - Method in class jplot.LinePars
Set the width of the lines to show errors
setPenWidthErrSys(int) - Method in class jhplot.DrawOptions
Set width of the lines used to show 2nd level errors
setPenWidthErrSys(float) - Method in class jplot.LinePars
Set the width of the lines to show systematical errors
setPercent(int) - Method in class org.jfree.chart.event.ChartProgressEvent
Sets the percentage complete.
setPercentComplete(Double) - Method in class org.jfree.data.gantt.Task
Sets the percentage complete for the task.
setPercentComplete(double) - Method in class org.jfree.data.gantt.Task
Sets the percentage complete for the task.
setPercentileImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation to be used by DescriptiveStatistics.getPercentile(double).
setPeriod(double) - Method in class org.jfree.chart.axis.CyclicNumberAxis
The cycle bound is a multiple of the period, plus optionally a start offset.
setPFMC(PostfixMathCommandI) - Method in class org.nfunk.jep.evaluation.CommandElement
 
setPFMC(PostfixMathCommandI) - Method in class org.nfunk.jep.Operator
 
setPhi(float) - Method in class hep.lcio.implementation.event.ITrack
 
setPhi(float) - Method in class hep.lcio.implementation.event.ITrackState
 
setPhi(double) - Method in class hephysics.jet.ParticleD
 
setPhi(float) - Method in class hephysics.jet.ParticleF
 
setPhi(double) - Method in class hephysics.vec.Hep3Vector
Set phi
setPhi(int, long) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint64 Phi = 3 [packed = true];
setPhi(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated sint64 Phi = 3 [packed = true];
setPhi(int, long) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint64 Phi = 3 [packed = true];
setPhi(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint64 Phi = 3 [packed = true];
setPhi(int, long) - Method in class proreco.io.ProMC.ProMCEvent.MissingET.Builder
repeated sint64 Phi = 3 [packed = true];
setPhi(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated sint64 Phi = 3 [packed = true];
setPhi(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Phi = 21 [packed = true];
setPhi(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated sint64 Phi = 3 [packed = true];
setPhi(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint64 Phi = 3 [packed = true];
setPhiOuter(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 PhiOuter = 12 [packed = true];
setPhiRange(double, double) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Select the phi range between 0 and 2*PI in radians.
setPhotons(ProMC.ProMCEvent.Photons) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Photons photons = 9;
setPhotons(ProMC.ProMCEvent.Photons.Builder) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Photons photons = 9;
setPieArea(Rectangle2D) - Method in class org.jfree.chart.plot.PiePlotState
Sets the pie area.
setPieCenterX(double) - Method in class org.jfree.chart.plot.PiePlotState
Sets the x-coordinate of the center of the pie chart.
setPieCenterY(double) - Method in class org.jfree.chart.plot.PiePlotState
Sets the y-coordinate of the center of the pie chart.
setPieChart(JFreeChart) - Method in class org.jfree.chart.plot.MultiplePiePlot
Sets the chart that is used to draw the individual pie plots.
setPieHRadius(double) - Method in class org.jfree.chart.plot.PiePlotState
Sets the vertical pie radius.
setPieIndex(int) - Method in class org.jfree.chart.entity.PieSectionEntity
Sets the pie index.
setPieIndex(int) - Method in class org.jfree.chart.plot.PiePlot
Sets the pie index (this is used by the MultiplePiePlot class to track subplots).
setPieWRadius(double) - Method in class org.jfree.chart.plot.PiePlotState
Sets the horizontal pie radius.
setPlot(Plot) - Method in class org.jfree.chart.axis.Axis
Sets a reference to the plot that the axis is assigned to.
setPlot(CategoryPlot) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Sets the plot that the renderer has been assigned to.
setPlot(CategoryPlot) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the plot that the renderer has been assigned to.
setPlot(PolarPlot) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Set the plot associated with this renderer.
setPlot(PolarPlot) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Sets the plot that this renderer is assigned to.
setPlot(WaferMapPlot) - Method in class org.jfree.chart.renderer.WaferMapRenderer
Sets the plot and build the paint index.
setPlot(XYPlot) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Sets the plot that the renderer is assigned to.
setPlot(XYPlot) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the plot that this renderer is assigned to.
setPlotArea(Rectangle2D) - Method in class org.jfree.chart.plot.PlotRenderingInfo
Sets the plot area.
setPlotArea(boolean) - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Sets a flag that controls whether or not areas are drawn for each data item and sends a RendererChangeEvent to all registered listeners.
setPlotBackgroundPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the plot background paint.
setPlotColor(SurfaceModel.PlotColor) - Method in class jplot3d.ColorModelSet
 
setPlotColor(SurfaceModel.PlotColor) - Method in class jplot3d.SurfaceModelCanvas
 
setPlotDiscontinuous(boolean) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Sets the flag that controls whether or not the renderer shows discontinuous lines, and sends a RendererChangeEvent to all registered listeners.
setPlotFunction1(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setPlotFunction12(boolean, boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setPlotFunction2(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setPlotHorizontal() - Method in class jhplot.HChart
Set plot hirizontal orientation.
setPlotImages(boolean) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Sets the flag that controls whether or not an image is drawn at each data point and sends a RendererChangeEvent to all registered listeners.
setPlotLines(boolean) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Sets the flag that controls whether or not a line is plotted between each data point and sends a RendererChangeEvent to all registered listeners.
setPlotOutlinePaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the plot outline paint.
setPlotsNum(int, int) - Method in class jhplot.gui.GHFrame
Set the number of plots
setPlotType(SurfaceModel.PlotType) - Method in class jplot3d.ColorModelSet
 
setPlotType(SurfaceModel.PlotType) - Method in class jplot3d.SurfaceModelCanvas
 
setPlotVertical() - Method in class jhplot.HChart
Set plot vertical orientation (default).
setPND(PBufFile.Record.PND) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PND pND = 13;
setPND(PBufFile.Record.PND.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PND pND = 13;
setPNI(PBufFile.Record.PNI) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PNI pNI = 14;
setPNI(PBufFile.Record.PNI.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PNI pNI = 14;
setPoint(int, double, double) - Method in class jplot.DataArray
Sets the values of a plot-point pair (x,y).
setPoint(int, double, double, double, double) - Method in class jplot.DataArray
Sets the values of a plot-point pair (x,y).
setPoint(int, double, double, double, double, double, double) - Method in class jplot.DataArray
Sets the values of a plot-point pair (x,y).
setPoint(int, double, double, double, double, double, double, double, double, double, double) - Method in class jplot.DataArray
Sets the values of a plot-point pair (x,y).
setPoint(int, double, double, double) - Method in class jplot.DataArray2D
Sets the values of a plot-point pair (x,y).
setPoint(int, double, double, double, double, double, double) - Method in class jplot.DataArray3D
Sets the values of a plot-point pair (x,y).
setPoint(double, double) - Method in class jplot.PlotPoint
Sets x- and y values.
setPoint(double, double, double, double) - Method in class jplot.PlotPoint
Sets x- and y values.
setPoint(double, double, double, double, double, double) - Method in class jplot.PlotPoint
Sets x- and y values.
setPoint(double, double, double, double, double, double, double, double, double, double) - Method in class jplot.PlotPoint
Sets x- and y values.
setPoint(PlotPoint) - Method in class jplot.PlotPoint
Sets x- and y values.
setPoint(double, double, double) - Method in class jplot.PlotPoint2D
Sets x-, y and z values.
setPoint(PlotPoint2D) - Method in class jplot.PlotPoint2D
Sets x- and y and z values.
setPoint(double, double, double, double, double, double) - Method in class jplot.PlotPoint3D
Sets x-, y and z values.
setPoint(PlotPoint3D) - Method in class jplot.PlotPoint3D
Sets x- and y and z values.
setPoint(double, double, double) - Method in class jplot3d.JPoint
Sets x-, y and z values.
setPoint(double, double, double, double) - Method in class jplot3d.JPoint
Sets x-, y and z values.
setPoint(double, double, double, double, Color, int) - Method in class jplot3d.JPoint
 
setPoint(JPoint) - Method in class jplot3d.JPoint
Sets x- and y and z values.
setPoint(Point2D) - Method in class org.jfree.chart.renderer.Outlier
Sets the xy coordinates of the bounding box containing the outlier ellipse.
setPoint(int, double, double) - Method in class org.jlab.groot.data.GraphErrors
 
setPointFrequency(int) - Method in class jplot.LinePars
Sets the frequency used to draw points in terms of an 'every' parameter (every 2 data-point, every 200 data point...).
setPoints(int) - Method in class jhplot.F1D
Sets the number points between Min and Max for evaluation
setPoints(int) - Method in class jhplot.F2D
Get the number of points
setPoints(int) - Method in class jhplot.F3D
Get the number of points
setPoints(int) - Method in class jhplot.FND
Sets the number points between Min and Max for evaluation
setPoints(int) - Method in class jhplot.FProxy
Numbers of points for evaluation.
setPopulationLimit(int) - Method in class org.apache.commons.math3.genetics.ListPopulation
Sets the maximal population size.
setPopupMenu(JPopupMenu) - Method in class org.jfree.chart.ChartPanel
Sets the popup menu for the panel.
setPosCoord(String) - Method in class jhplot.shapes.HShape
Set the style of the coodinate position
setPosition(int) - Method in class graph.Axis
Set the axis position.
setPosition(float[]) - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
setPosition(float[]) - Method in class hep.lcio.implementation.event.ICluster
 
setPosition(float[]) - Method in class hep.lcio.implementation.event.ISimCalorimeterHit
 
setPosition(double[]) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setPosition(double[]) - Method in class hep.lcio.implementation.event.ITrackerHit
 
setPosition(double[]) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setPosition(double[]) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setPosition(float[]) - Method in class hep.lcio.implementation.event.IVertex
 
setPosition(HepLorentzVector) - Method in class hephysics.particle.HEParticle
Set position of particle in X,Y,Z,time.
setPosition(RectangleEdge) - Method in class org.jfree.chart.title.Title
Sets the position for the title and sends a TitleChangeEvent to all registered listeners.
setPosition(int) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Sets the x position type (START, MIDDLE or END).
setPosition(int, int) - Method in class org.jlab.groot.ui.PaveText
 
setPositionCoordinate(int) - Method in class jhplot.shapes.HShape
How to set the position of this object?
setPositionError(float[]) - Method in class hep.lcio.implementation.event.ICluster
 
setPositiveArrowVisible(boolean) - Method in class org.jfree.chart.axis.ValueAxis
Sets a flag that controls whether or not the axis lines has an arrow drawn that points in the positive direction for the axis, and sends an AxisChangeEvent to all registered listeners.
setPositiveBarPaint(Paint) - Method in class org.jfree.chart.renderer.category.WaterfallBarRenderer
Sets the paint that will be used to draw bars having positive values.
setPositiveItemLabelPosition(ItemLabelPosition) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
setPositiveItemLabelPosition(ItemLabelPosition, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
setPositiveItemLabelPosition(ItemLabelPosition) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
setPositiveItemLabelPosition(ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
setPositiveItemLabelPosition(ItemLabelPosition) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesPositiveItemLabelPosition(int, ItemLabelPosition) and XYItemRenderer.setBasePositiveItemLabelPosition(ItemLabelPosition).
setPositiveItemLabelPosition(ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
setPositiveItemLabelPositionFallback(ItemLabelPosition) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the fallback position for positive item labels that don't fit within a bar, and sends a RendererChangeEvent to all registered listeners.
setPositiveItemLabelPositionFallback(ItemLabelPosition) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the fallback position for positive item labels that don't fit within a bar, and sends a RendererChangeEvent to all registered listeners.
setPositivePaint(Paint) - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Sets the paint used to highlight positive differences and sends a RendererChangeEvent to all registered listeners.
setPositivePrefix(String) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the string that is prepended to the format if the relative time is positive.
setPrecedenceTable(Operator[][]) - Static method in class org.lsmp.djep.xjep.XOperatorSet
Sets the precedences of the operators according to order in the supplied array.
setPrecision(double) - Method in class org.freehep.math.minuit.MnApplication
 
setPrecision(double) - Method in class org.freehep.math.minuit.MnMachinePrecision
override Minuit's own determination
setPrecision(double) - Method in class org.freehep.math.minuit.MnUserParameters
 
setPrecision(double) - Method in class org.freehep.math.minuit.MnUserParameterState
 
setPrecision(int) - Method in class org.jfree.chart.renderer.xy.XYSplineRenderer
Set the resolution of splines and sends a RendererChangeEvent to all registered listeners.
setPrimary(boolean) - Method in class hep.lcio.implementation.event.IVertex
 
setPrimaryState(double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Set primary part of the current state.
setPrimitivesToFront(boolean) - Method in class jhplot.HPlot
Setting the flag to true, this will draw all primitives after drawing all the lines and point stuff, hence on the foreground.
setPrimitivesToFront(boolean) - Method in class jplot.GraphSettings
Setting the flag to true, this will draw the primitives after drawing all the lines and point stuff, hence on the foreground.
setPrintShape(boolean) - Method in class cern.colt.matrix.impl.AbstractFormatter
Specifies whether a string representation of a matrix is to be preceded with a summary of its shape.
setProb(double) - Method in class jminhep.algorithms.FuzzyCMeansAlg
Set probability of associations with each cluster.
setProbab(double) - Method in class jminhep.cluster.Partition
Set probability for cluster accosiation
setProbability(float) - Method in class hep.lcio.implementation.event.IVertex
 
setProbabilityOfSuccess(double) - Method in class jhplot.math.num.pdf.Binomial
Modify probability of success.
setProbabilityOfSuccess(double) - Method in class jhplot.math.num.pdf.Geometric
Modify probability of success.
setProbabilityOfSuccess(double) - Method in class jhplot.math.num.pdf.NegativeBinomial
Modify probability of success.
setProcess_noise_cov(Matrix) - Method in class jhplot.math.kalman.JKalman
Setter
setProcessData(int, ProMCStatFile.ProMCStat.ProcessData) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
setProcessData(int, ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class proeic.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
setProcessData(int, ProMCStatFile.ProMCStat.ProcessData) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
setProcessData(int, ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class promc.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
setProcessData(int, ProMCStatFile.ProMCStat.ProcessData) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
setProcessData(int, ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class pronlo.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
setProcessData(int, ProMCStatFile.ProMCStat.ProcessData) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
setProcessData(int, ProMCStatFile.ProMCStat.ProcessData.Builder) - Method in class proreco.io.ProMCStatFile.ProMCStat.Builder
repeated .promc.ProMCStat.ProcessData processData = 10;
setProcessID(int) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
setProcessID(int) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
setProcessID(int) - Method in class pronlo.io.ProMC.ProMCEvent.Event.Builder
optional int32 Process_ID = 2;
setProcessID(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated int32 ProcessID = 2 [packed = true];
setProcessVisibleItemsOnly(boolean) - Method in class org.jfree.chart.renderer.xy.XYItemRendererState
Sets the flag that controls whether the plot passes all data items in each series to the renderer, or just the visible items.
setProducedBySecondary(boolean) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setProjectionArea(Rectangle) - Method in class jplot3d.Projector
Sets the projection area.
setProjector(Projector) - Method in class jplot3d.SurfaceVertex
Sets the projector to project this vertex.
setPropagateClose(boolean) - Method in class org.apache.commons.io.input.BoundedInputStream
Set whether the BoundedInputStream.close() method should propagate to the underling InputStream.
setProperty(Property) - Method in class cern.colt.matrix.linalg.Algebra
Attaches the given property object to this Algebra, defining tolerance.
setProperty(String, String) - Static method in class jhepsim.Options
Elementary property function.
setPT(int, long) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated uint64 PT = 1 [packed = true];
setPT(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Electrons.Builder
repeated uint64 PT = 1 [packed = true];
setPT(int, long) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated uint64 PT = 1 [packed = true];
setPT(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated uint64 PT = 1 [packed = true];
setPT(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Muons.Builder
repeated uint64 PT = 1 [packed = true];
setPT(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 PT = 19 [packed = true];
setPT(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Photons.Builder
repeated uint64 PT = 1 [packed = true];
setPT(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated uint64 PT = 1 [packed = true];
setPt2(double) - Method in class hephysics.jet.ParticleD
 
setPtEtaPhiE(double, double, double, double) - Method in class hephysics.particle.LParticle
Set 4-momentum of a particle using transverse momentum (pt), pseudorapidity (Eta) and azimuthal angle (phi) and energy.
setPtEtaPhiM(double, double, double, double) - Method in class hephysics.jet.ParticleD
Set 4-momentum of a particle using transverse momentum (pt), pseudorapidity (eta) and azimuthal angle (phi) and mass (m).
setPtEtaPhiM(double, double, double, double) - Method in class hephysics.particle.LParticle
Set 4-momentum of a particle using transverse momentum (pt), pseudorapidity (eta) and azimuthal angle (phi) and mass (m).
setPtSizePct(double) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the ptSizePct.
setPx(double) - Method in class hephysics.jet.ParticleD
 
setPx(double) - Method in class hephysics.vec.HepLorentzVector
Set Px
setPx(int, float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Px = 5 [packed = true];
setPx(int, long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
setPx(int, long) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 4 [packed = true];
setPx(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Px = 5 [packed = true];
setPxPyPz(double, double, double) - Method in class hephysics.particle.LParticle
Set Px,Py,Pz (or x,y,z)
setPxPyPzE(double, double, double, double) - Method in class hephysics.jet.ParticleD
Initialize from 4-momenta.
setPxPyPzE(float, float, float, float) - Method in class hephysics.jet.ParticleF
Initialize from 4-momenta.
setPxPyPzE(double, double, double, double) - Method in class hephysics.particle.LParticle
Set Px,Py,Pz and energy of a particle
setPxPyPzE(double, double, double, double) - Method in class j4np.physics.LorentzVector
 
setPxPyPzM(double, double, double, double) - Method in class j4np.physics.LorentzVector
 
setPXY(PBufFile.Record.PXY) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXY pXY = 4;
setPXY(PBufFile.Record.PXY.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXY pXY = 4;
setPXYZ(PBufFile.Record.PXYZ) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXYZ pXYZ = 5;
setPXYZ(PBufFile.Record.PXYZ.Builder) - Method in class promc.io.PBufFile.Record.Builder
optional .promc.Record.PXYZ pXYZ = 5;
setPy(double) - Method in class hephysics.jet.ParticleD
 
setPy(double) - Method in class hephysics.vec.HepLorentzVector
Set Py
setPy(int, float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Py = 6 [packed = true];
setPy(int, long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
setPy(int, long) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 5 [packed = true];
setPy(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Py = 6 [packed = true];
setPz(double) - Method in class hephysics.jet.ParticleD
 
setPz(double) - Method in class hephysics.vec.HepLorentzVector
Set Pz
setPz(int, float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Pz = 7 [packed = true];
setPz(int, long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
setPz(int, long) - Method in class pronlo.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 6 [packed = true];
setPz(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint64 Pz = 7 [packed = true];
setQ2(float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Q2 = 16;
setQuadrantOrigin(Point2D) - Method in class org.jfree.chart.plot.XYPlot
Sets the quadrant origin and sends a PlotChangeEvent to all registered listeners.
setQuadrantPaint(int, Paint) - Method in class org.jfree.chart.plot.XYPlot
Sets the paint used for the specified quadrant and sends a PlotChangeEvent to all registered listeners.
setQuality(int) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setQuality(int) - Method in class hep.lcio.implementation.event.ITPCHit
 
setQuality(int) - Method in class hep.lcio.implementation.event.ITrackerHit
 
setQuality(int) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setQuality(int) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setQuality(int) - Method in class hep.lcio.implementation.event.ITrackerPulse
 
setQuality(float) - Method in interface org.jfree.chart.encoders.ImageEncoder
Set the quality of the image encoding (not supported by all ImageEncoders).
setQuality(float) - Method in class org.jfree.chart.encoders.KeypointPNGEncoderAdapter
Set the quality of the image encoding (supported).
setQuality(float) - Method in class org.jfree.chart.encoders.SunJPEGEncoderAdapter
Set the quality of the image encoding.
setQuality(float) - Method in class org.jfree.chart.encoders.SunPNGEncoderAdapter
Set the quality of the image encoding (not supported in this ImageEncoder).
setQuantile(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Sets the value of the quantile field (determines what percentile is computed when evaluate() is called with no quantile argument).
setQuick(int, boolean) - Method in class cern.colt.list.BooleanArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, byte) - Method in class cern.colt.list.ByteArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, char) - Method in class cern.colt.list.CharArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, long) - Method in class cern.colt.list.DistinctNumberList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, double) - Method in class cern.colt.list.DoubleArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, float) - Method in class cern.colt.list.FloatArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, int) - Method in class cern.colt.list.IntArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, long) - Method in class cern.colt.list.LongArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, long) - Method in class cern.colt.list.MinMaxNumberList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, Object) - Method in class cern.colt.list.ObjectArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, short) - Method in class cern.colt.list.ShortArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, double) - Method in class cern.colt.matrix.DoubleMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, double) - Method in class cern.colt.matrix.DoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, double) - Method in class cern.colt.matrix.DoubleMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, double) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, double) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, double) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, Object) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, Object) - Method in class cern.colt.matrix.impl.DenseObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, double) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, Object) - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, Object) - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, Object) - Method in class cern.colt.matrix.ObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.ObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, Object) - Method in class cern.colt.matrix.ObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, double, double, double, double, double, double, double, double, double, double) - Method in class jhplot.P1D
setQuicks the ith value of a plot-point pair (x,y).
setQuick(int, double, double, double, double, double, double) - Method in class jhplot.P1D
setQuicks the ith value of a plot-point pair (x,y).
setQuick(int, double, double, double, double) - Method in class jhplot.P1D
setQuicks the ith value of a plot-point pair (x,y).
setQuick(int, double, double, double) - Method in class jhplot.P1D
setQuicks the ith value of a plot-point pair (x,y).
setQuick(int, double, double) - Method in class jhplot.P1D
setQuicks the ith value of a plot-point pair (x,y).
setRadius(double) - Method in class org.jfree.chart.plot.dial.DialCap
Sets the radius of the cap, as a percentage of the dial's framing rectangle, and sends a DialLayerChangeEvent to all registered listeners.
setRadius(double) - Method in class org.jfree.chart.plot.dial.DialPointer
Sets the radius of the pointer and sends a DialLayerChangeEvent to all registered listeners.
setRadius(double) - Method in class org.jfree.chart.plot.dial.DialTextAnnotation
Sets the radius used to calculate the anchor point and sends a DialLayerChangeEvent to all registered listeners.
setRadius(double) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the radius and sends a DialLayerChangeEvent to all registered listeners.
setRadius(double) - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Sets the radius and sends a DialLayerChangeEvent to all registered listeners.
setRadius(double) - Method in class org.jfree.chart.renderer.Outlier
Sets the radius of the outlier ellipse.
setRadiusGridlinePaint(Paint) - Method in class org.jfree.chart.plot.PolarPlot
Sets the paint for the grid lines plotted against the radius axis and sends a PlotChangeEvent to all registered listeners.
setRadiusGridlineStroke(Stroke) - Method in class org.jfree.chart.plot.PolarPlot
Sets the stroke for the grid lines plotted against the radius axis and sends a PlotChangeEvent to all registered listeners.
setRadiusGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.PolarPlot
Sets the flag that controls whether or not the radius axis grid lines are visible.
setRadiusMinorGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.PolarPlot
Set the flag that determines if radial minor grid-lines will be drawn, and sends a PlotChangeEvent to all registered listeners.
setRadiusOfInnermostHit(float) - Method in class hep.lcio.implementation.event.ITrack
 
setRandom() - Method in class org.jlab.groot.math.UserParameter
 
setRandomGenerator(RandomGenerator) - Static method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Set the (static) random generator.
setRandomParticleAntiParticle(boolean) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Randomly change between generating particles and anti-particles, if true.
setRange(double, double) - Method in class fitter.Fitter
set range manually
setRange(double, double, double, double) - Method in class graph.Contour
Set the range of the grid
setRange(int, double, double) - Method in class jhplot.HChart
Sets the range (min-max) displayed on the axis.
setRange(double, double) - Method in class jhplot.HFitter
Set range for fitting for 1D objects (H1D, P1D)
setRange(int, double, double) - Method in class jhplot.HPlot
Sets the range (min-max) displayed on the axis.
setRange(double, double, double, double) - Method in class jhplot.HPlot
Sets the range for the current plot
setRange(double, double, double, double) - Method in class jhplot.HPlot3D
Set X and Y range for the 3D plot.
setRange(double, double, double, double, double, double) - Method in class jhplot.HPlot3D
Set X, Y, Z ranges for the 3D plot
setRange(int, double, double) - Method in class jplot.GraphSettings
Sets the range (min-max) displayed on the axis.
setRange(Range, boolean, boolean) - Method in class org.jfree.chart.axis.CyclicNumberAxis
Sets a new axis range.
setRange(Range) - Method in class org.jfree.chart.axis.DateAxis
Sets the upper and lower bounds for the axis and sends an AxisChangeEvent to all registered listeners.
setRange(Range, boolean, boolean) - Method in class org.jfree.chart.axis.DateAxis
Sets the range for the axis, if requested, sends an AxisChangeEvent to all registered listeners.
setRange(Date, Date) - Method in class org.jfree.chart.axis.DateAxis
Sets the axis range and sends an AxisChangeEvent to all registered listeners.
setRange(double, double) - Method in class org.jfree.chart.axis.DateAxis
Sets the axis range and sends an AxisChangeEvent to all registered listeners.
setRange(Range) - Method in class org.jfree.chart.axis.LogarithmicAxis
Overridden version that calls original and then sets up flag for log axis processing.
setRange(Range, boolean, boolean) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the range for the axis, if requested, sends an AxisChangeEvent to all registered listeners.
setRange(Range) - Method in class org.jfree.chart.axis.ValueAxis
Sets the range for the axis and sends a change event to all registered listeners.
setRange(Range, boolean, boolean) - Method in class org.jfree.chart.axis.ValueAxis
Sets the range for the axis and, if requested, sends a change event to all registered listeners.
setRange(double, double) - Method in class org.jfree.chart.axis.ValueAxis
Sets the range for the axis and sends a change event to all registered listeners.
setRange(double, double) - Method in class org.jfree.chart.plot.JThermometer
Sets the lower and upper bounds for the thermometer.
setRange(Range) - Method in class org.jfree.chart.plot.MeterPlot
Sets the range for the dial and sends a PlotChangeEvent to all registered listeners.
setRange(double, double) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the lower and upper bounds for the thermometer.
setRange(double, double) - Method in class org.jlab.groot.graphics.GraphicsAxis
Sets the range of the axis, it also updates the axis labels.
setRange(double, double) - Method in class org.jlab.groot.math.Func1D
 
setRange(double, double) - Method in class org.jlab.groot.ui.GraphicsAxis
Sets the range of the axis, it also updates the axis labels.
setRangeAboutValue(double, double) - Method in class org.jfree.chart.axis.ValueAxis
Sets the axis range, where the new range is 'size' in length, and centered on 'value'.
setRangeAll(int, double, double) - Method in class jhplot.HPlot
Sets the range (min-max) displayed on all axises.
setRangeAll(double, double, double, double) - Method in class jhplot.HPlot
Sets the range for all plots
setRangeAxes(ValueAxis[]) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the range axes for this plot and sends a PlotChangeEvent to all registered listeners.
setRangeAxes(ValueAxis[]) - Method in class org.jfree.chart.plot.XYPlot
Sets the range axes for this plot and sends a PlotChangeEvent to all registered listeners.
setRangeAxis(ValueAxis) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the range axis for the plot and sends a PlotChangeEvent to all registered listeners.
setRangeAxis(int, ValueAxis) - Method in class org.jfree.chart.plot.CategoryPlot
Sets a range axis and sends a PlotChangeEvent to all registered listeners.
setRangeAxis(int, ValueAxis, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets a range axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setRangeAxis(ValueAxis) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the range axis for the plot.
setRangeAxis(ValueAxis) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the range axis and sends a PlotChangeEvent to all registered listeners.
setRangeAxis(ValueAxis) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the range axis for the plot and sends a PlotChangeEvent to all registered listeners.
setRangeAxis(ValueAxis) - Method in class org.jfree.chart.plot.XYPlot
Sets the range axis for the plot and sends a PlotChangeEvent to all registered listeners.
setRangeAxis(int, ValueAxis) - Method in class org.jfree.chart.plot.XYPlot
Sets a range axis and sends a PlotChangeEvent to all registered listeners.
setRangeAxis(int, ValueAxis, boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets a range axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setRangeAxisLocation(AxisLocation) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the location of the range axis and sends a PlotChangeEvent to all registered listeners.
setRangeAxisLocation(AxisLocation, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the location of the range axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setRangeAxisLocation(int, AxisLocation) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the location for a range axis and sends a PlotChangeEvent to all registered listeners.
setRangeAxisLocation(int, AxisLocation, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the location for a range axis and sends a PlotChangeEvent to all registered listeners.
setRangeAxisLocation(AxisLocation) - Method in class org.jfree.chart.plot.XYPlot
Sets the location of the primary range axis and sends a PlotChangeEvent to all registered listeners.
setRangeAxisLocation(AxisLocation, boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the location of the primary range axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setRangeAxisLocation(int, AxisLocation) - Method in class org.jfree.chart.plot.XYPlot
Sets the location for a range axis and sends a PlotChangeEvent to all registered listeners.
setRangeAxisLocation(int, AxisLocation, boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the axis location for a domain axis and, if requested, sends a PlotChangeEvent to all registered listeners.
setRangeBase(double) - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Sets the value on the range axis which defines the default border of the area, and sends a RendererChangeEvent to all registered listeners.
setRangeCrosshairLockedOnData(boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the flag indicating whether or not the range crosshair should "lock-on" to actual data values, and sends a PlotChangeEvent to all registered listeners.
setRangeCrosshairLockedOnData(boolean) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the flag indicating whether or not the range crosshair should "lock-on" to actual data values.
setRangeCrosshairLockedOnData(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag indicating whether or not the range crosshair should "lock-on" to actual data values.
setRangeCrosshairPaint(Paint) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the paint used to draw the range crosshair (if visible) and sends a PlotChangeEvent to all registered listeners.
setRangeCrosshairPaint(Paint) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the Paint used to color the crosshairs (if visible) and notifies registered listeners that the axis has been modified.
setRangeCrosshairPaint(Paint) - Method in class org.jfree.chart.plot.XYPlot
Sets the paint used to color the crosshairs (if visible) and sends a PlotChangeEvent to all registered listeners.
setRangeCrosshairStroke(Stroke) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the pen-style (Stroke) used to draw the range crosshair (if visible), and sends a PlotChangeEvent to all registered listeners.
setRangeCrosshairStroke(Stroke) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the Stroke used to draw the crosshairs (if visible) and notifies registered listeners that the axis has been modified.
setRangeCrosshairStroke(Stroke) - Method in class org.jfree.chart.plot.XYPlot
Sets the stroke used to draw the crosshairs (if visible) and sends a PlotChangeEvent to all registered listeners.
setRangeCrosshairValue(double) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the range crosshair value and, if the crosshair is visible, sends a PlotChangeEvent to all registered listeners.
setRangeCrosshairValue(double, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the range crosshair value and, if requested, sends a PlotChangeEvent to all registered listeners (but only if the crosshair is visible).
setRangeCrosshairValue(double) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the domain crosshair value.
setRangeCrosshairValue(double, boolean) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the range crosshair value.
setRangeCrosshairValue(double) - Method in class org.jfree.chart.plot.XYPlot
Sets the range crosshair value.
setRangeCrosshairValue(double, boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the range crosshair value and sends a PlotChangeEvent to all registered listeners, but only if the crosshair is visible.
setRangeCrosshairVisible(boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the flag indicating whether or not the range crosshair is visible.
setRangeCrosshairVisible(boolean) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the flag indicating whether or not the range crosshair is visible.
setRangeCrosshairVisible(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag indicating whether or not the range crosshair is visible.
setRangeDescription(String) - Method in class org.jfree.data.time.TimePeriodValues
Sets the range description and fires a property change event with the name Range.
setRangeDescription(String) - Method in class org.jfree.data.time.TimeSeries
Sets the range description and sends a PropertyChangeEvent (with the property name Range) to all registered listeners.
setRangeGridlinePaint(Paint) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the paint used to draw the grid lines against the range axis and sends a PlotChangeEvent to all registered listeners.
setRangeGridlinePaint(Paint) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the paint for the grid lines plotted against the range axis and sends a PlotChangeEvent to all registered listeners.
setRangeGridlinePaint(Paint) - Method in class org.jfree.chart.plot.XYPlot
Sets the paint for the grid lines plotted against the range axis and sends a PlotChangeEvent to all registered listeners.
setRangeGridlinePaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the range grid line paint.
setRangeGridlineStroke(Stroke) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the stroke used to draw the grid-lines against the range axis and sends a PlotChangeEvent to all registered listeners.
setRangeGridlineStroke(Stroke) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the stroke for the grid lines plotted against the range axis and sends a PlotChangeEvent to all registered listeners.
setRangeGridlineStroke(Stroke) - Method in class org.jfree.chart.plot.XYPlot
Sets the stroke for the grid lines plotted against the range axis, and sends a PlotChangeEvent to all registered listeners.
setRangeGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the flag that controls whether or not grid-lines are drawn against the range axis.
setRangeGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the flag that controls whether or not the range axis grid lines are visible.
setRangeGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag that controls whether or not the range axis grid lines are visible.
setRangeMinorGridlinePaint(Paint) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the paint for the minor grid lines plotted against the range axis and sends a PlotChangeEvent to all registered listeners.
setRangeMinorGridlinePaint(Paint) - Method in class org.jfree.chart.plot.XYPlot
Sets the paint for the minor grid lines plotted against the range axis and sends a PlotChangeEvent to all registered listeners.
setRangeMinorGridlineStroke(Stroke) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the stroke for the minor grid lines plotted against the range axis, and sends a PlotChangeEvent to all registered listeners.
setRangeMinorGridlineStroke(Stroke) - Method in class org.jfree.chart.plot.XYPlot
Sets the stroke for the minor grid lines plotted against the range axis, and sends a PlotChangeEvent to all registered listeners.
setRangeMinorGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the flag that controls whether or not the range axis minor grid lines are visible.
setRangeMinorGridlinesVisible(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag that controls whether or not the range axis minor grid lines are visible.
setRangePannable(boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the flag that enables or disables panning of the plot along the range axes.
setRangePannable(boolean) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Sets the flag, on each of the subplots, that controls whether or not the range is pannable.
setRangePannable(boolean) - Method in class org.jfree.chart.plot.FastScatterPlot
Sets the flag that enables or disables panning of the plot along the range axes.
setRangePannable(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag that enables or disables panning of the plot along the range axis/axes.
setRanges(float, float, float, float) - Method in class jplot3d.JSurface
Sets the x and y ranges of calculated surface vertices.
setRangeTickBandPaint(Paint) - Method in class org.jfree.chart.plot.XYPlot
Sets the paint for the range tick bands.
setRangeType(RangeType) - Method in class org.jfree.chart.axis.NumberAxis
Sets the axis range type.
setRangeWithMargins(Range) - Method in class org.jfree.chart.axis.ValueAxis
Sets the range for the axis (after first adding the current margins to the specified range) and sends an AxisChangeEvent to all registered listeners.
setRangeWithMargins(Range, boolean, boolean) - Method in class org.jfree.chart.axis.ValueAxis
Sets the range for the axis after first adding the current margins to the range and, if requested, sends an AxisChangeEvent to all registered listeners.
setRangeWithMargins(double, double) - Method in class org.jfree.chart.axis.ValueAxis
Sets the axis range (after first adding the current margins to the range) and sends an AxisChangeEvent to all registered listeners.
setRangeX(double, double) - Method in class jhplot.HPlot
Sets the range (min-max) displayed on X
setRangeX(double, double) - Method in class jhplot.HPlot3DP
Set range for X axis
setRangeX(double, double) - Method in class jplot3dp.ModelView
 
setRangeY(double, double) - Method in class jhplot.HPlot
Sets the range (min-max) displayed on Y
setRangeY(double, double) - Method in class jhplot.HPlot3DP
Set range for Y
setRangeY(double, double) - Method in class jplot3dp.ModelView
 
setRangeZ(double, double) - Method in class jhplot.HPlot3D
Sets the z range of calculated surface vertices.
setRangeZ(double, double) - Method in class jhplot.HPlot3DP
Set range for Z
setRangeZ(double, double) - Method in class jplot3dp.ModelView
 
setRangeZeroBaselinePaint(Paint) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the paint for the zero baseline plotted against the range axis and sends a PlotChangeEvent to all registered listeners.
setRangeZeroBaselinePaint(Paint) - Method in class org.jfree.chart.plot.XYPlot
Sets the paint for the zero baseline plotted against the range axis and sends a PlotChangeEvent to all registered listeners.
setRangeZeroBaselineStroke(Stroke) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the stroke for the zero baseline for the range axis, and sends a PlotChangeEvent to all registered listeners.
setRangeZeroBaselineStroke(Stroke) - Method in class org.jfree.chart.plot.XYPlot
Sets the stroke for the zero baseline for the range axis, and sends a PlotChangeEvent to all registered listeners.
setRangeZeroBaselineVisible(boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the flag that controls whether or not the zero baseline is displayed for the range axis, and sends a PlotChangeEvent to all registered listeners.
setRangeZeroBaselineVisible(boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the flag that controls whether or not the zero baseline is displayed for the range axis, and sends a PlotChangeEvent to all registered listeners.
setRangeZoomable(boolean) - Method in class org.jfree.chart.ChartPanel
A flag that controls mouse-based zooming on the vertical axis.
setRapidity(double) - Method in class hephysics.jet.ParticleD
 
setRawDataWords(int[]) - Method in class hep.lcio.implementation.event.ITPCHit
 
setRawHit(LCObject) - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
setRawHits(List) - Method in class hep.lcio.implementation.event.ITrackerHit
 
setRawHits(List) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setRawHits(List) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setRe(double) - Method in class org.nfunk.jep.type.Complex
Sets the real component of the object
setReadOnly(Path, boolean, LinkOption...) - Static method in class org.apache.commons.io.file.PathUtils
Sets the given Path to the readOnly value.
setReferencePoint(float[]) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setReferencePoint(float[]) - Method in class hep.lcio.implementation.event.ITrack
 
setReferencePoint(float[]) - Method in class hep.lcio.implementation.event.ITrackState
 
setRefreshBuffer(boolean) - Method in class org.jfree.chart.ChartPanel
Sets the refresh buffer flag.
setRegularFont(Font) - Method in class org.jfree.chart.StandardChartTheme
Sets the regular font for this theme.
setRelation(String) - Method in class jminhep.cluster.DataHolder
Set relation (name) of the data holder
setRenderAsPercentages(boolean) - Method in class org.jfree.chart.renderer.category.StackedAreaRenderer
Sets the flag that controls whether the renderer displays each item value as a percentage (so that the stacked areas add to 100%), and sends a RendererChangeEvent to all registered listeners.
setRenderAsPercentages(boolean) - Method in class org.jfree.chart.renderer.category.StackedBarRenderer
Sets the flag that controls whether the renderer displays each item value as a percentage (so that the stacked bars add to 100%), and sends a RendererChangeEvent to all registered listeners.
setRenderAsPercentages(boolean) - Method in class org.jfree.chart.renderer.category.StackedBarRenderer3D
Sets the flag that controls whether the renderer displays each item value as a percentage (so that the stacked bars add to 100%), and sends a RendererChangeEvent to all registered listeners.
setRenderAsPercentages(boolean) - Method in class org.jfree.chart.renderer.xy.StackedXYBarRenderer
Sets the flag that controls whether the renderer displays each item value as a percentage (so that the stacked bars add to 100%), and sends a RendererChangeEvent to all registered listeners.
setRenderAsPoints(boolean) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the renderAsPoints.
setRenderer(CategoryItemRenderer) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the renderer at index 0 (sometimes referred to as the "primary" renderer) and sends a change event to all registered listeners.
setRenderer(CategoryItemRenderer, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the renderer at index 0 (sometimes referred to as the "primary" renderer) and, if requested, sends a change event to all registered listeners.
setRenderer(int, CategoryItemRenderer) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the renderer to use for the dataset with the specified index and sends a change event to all registered listeners.
setRenderer(int, CategoryItemRenderer, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the renderer to use for the dataset with the specified index and, if requested, sends a change event to all registered listeners.
setRenderer(XYItemRenderer) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Sets the item renderer FOR ALL SUBPLOTS.
setRenderer(XYItemRenderer) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Sets the item renderer FOR ALL SUBPLOTS.
setRenderer(PolarItemRenderer) - Method in class org.jfree.chart.plot.PolarPlot
Sets the primary renderer, and notifies all listeners of a change to the plot.
setRenderer(int, PolarItemRenderer) - Method in class org.jfree.chart.plot.PolarPlot
Sets a renderer and sends a PlotChangeEvent to all registered listeners.
setRenderer(int, PolarItemRenderer, boolean) - Method in class org.jfree.chart.plot.PolarPlot
Sets a renderer and, if requested, sends a PlotChangeEvent to all registered listeners.
setRenderer(WaferMapRenderer) - Method in class org.jfree.chart.plot.WaferMapPlot
Sets the item renderer, and notifies all listeners of a change to the plot.
setRenderer(XYItemRenderer) - Method in class org.jfree.chart.plot.XYPlot
Sets the renderer for the primary dataset and sends a change event to all registered listeners.
setRenderer(int, XYItemRenderer) - Method in class org.jfree.chart.plot.XYPlot
Sets the renderer for the dataset with the specified index and sends a change event to all registered listeners.
setRenderer(int, XYItemRenderer, boolean) - Method in class org.jfree.chart.plot.XYPlot
Sets the renderer for the dataset with the specified index and, if requested, sends a change event to all registered listeners.
setRendererIndex(int) - Method in class org.jfree.chart.entity.XYAnnotationEntity
Sets the renderer index.
setRenderers(CategoryItemRenderer[]) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the renderers for this plot and sends a PlotChangeEvent to all registered listeners.
setRenderers(XYItemRenderer[]) - Method in class org.jfree.chart.plot.XYPlot
Sets the renderers for this plot and sends a PlotChangeEvent to all registered listeners.
setRenderingHint(RenderingHints.Key, Object) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the value for a hint.
setRenderingHints(Map<?, ?>) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the rendering hints to the specified collection.
setRenderingHints(RenderingHints) - Method in class org.jfree.chart.JFreeChart
Sets the rendering hints for the chart.
setRequestedEvents(double) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
setRequestedEvents(double) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
setRequestedEvents(double) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
setRequestedEvents(double) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double requested_events = 21;
setRequired(boolean) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
setReshowDelay(int) - Method in class org.jfree.chart.ChartPanel
Specifies the amount of time before the user has to wait initialDelay milliseconds before a tooltip will be shown.
setResult(H1F, F1D, int) - Method in interface org.jlab.groot.fitter.ParallelSliceFitter.ResultSetter
 
setRevolutionDistance(double) - Method in class org.jfree.chart.plot.CompassPlot
Sets the count to complete one revolution.
setRight(double) - Method in class org.jfree.chart.axis.AxisSpace
Sets the space reserved for axes at the right of the plot area.
setRightArrow(Shape) - Method in class org.jfree.chart.axis.ValueAxis
Sets the shape that can be displayed as an arrow pointing rightwards at the end of an axis line and sends an AxisChangeEvent to all registered listeners.
setRightMargin(double) - Method in class jplot.GraphSettings
Sets the distance between the right-border of the panel and the right Y-axis.
setRightMargin(int) - Method in class org.jlab.groot.base.PadMargins
 
setRms(double) - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double rms = 15;
setRmses(int, double) - Method in class promc.io.PBufFile.Record.H1D.Builder
repeated double rmses = 5 [packed = true];
setRmsesX(int, double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesX = 5 [packed = true];
setRmsesY(int, double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double rmsesY = 8 [packed = true];
setRmsX(double) - Method in class jhplot.H2D
Set RMS on X.
setRmsX(double) - Method in class jhplot.HProf2D
Set RMS on X.
setRmsY(double) - Method in class jhplot.H2D
Set RMS on Y
setRmsY(double) - Method in class jhplot.HProf2D
Set RMS on Y
setRootVal(Complex) - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
Sets the value used to approximate the root as a complex number.
setRootVal(String, Complex) - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
Sets the root value for given symbol.
setRoseCenterPaint(Paint) - Method in class org.jfree.chart.plot.CompassPlot
Sets the paint used to fill the inner background area of the compass, and sends a PlotChangeEvent to all registered listeners.
setRoseHighlightPaint(Paint) - Method in class org.jfree.chart.plot.CompassPlot
Sets the paint used to draw the circles, symbols and labels of the compass, and sends a PlotChangeEvent to all registered listeners.
setRosePaint(Paint) - Method in class org.jfree.chart.plot.CompassPlot
Sets the paint used to fill the outer circle of the compass, and sends a PlotChangeEvent to all registered listeners.
setRotateTics(int, boolean) - Method in class jplot.GraphSettings
Defines whether we should rotate tics.
setRotateX(double) - Method in class org.jfree.chart.needle.MeterNeedle
Sets the rotateX value.
setRotateY(double) - Method in class org.jfree.chart.needle.MeterNeedle
Sets the rotateY value.
setRotation(int) - Method in class graph.RTextLine
Set the text rotation angle.
setRotation(int, Component) - Method in class graph.RTextLine
Set the Rotation and the Component that will be drawn into
setRotation(int) - Method in class jhplot.gui.GHMargin
Set the rotation angle of the text in degrees.
setRotation(double) - Method in class jhplot.HKey
Sets the rotation angle.
setRotation(double) - Method in class jhplot.HLabel
Sets the rotation angle.
setRotation(double) - Method in class jhplot.HMLabel
Sets the rotation angle.
setRotation(double) - Method in class jhplot.shapes.HShape
Rotate the shape or text.
setRotation(double) - Method in class jplot.GraphLabel
Sets the rotation angle.
setRotationAnchor(TextAnchor) - Method in class org.jfree.chart.annotations.TextAnnotation
Sets the rotation anchor point and sends an AnnotationChangeEvent to all registered listeners.
setRotationAnchor(TextAnchor) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the rotation anchor point and sends an AnnotationChangeEvent to all registered listeners.
setRotationAngle(double) - Method in class jhplot.HPlot3D
Get the rotation angle
setRotationAngle(float) - Method in class jplot3d.Projector
Sets the rotation angle.
setRotationAngle(float) - Method in class jplot3d.SurfaceModelCanvas
 
setRotationAngle(double) - Method in class org.jfree.chart.annotations.TextAnnotation
Sets the rotation angle and sends an AnnotationChangeEvent to all registered listeners.
setRotationAngle(double) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the rotation angle and sends an AnnotationChangeEvent to all registered listeners.
setRoundingMode(DfpField.RoundingMode) - Method in class org.apache.commons.math3.dfp.DfpField
Set the rounding mode.
setRoundingMode(RoundingMode) - Method in class org.apache.commons.math3.util.BigReal
Sets the rounding mode for decimal divisions.
setRoundXCoordinates(boolean) - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer2
Sets the flag that controls whether or not the x-coordinates (in Java2D space) are rounded to integer values, and sends a RendererChangeEvent to all registered listeners.
setRoundXCoordinates(boolean) - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Sets the flag that controls whether or not the x-coordinates (in Java2D space) are rounded to integer values, and sends a RendererChangeEvent to all registered listeners.
setRow(int, double, double, double) - Method in class j4np.physics.TransMatrix
 
setRow(int, T[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in row number row as a row matrix.
setRow(int, double[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified row of this matrix to the entries of the specified array.
setRow(int, T[]) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in row number row as a row matrix.
setRow(int, double[]) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified row of this matrix to the entries of the specified array.
setRow(int, T[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in row number row as a row matrix.
setRow(int, double[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified row of this matrix to the entries of the specified array.
setRowKey(Comparable) - Method in class org.jfree.chart.entity.CategoryItemEntity
Sets the row key.
setRowKey(Comparable) - Method in class org.jfree.chart.plot.CategoryCrosshairState
Sets the row key.
setRowMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in row number row as a row matrix.
setRowMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified row of this matrix to the entries of the specified row matrix.
setRowMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in row number row as a row matrix.
setRowMatrix(int, BlockFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified row of this matrix to the entries of the specified row matrix.
setRowMatrix(int, BlockRealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in row number row as a row matrix.
setRowMatrix(int, RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified row of this matrix to the entries of the specified row matrix.
setRowRenderingOrder(SortOrder) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the row order in which the items in each dataset should be rendered and sends a PlotChangeEvent to all registered listeners.
setRowSeparator(String) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the string separating any two rows from another.
setRowVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in row number row as a vector.
setRowVector(int, RealVector) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified row of this matrix to the entries of the specified vector.
setRowVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in row number row as a vector.
setRowVector(int, RealVector) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified row of this matrix to the entries of the specified vector.
setRowVector(int, FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in row number row as a vector.
setRowVector(int, RealVector) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified row of this matrix to the entries of the specified vector.
setRunNumber(int) - Method in class hep.lcio.implementation.event.ILCEvent
 
setRunNumber(int) - Method in class hep.lcio.implementation.event.ILCRunHeader
 
setRunNumber(int) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Sets the run number.
setS(double) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
setS(double) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
setS(double) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
setS(double) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double s = 11;
setSafety(double) - Method in class org.apache.commons.math3.ode.MultistepFieldIntegrator
Set the safety factor for stepsize control.
setSafety(double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Set the safety factor for stepsize control.
setSafety(T) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Set the safety factor for stepsize control.
setSafety(double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Set the safety factor for stepsize control.
setSampleSize(int) - Method in class jhplot.math.num.pdf.Hypergeometric
Modify the sample size.
setScale(double) - Method in class graph.VectorSet
Set the scaling to use when drawing vectors
setScale(double) - Method in class jhplot.math.num.pdf.Cauchy
Modify the scale parameter.
setScale(double) - Method in class jhplot.math.num.pdf.Laplace
Modify the scale.
setScale(double) - Method in class jhplot.math.num.pdf.Logistic
Modify the scale parameter.
setScale(double) - Method in class jhplot.math.num.pdf.Rayleigh
Modify the scale parameter.
setScale(double) - Method in class jhplot.math.num.pdf.Weibull
Modify the scale parameter.
setScale(int) - Method in class org.apache.commons.math3.util.BigReal
Sets the scale for division operations.
setScale(PaintScale) - Method in class org.jfree.chart.title.PaintScaleLegend
Sets the scale and sends a TitleChangeEvent to all registered listeners.
setScale(float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Scale = 12;
setScale(float) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Scale = 12;
setScale(int, float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float Scale = 12;
setScaleBox(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setScaleFactor(double) - Method in class org.jfree.data.xy.NormalizedMatrixSeries
Sets the factor that multiplies each item in this series when observed using getItem mehtod.
setScaleIndex(int) - Method in class org.jfree.chart.plot.dial.StandardDialRange
Sets the scale index and sends a DialLayerChangeEvent to all registered listeners.
setScalePDF(float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float Scale_PDF = 10;
setScalepdf(double) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
setScalePDF(float) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float Scale_PDF = 10;
setScalepdf(double) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
setScalepdf(double) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
setScalePDF(int, float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float ScalePDF = 10;
setScalepdf(double) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double scalepdf = 7;
setScaling(double) - Method in class jhplot.HPlot3D
Set the scaling
setScaling(float, float, float) - Method in class jplot3d.Projector
Sets the scaling factor in all direction.
setScaling(float) - Method in class jplot3d.Projector
Sets the same scaling factor for all direction.
setScalingType(int) - Method in class graph.VectorSet
Set the scaling type to use when drawing vectors
setSecondaryState(int, double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Set secondary part of the current state.
setSecondFormatter(NumberFormat) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the formatter for the seconds and milliseconds.
setSecondFunctionOnly(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setSecondSuffix(String) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the string that is appended to the second count.
setSectionDepth(double) - Method in class org.jfree.chart.plot.RingPlot
The section depth is given as percentage of the plot radius.
setSectionIndex(int) - Method in class org.jfree.chart.entity.PieSectionEntity
Sets the section index.
setSectionKey(Comparable) - Method in class org.jfree.chart.entity.PieSectionEntity
Sets the section key.
setSectionOutlinePaint(Comparable, Paint) - Method in class org.jfree.chart.plot.PiePlot
Sets the outline paint associated with the specified key, and sends a PlotChangeEvent to all registered listeners.
setSectionOutlinePaint(Paint) - Method in class org.jfree.chart.plot.PiePlot
setSectionOutlinePaint(int, Paint) - Method in class org.jfree.chart.plot.PiePlot
setSectionOutlineStroke(Comparable, Stroke) - Method in class org.jfree.chart.plot.PiePlot
Sets the outline stroke associated with the specified key, and sends a PlotChangeEvent to all registered listeners.
setSectionOutlineStroke(Stroke) - Method in class org.jfree.chart.plot.PiePlot
setSectionOutlineStroke(int, Stroke) - Method in class org.jfree.chart.plot.PiePlot
setSectionOutlinesVisible(boolean) - Method in class org.jfree.chart.plot.PiePlot
Sets the flag that controls whether or not the outline is drawn for each pie section, and sends a PlotChangeEvent to all registered listeners.
setSectionPaint(Paint) - Method in class org.jfree.chart.plot.PiePlot
Deprecated.
setSectionPaint(Comparable, Paint) - Method in class org.jfree.chart.plot.PiePlot
Sets the paint associated with the specified key, and sends a PlotChangeEvent to all registered listeners.
setSectionPaint(int, Paint) - Method in class org.jfree.chart.plot.PiePlot
setSecureAlgorithm(String, String) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Sets the PRNG algorithm for the underlying SecureRandom instance using the Security Provider API.
setSecureAlgorithm(String, String) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated.
Sets the PRNG algorithm for the underlying SecureRandom instance using the Security Provider API.
setSeed(long) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Set the seed for the random number generator.
setSeed(long) - Static method in class Jampack.Rand
Sets the seed for the random number generator.
setSeed(double[][]) - Method in class jminhep.algorithms.KMeansAlg
Set seeds by hand
setSeed(int) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Sets the seed of the underlying random number generator using a long seed.
setSeed(int) - Method in class org.apache.commons.math3.random.AbstractWell
Reinitialize the generator as if just built with the given int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.AbstractWell
Reinitialize the generator as if just built with the given int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.AbstractWell
Reinitialize the generator as if just built with the given long seed.
setSeed(int) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Sets the seed of the underlying random number generator using a long seed.
setSeed(int) - Method in class org.apache.commons.math3.random.ISAACRandom
Sets the seed of the underlying random number generator using an int seed.
setSeed(long) - Method in class org.apache.commons.math3.random.ISAACRandom
Sets the seed of the underlying random number generator using a long seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.ISAACRandom
Sets the seed of the underlying random number generator using an int array seed.
setSeed(int) - Method in class org.apache.commons.math3.random.JDKRandomGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.JDKRandomGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(int) - Method in class org.apache.commons.math3.random.MersenneTwister
Reinitialize the generator as if just built with the given int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.MersenneTwister
Reinitialize the generator as if just built with the given int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.MersenneTwister
Reinitialize the generator as if just built with the given long seed.
setSeed(int) - Method in class org.apache.commons.math3.random.RandomAdaptor
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.RandomAdaptor
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.RandomAdaptor
Sets the seed of the underlying random number generator using a long seed.
setSeed(int) - Method in interface org.apache.commons.math3.random.RandomGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in interface org.apache.commons.math3.random.RandomGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in interface org.apache.commons.math3.random.RandomGenerator
Sets the seed of the underlying random number generator using a long seed.
setSeed(int) - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Sets the seed of the underlying random number generator using a long seed.
setSelected(Object) - Method in class jplot.SmallScrollPane
Sets the selected item and lets the view port scroll to the item corresponding to this index.
setSelected(boolean) - Method in class jplot.Utils.CheckBoxWithText
 
setSelected(boolean) - Method in class jplot.Utils.LabeledTextField
 
setSelectedColor(Color) - Method in class jplot.panels.PanelColor
Sets the selected color.
setSelectedFontname(String) - Method in class jplot.panels.PanelFonts
Sets the font from a font name.
setSelectedFontsize(int) - Method in class jplot.panels.PanelFonts
Sets the font size.
setSelectedIndex(int) - Method in class jplot.SmallScrollPane
Sets the selected index and lets the viewport scroll to the item corresponding to this index.
setSelectedItem(String) - Method in class jhepsim.FontChooser.NwList
 
setSelectedItem(String) - Method in class jminhep.gui.FontChooser.NwList
 
setSelectedItem(Object) - Method in class jplot.Utils.LabeledComboBox
 
setSensitivity(double) - Method in class jhplot.stat.limit.StatConfidence
Set new sensitivity
setSensitivityError(double) - Method in class jhplot.stat.limit.StatConfidence
Set error on sensitivity
setSeparation(float) - Method in class jhplot.HKey
Set Y-separation of the keys in the default location mode
setSeparator(String) - Method in class jplot.XMLWrite
This method resets the separator between settings to a specific string.
setSeparatorPaint(Paint) - Method in class org.jfree.chart.plot.RingPlot
Sets the paint used to draw the separator between sections and sends a change event to all registered listeners.
setSeparatorStroke(Stroke) - Method in class org.jfree.chart.plot.RingPlot
Sets the stroke used to draw the separator between sections and sends a change event to all registered listeners.
setSeparatorsVisible(boolean) - Method in class org.jfree.chart.plot.RingPlot
Sets the flag that controls whether or not separators are drawn between the sections in the chart, and sends a change event to all registered listeners.
setSeries(int) - Method in class org.jfree.chart.entity.CategoryItemEntity
Deprecated.
As of 1.0.6, you should use CategoryItemEntity.setRowKey(Comparable) to designate the series.
setSeriesBarWidth(int, double) - Method in class org.jfree.chart.renderer.category.LayeredBarRenderer
Sets the width of the bars of a series.
setSeriesCreateEntities(int, Boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether entities are created for a series, and sends a RendererChangeEvent to all registered listeners.
setSeriesCreateEntities(int, Boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether entities are created for a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesFilled(int, boolean) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Sets a flag that controls whether or not a series is filled.
setSeriesFillPaint(int, Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the paint used for a series fill and sends a RendererChangeEvent to all registered listeners.
setSeriesFillPaint(int, Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the paint used to fill a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesIndex(int) - Method in class org.jfree.chart.entity.LegendItemEntity
Deprecated.
As of 1.0.6, use the LegendItemEntity.setSeriesKey(Comparable) method.
setSeriesIndex(int) - Method in class org.jfree.chart.entity.XYItemEntity
Sets the series index.
setSeriesIndex(int) - Method in class org.jfree.chart.LegendItem
Sets the series index for this legend item.
setSeriesIndex(int) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer.State
Sets the series index for the current path.
setSeriesItemLabelFont(int, Font) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the item label font for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelFont(int, Font, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the item label font for a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelFont(int, Font) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the item label font for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelFont(int, Font) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the item label font for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelGenerator(int, CategoryItemLabelGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Sets the item label generator for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelGenerator(int, CategoryItemLabelGenerator) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the item label generator for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelGenerator(int, XYItemLabelGenerator) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Sets the item label generator for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelGenerator(int, XYItemLabelGenerator) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the item label generator for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelPaint(int, Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the item label paint for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelPaint(int, Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the item label paint for a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelPaint(int, Paint) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the item label paint for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelPaint(int, Paint) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the item label paint for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelsVisible(int, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets a flag that controls the visibility of the item labels for a series, and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelsVisible(int, Boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the visibility of the item labels for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelsVisible(int, Boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the visibility of item labels for a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelsVisible(int, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets a flag that controls the visibility of the item labels for a series.
setSeriesItemLabelsVisible(int, Boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets a flag that controls the visibility of the item labels for a series.
setSeriesItemLabelsVisible(int, Boolean, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the visibility of item labels for a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelsVisible(int, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets a flag that controls the visibility of the item labels for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemLabelsVisible(int, Boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets a flag that controls the visibility of the item labels for a series.
setSeriesItemLabelsVisible(int, Boolean, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the visibility of item labels for a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesItemURLGenerator(int, CategoryURLGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Sets the URL generator for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesItemURLGenerator(int, CategoryURLGenerator) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the item URL generator for a series.
setSeriesKey(Comparable) - Method in class org.jfree.chart.entity.LegendItemEntity
Sets the key for the series.
setSeriesKey(Comparable) - Method in class org.jfree.chart.LegendItem
Sets the series key.
setSeriesKey(int, Comparable) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Sets the name of a series.
setSeriesKey(Comparable) - Method in class org.jfree.data.xml.CategorySeriesHandler
Sets the series key.
setSeriesKeys(Comparable[]) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Sets the names of the series in the dataset.
setSeriesKeys(Comparable[]) - Method in class org.jfree.data.contour.DefaultContourDataset
Deprecated.
Sets the names of the series in the data source.
setSeriesLinesVisible(int, Boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the 'lines visible' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesLinesVisible(int, boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the 'lines visible' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesLinesVisible(int, Boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the 'lines visible' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesLinesVisible(int, boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the 'lines visible' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesNeedle(int) - Method in class org.jfree.chart.plot.CompassPlot
Sets the needle type.
setSeriesNeedle(int, int) - Method in class org.jfree.chart.plot.CompassPlot
Sets the needle for a series.
setSeriesNeedle(int, MeterNeedle) - Method in class org.jfree.chart.plot.CompassPlot
Sets the needle for a series and sends a PlotChangeEvent to all registered listeners.
setSeriesNegativeItemLabelPosition(int, ItemLabelPosition) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the item label position for negative values in a series and sends a RendererChangeEvent to all registered listeners.
setSeriesNegativeItemLabelPosition(int, ItemLabelPosition, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the item label position for negative values in a series and (if requested) sends a RendererChangeEvent to all registered listeners.
setSeriesNegativeItemLabelPosition(int, ItemLabelPosition) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the item label position for negative values in a series and sends a RendererChangeEvent to all registered listeners.
setSeriesNegativeItemLabelPosition(int, ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the item label position for negative values in a series and (if requested) sends a RendererChangeEvent to all registered listeners.
setSeriesNegativeItemLabelPosition(int, ItemLabelPosition) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the item label position for negative values in a series and sends a RendererChangeEvent to all registered listeners.
setSeriesNegativeItemLabelPosition(int, ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the item label position for negative values in a series and (if requested) sends a RendererChangeEvent to all registered listeners.
setSeriesOutlinePaint(int, Paint) - Method in class org.jfree.chart.plot.CompassPlot
Sets the series outline paint.
setSeriesOutlinePaint(Paint) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the outline paint for ALL series in the plot.
setSeriesOutlinePaint(int, Paint) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the paint used to fill a series of the radar and sends a PlotChangeEvent to all registered listeners.
setSeriesOutlinePaint(int, Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the paint used for a series outline and sends a RendererChangeEvent to all registered listeners.
setSeriesOutlinePaint(int, Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the paint used to draw the outline for a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesOutlinePaint(int, Paint) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the paint used for a series outline and sends a RendererChangeEvent to all registered listeners.
setSeriesOutlinePaint(int, Paint) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the paint used for a series outline and sends a RendererChangeEvent to all registered listeners.
setSeriesOutlineStroke(int, Stroke) - Method in class org.jfree.chart.plot.CompassPlot
Sets the series outline stroke.
setSeriesOutlineStroke(Stroke) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the outline stroke for ALL series in the plot.
setSeriesOutlineStroke(int, Stroke) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the stroke used to fill a series of the radar and sends a PlotChangeEvent to all registered listeners.
setSeriesOutlineStroke(int, Stroke) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the outline stroke used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesOutlineStroke(int, Stroke, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the outline stroke for a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesOutlineStroke(int, Stroke) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the outline stroke used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesOutlineStroke(int, Stroke) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the outline stroke used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesPaint(int, Paint) - Method in class org.jfree.chart.plot.CompassPlot
Sets the series paint.
setSeriesPaint(Paint) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the paint for ALL series in the plot.
setSeriesPaint(int, Paint) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the paint used to fill a series of the radar and sends a PlotChangeEvent to all registered listeners.
setSeriesPaint(int, Paint) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the paint used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesPaint(int, Paint, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the paint used for a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesPaint(int, Paint) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the paint used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesPaint(int, Paint) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the paint used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesPositiveItemLabelPosition(int, ItemLabelPosition) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the item label position for all positive values in a series and sends a RendererChangeEvent to all registered listeners.
setSeriesPositiveItemLabelPosition(int, ItemLabelPosition, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the item label position for all positive values in a series and (if requested) sends a RendererChangeEvent to all registered listeners.
setSeriesPositiveItemLabelPosition(int, ItemLabelPosition) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the item label position for all positive values in a series and sends a RendererChangeEvent to all registered listeners.
setSeriesPositiveItemLabelPosition(int, ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the item label position for all positive values in a series and (if requested) sends a RendererChangeEvent to all registered listeners.
setSeriesPositiveItemLabelPosition(int, ItemLabelPosition) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the item label position for all positive values in a series and sends a RendererChangeEvent to all registered listeners.
setSeriesPositiveItemLabelPosition(int, ItemLabelPosition, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the item label position for all positive values in a series and (if requested) sends a RendererChangeEvent to all registered listeners.
setSeriesRenderingOrder(SeriesRenderingOrder) - Method in class org.jfree.chart.plot.XYPlot
Sets the series order and sends a PlotChangeEvent to all registered listeners.
setSeriesShape(int, Shape) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the shape used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShape(int, Shape, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the shape for a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesShape(int, Shape) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the shape used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShape(int, Shape) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the shape used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShapesFilled(int, Boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the 'shapes filled' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShapesFilled(int, boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the 'shapes filled' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShapesFilled(int, Boolean) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Sets the 'shapes filled' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShapesFilled(int, boolean) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Sets the 'shapes filled' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShapesFilled(int, Boolean) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Sets the 'shapes filled' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShapesFilled(int, boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the 'shapes filled' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShapesFilled(int, Boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the 'shapes filled' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShapesVisible(int, boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the 'shapes visible' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShapesVisible(int, Boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the 'shapes visible' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShapesVisible(int, boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the 'shapes visible' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesShapesVisible(int, Boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the 'shapes visible' flag for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesStroke(int, Stroke) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the stroke used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesStroke(int, Stroke, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the stroke for a series and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesStroke(int, Stroke) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the stroke used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesStroke(int, Stroke) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the stroke used for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesToGroupMap(KeyToGroupMap) - Method in class org.jfree.chart.renderer.category.GroupedStackedBarRenderer
Updates the map used to assign each series to a group, and sends a RendererChangeEvent to all registered listeners.
setSeriesToolTipGenerator(int, CategoryToolTipGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
Sets the tool tip generator for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesToolTipGenerator(int, CategoryToolTipGenerator) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the tool tip generator for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesToolTipGenerator(int, XYToolTipGenerator) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Sets the tooltip generator for the specified series.
setSeriesToolTipGenerator(int, XYToolTipGenerator) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Sets the tool tip generator for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesToolTipGenerator(int, XYToolTipGenerator) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Sets the tool tip generator for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesToolTipGenerator(int, XYToolTipGenerator) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the tool tip generator for a series and sends a RendererChangeEvent to all registered listeners.
setSeriesVisible(int, Boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether a series is visible and sends a RendererChangeEvent to all registered listeners.
setSeriesVisible(int, Boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether a series is visible and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesVisible(Boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesVisible(int, Boolean) and AbstractRenderer.setBaseSeriesVisible(boolean).
setSeriesVisible(Boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesVisible(int, Boolean) and AbstractRenderer.setBaseSeriesVisible(boolean).
setSeriesVisible(Boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesVisible(int, Boolean) and CategoryItemRenderer.setBaseSeriesVisible(boolean).
setSeriesVisible(Boolean, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesVisible(int, Boolean, boolean) and CategoryItemRenderer.setBaseSeriesVisible(boolean, boolean).
setSeriesVisible(int, Boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the flag that controls whether a series is visible and sends a RendererChangeEvent to all registered listeners.
setSeriesVisible(int, Boolean, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the flag that controls whether a series is visible and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesVisible(int, Boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the flag that controls whether a series is visible and sends a RendererChangeEvent to all registered listeners.
setSeriesVisible(int, Boolean, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the flag that controls whether a series is visible and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesVisible(Boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesVisible(int, Boolean) and XYItemRenderer.setBaseSeriesVisible(boolean).
setSeriesVisible(Boolean, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesVisible(int, Boolean, boolean) and XYItemRenderer.setBaseSeriesVisible(boolean, boolean).
setSeriesVisibleInLegend(int, Boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether a series is visible in the legend and sends a RendererChangeEvent to all registered listeners.
setSeriesVisibleInLegend(int, Boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Sets the flag that controls whether a series is visible in the legend and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesVisibleInLegend(Boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesVisibleInLegend(int, Boolean) and AbstractRenderer.setBaseSeriesVisibleInLegend(boolean).
setSeriesVisibleInLegend(Boolean, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesVisibleInLegend(int, Boolean, boolean) and AbstractRenderer.setBaseSeriesVisibleInLegend(boolean, boolean).
setSeriesVisibleInLegend(Boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesVisibleInLegend(int, Boolean) and CategoryItemRenderer.setBaseSeriesVisibleInLegend(boolean).
setSeriesVisibleInLegend(Boolean, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesVisibleInLegend(int, Boolean, boolean) and CategoryItemRenderer.setBaseSeriesVisibleInLegend(boolean, boolean).
setSeriesVisibleInLegend(int, Boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the flag that controls whether a series is visible in the legend and sends a RendererChangeEvent to all registered listeners.
setSeriesVisibleInLegend(int, Boolean, boolean) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Sets the flag that controls whether a series is visible in the legend and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesVisibleInLegend(int, Boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the flag that controls whether a series is visible in the legend and sends a RendererChangeEvent to all registered listeners.
setSeriesVisibleInLegend(int, Boolean, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the flag that controls whether a series is visible in the legend and, if requested, sends a RendererChangeEvent to all registered listeners.
setSeriesVisibleInLegend(Boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesVisibleInLegend(int, Boolean) and XYItemRenderer.setBaseSeriesVisibleInLegend(boolean).
setSeriesVisibleInLegend(Boolean, boolean) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesVisibleInLegend(int, Boolean, boolean) and XYItemRenderer.setBaseSeriesVisibleInLegend(boolean, boolean).
setSeriesWidth(double) - Method in class org.jfree.data.gantt.XYTaskDataset
Sets the series interval width and sends a DatasetChangeEvent to all registered listeners.
SetSettings(int, double, int, double) - Static method in class jminhep.clcontrol.Global
 
setShadow(boolean) - Method in class jhplot.HPlot
Defines whether or not a shadow will be drawn at the panel border.
setShadow(boolean) - Method in class jplot.GraphSettings
Defines whether or not a shadow will be drawn at the panel border.
setShadowGenerator(ShadowGenerator) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the shadow generator for the plot and sends a PlotChangeEvent to all registered listeners.
setShadowGenerator(ShadowGenerator) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Sets the shadow generator for the plot (and all subplots) and sends a PlotChangeEvent to all registered listeners.
setShadowGenerator(ShadowGenerator) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Sets the shadow generator for the plot (and all subplots) and sends a PlotChangeEvent to all registered listeners.
setShadowGenerator(ShadowGenerator) - Method in class org.jfree.chart.plot.CombinedRangeCategoryPlot
Sets the shadow generator for the plot (and all subplots) and sends a PlotChangeEvent to all registered listeners.
setShadowGenerator(ShadowGenerator) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Sets the shadow generator for the plot (and all subplots) and sends a PlotChangeEvent to all registered listeners.
setShadowGenerator(ShadowGenerator) - Method in class org.jfree.chart.plot.PiePlot
Sets the shadow generator for the plot and sends a PlotChangeEvent to all registered listeners.
setShadowGenerator(ShadowGenerator) - Method in class org.jfree.chart.plot.XYPlot
Sets the shadow generator for the plot and sends a PlotChangeEvent to all registered listeners.
setShadowPaint(Paint) - Method in class org.jfree.chart.plot.PiePlot
Sets the shadow paint and sends a PlotChangeEvent to all registered listeners.
setShadowPaint(Paint) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the shadow paint and sends a RendererChangeEvent to all registered listeners.
setShadowPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the shadow paint.
setShadowVisible(boolean) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the flag that controls whether or not shadows are drawn by the renderer.
setShadowVisible(boolean) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the flag that controls whether or not the renderer draws shadows for the bars, and sends a RendererChangeEvent to all registered listeners.
setShadowVisible(boolean) - Method in class org.jfree.chart.StandardChartTheme
Sets the shadow visibility flag.
setShadowXOffset(double) - Method in class org.jfree.chart.plot.PiePlot
Sets the x-offset for the shadow effect and sends a PlotChangeEvent to all registered listeners.
setShadowXOffset(double) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the x-offset for the bar shadow and sends a RendererChangeEvent to all registered listeners.
setShadowXOffset(double) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the x-offset for the bar shadow and sends a RendererChangeEvent to all registered listeners.
setShadowYOffset(double) - Method in class org.jfree.chart.plot.PiePlot
Sets the y-offset for the shadow effect and sends a PlotChangeEvent to all registered listeners.
setShadowYOffset(double) - Method in class org.jfree.chart.renderer.category.BarRenderer
Sets the y-offset for the bar shadow and sends a RendererChangeEvent to all registered listeners.
setShadowYOffset(double) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the y-offset for the bar shadow and sends a RendererChangeEvent to all registered listeners.
setShape(float[]) - Method in class hep.lcio.implementation.event.ICluster
 
setShape(double) - Method in class jhplot.math.num.pdf.Weibull
Modify the shape parameter.
setShape(Shape) - Method in class org.jfree.chart.LegendItem
Sets the shape for the legend item.
setShape(Shape) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesShape(int, Shape) and AbstractRenderer.setBaseShape(Shape).
setShape(Shape, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesShape(int, Shape, boolean) and AbstractRenderer.setBaseShape(Shape, boolean).
setShape(Shape) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesShape(int, Shape) and CategoryItemRenderer.setBaseShape(Shape).
setShape(Shape) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesShape(int, Shape) and XYItemRenderer.setBaseShape(Shape).
setShape(Shape) - Method in class org.jfree.chart.title.LegendGraphic
Sets the shape.
setShapeAnchor(RectangleAnchor) - Method in class org.jfree.chart.title.LegendGraphic
Sets the shape anchor.
setShapeFilled(boolean) - Method in class org.jfree.chart.title.LegendGraphic
Sets a flag that controls whether or not the shape is filled.
setShapeLocation(RectangleAnchor) - Method in class org.jfree.chart.title.LegendGraphic
Sets the shape location.
setShapeOutlineVisible(boolean) - Method in class org.jfree.chart.title.LegendGraphic
Sets a flag that controls whether or not the shape outline is visible.
setShapePaint(Paint) - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Sets the paint for rendering shapes and sends a RendererChangeEvent to all registered listeners.
setShapesFilled(boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Deprecated.
As of 1.0.7 (the override facility is unnecessary, just use the per-series and base (default) settings).
setShapesFilled(Boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Deprecated.
As of 1.0.7 (the override facility is unnecessary, just use the per-series and base (default) settings).
setShapesFilled(boolean) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Deprecated.
As of 1.0.8, you should avoid using this method and rely on just the per-series (StandardXYItemRenderer.setSeriesShapesFilled(int, Boolean)) and base-level (StandardXYItemRenderer.setBaseShapesVisible( boolean)) settings.
setShapesFilled(Boolean) - Method in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Deprecated.
As of 1.0.8, you should avoid using this method and rely on just the per-series (StandardXYItemRenderer.setSeriesShapesFilled(int, Boolean)) and base-level (StandardXYItemRenderer.setBaseShapesVisible( boolean)) settings.
setShapesFilled(boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Deprecated.
As of 1.0.7, use the per-series and base level settings.
setShapesFilled(Boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Deprecated.
As of 1.0.7, use the per-series and base level settings.
setShapesFilled(boolean) - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Sets the 'shapes filled' for ALL series and sends a RendererChangeEvent to all registered listeners.
setShapeStroke(Stroke) - Method in class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Sets the stroke for rendering shapes and sends a RendererChangeEvent to all registered listeners.
setShapesVisible(Boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Deprecated.
As of 1.0.7 (the override facility is unnecessary, just use the per-series and base (default) settings).
setShapesVisible(boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Deprecated.
As of 1.0.7 (the override facility is unnecessary, just use the per-series and base (default) settings).
setShapesVisible(boolean) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Set the flag that controls whether a shape will be drawn for every item, or not and sends a RendererChangeEvent to all registered listeners.
setShapesVisible(boolean) - Method in class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Sets a flag that controls whether or not shapes are drawn for each data value, and sends a RendererChangeEvent to all registered listeners.
setShapesVisible(Boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Deprecated.
As of 1.0.7, use the per-series and base level settings.
setShapesVisible(boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Deprecated.
As of 1.0.7, use the per-series and base level settings.
setShapesVisible(boolean) - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Sets the flag that controls whether or not shapes are displayed for each data item, and sends a RendererChangeEvent to all registered listeners.
setShapeVisible(boolean) - Method in class org.jfree.chart.LegendItem
Sets the flag that controls whether or not the shape is visible.
setShapeVisible(boolean) - Method in class org.jfree.chart.title.LegendGraphic
Sets a flag that controls whether or not the shape is visible.
setShift(String) - Method in class jplot.XMLWrite
Sets the initial indentation level, a number of spaces.
setShowAxes(boolean, boolean, boolean) - Method in class jplot3dp.ModelView
 
setShowAxis(boolean) - Method in class org.jlab.groot.base.AxisAttributes
 
setShowAxis(boolean) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
setShowAxisLocation(int) - Method in class org.jfree.chart.plot.JThermometer
Sets the location for the axis.
setShowBars(boolean) - Method in class jplot.LinePars
Show histograms using bars
setShowValueLines(boolean) - Method in class org.jfree.chart.plot.JThermometer
Sets the flag that controls whether or not value lines are displayed.
setShowValueLines(boolean) - Method in class org.jfree.chart.plot.ThermometerPlot
Deprecated.
This flag doesn't do anything useful/visible. Deprecated as of version 1.0.6.
setShowZeroDays(boolean) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the flag that controls whether or not zero day counts are shown in the formatted output.
setShowZeroHours(boolean) - Method in class org.jfree.chart.util.RelativeDateFormat
Sets the flag that controls whether or not zero hour counts are shown in the formatted output.
setSigma(double) - Method in class org.apache.commons.math3.random.ValueServer
setSimpleLabelOffset(RectangleInsets) - Method in class org.jfree.chart.plot.PiePlot
Sets the offset for the simple labels and sends a PlotChangeEvent to all registered listeners.
setSimpleLabels(boolean) - Method in class org.jfree.chart.plot.PiePlot
Sets the flag that controls whether simple or extended labels are displayed on the plot, and sends a PlotChangeEvent to all registered listeners.
setSimplex(AbstractSimplex) - Method in class org.apache.commons.math3.optimization.direct.SimplexOptimizer
Deprecated.
As of 3.1. The initial simplex can now be passed as an argument of the BaseAbstractMultivariateOptimizer.optimize(int,MultivariateFunction,GoalType,OptimizationData[]) method.
setSimulatorStatus(int) - Method in class hep.lcio.implementation.event.IMCParticle
 
setSize(int) - Method in class cern.colt.bitvector.BitVector
Shrinks or expands the receiver so that it holds newSize bits.
setSize(int) - Method in class cern.colt.list.AbstractList
Sets the size of the receiver.
setSize(int) - Method in class jhplot.math.num.DoubleArray
Modify the size of this array.
setSize(double, double) - Method in class jplot.GraphLabel
Sets the size of the bounding box:
setSize(int, int) - Method in class net.java.dev.colorchooser.Palette
Get a localized name for this palette or null if a display name is not warranted
setSize(int) - Method in class org.jfree.chart.needle.MeterNeedle
Sets the size.
setSizeMargin(int, int) - Method in class jhplot.gui.GHMargin
Set size of this margin panel
setSizePanel(int, int) - Method in class jhplot.gui.GHPanel
Set the size of the global panel which keeps the central panel and the margins
setSkewnessImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the skewness.
setSliceSeparator(String) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the string separating any two slices from another.
setSlideColor(Color, Color) - Method in class jplot.LinePars
Enabled and initializes the sliding color option.
setSlideColor(boolean) - Method in class jplot.LinePars
Activates the slide color option.
setSmallestValue(double) - Method in class org.jfree.chart.axis.LogAxis
Sets the smallest value represented by the axis and sends a change event to all registered listeners.
setSmallFont(Font) - Method in class org.jfree.chart.StandardChartTheme
Sets the small font for this theme.
setSoftCurrentTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Restrict step range to a limited part of the global step.
setSoftPreviousTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Restrict step range to a limited part of the global step.
setSortOrder(SortOrder) - Method in class org.jfree.chart.title.LegendTitle
Sets the order used to display legend items.
setSource(String) - Method in interface org.jlab.groot.tree.TreeProvider
 
setSource(String) - Method in class org.jlab.groot.tree.TreeTextFile
 
setSources(LegendItemSource[]) - Method in class org.jfree.chart.title.LegendTitle
Sets the legend item sources and sends a TitleChangeEvent to all registered listeners.
setSpace() - Method in class jplot.GraphLabel
add a space
setSpaceParity(float) - Method in class hephysics.particle.HEParticle
Set P space parity
setSpectrumMode(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setSpin(float[]) - Method in class hep.lcio.implementation.event.IMCParticle
 
setSpin(float) - Method in class hephysics.particle.HEParticle
Set J total spin
setStabilityCheck(boolean, int, int, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Set the stability check controls.
setStagger(boolean) - Method in class org.jfree.chart.renderer.category.CategoryStepRenderer
Sets the flag that controls whether or not the series steps are staggered and sends a RendererChangeEvent to all registered listeners.
setStandardDeviation(double) - Method in class jhplot.math.num.pdf.LogNormal
Modify the standard deviation.
setStandardDeviation(double) - Method in class jhplot.math.num.pdf.Normal
Modify the standard deviation.
setStandardTickUnits(TickUnitSource) - Method in class org.jfree.chart.axis.ValueAxis
Sets the source for obtaining standard tick units for the axis and sends an AxisChangeEvent to all registered listeners.
setStartAngle(double) - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Sets the start angle and sends a DialLayerChangeEvent to all registered listeners.
setStartAngle(double) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the start angle for the scale and sends a DialLayerChangeEvent to all registered listeners.
setStartAngle(double) - Method in class org.jfree.chart.plot.PiePlot
Sets the starting angle and sends a PlotChangeEvent to all registered listeners.
setStartAngle(double) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the starting angle and sends a PlotChangeEvent to all registered listeners.
setStarterIntegrator(FirstOrderFieldIntegrator<T>) - Method in class org.apache.commons.math3.ode.MultistepFieldIntegrator
Set the starter integrator.
setStarterIntegrator(FirstOrderIntegrator) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Set the starter integrator.
setStartPercent(double) - Method in class org.jfree.chart.renderer.category.GanttRenderer
Sets the position of the start of the progress indicator, as a percentage of the bar width, and sends a RendererChangeEvent to all registered listeners.
setStartTime(long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Sets the start time for the timeline.
setStartValue(double) - Method in class org.jfree.chart.plot.IntervalMarker
Sets the start value for the marker and sends a MarkerChangeEvent to all registered listeners.
setStartValue(int, Comparable, Number) - Method in class org.jfree.data.category.DefaultIntervalCategoryDataset
Sets the start data value for one category in a series.
setStartVertex(Vertex) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setStatBoxFont(FontProperties) - Method in class org.jlab.groot.base.PadAttributes
 
setStatBoxFont(String) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setStatBoxFontSize(int) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setStatBoxFontSize(int) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setStatBoxOffsetX(int) - Method in class org.jlab.groot.base.PadAttributes
 
setStatBoxOffsetY(int) - Method in class org.jlab.groot.base.PadAttributes
 
setState(double, double) - Method in class cern.jet.random.Beta
Sets the parameters.
setState(double, double, double) - Method in class cern.jet.random.BreitWigner
Sets the mean, gamma and cut parameters.
setState(double) - Method in class cern.jet.random.ChiSquare
Sets the distribution parameter.
setState(double[], int) - Method in class cern.jet.random.Empirical
Sets the distribution parameters.
setState(double[], int) - Method in class cern.jet.random.EmpiricalWalker
Sets the distribution parameters.
setState(double) - Method in class cern.jet.random.Exponential
Sets the mean.
setState(double) - Method in class cern.jet.random.ExponentialPower
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.Gamma
Sets the mean and variance.
setState(double, double) - Method in class cern.jet.random.Hyperbolic
Sets the parameters.
setState(int, int, int) - Method in class cern.jet.random.HyperGeometric
Sets the parameters.
setState(double) - Method in class cern.jet.random.Logarithmic
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.Normal
Sets the mean and variance.
setState(double) - Method in class cern.jet.random.StudentT
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.Uniform
Sets the internal state.
setState(double) - Method in class cern.jet.random.VonMises
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.Zeta
Sets the parameters.
setState2(double[]) - Method in class cern.jet.random.EmpiricalWalker
Sets the distribution parameters.
setState_post(Matrix) - Method in class jhplot.math.kalman.JKalman
Setter
setState_pre(Matrix) - Method in class jhplot.math.kalman.JKalman
Setter
setStatus(int) - Method in class hephysics.particle.HEParticle
Set Monte Carlo status code
setStatus(int, int) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
setStatus(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
setStatus(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 status = 3 [packed = true];
setStep(double) - Method in class org.jlab.groot.math.UserParameter
 
setStepped(boolean) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Sets the stepped flag.
setStepPoint(double) - Method in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Sets the step point and sends a RendererChangeEvent to all registered listeners.
setStepPoint(double) - Method in class org.jfree.chart.renderer.xy.XYStepRenderer
Sets the step point and sends a RendererChangeEvent to all registered listeners.
setStepSizeControl(double, double, double, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
Set the adaptive step size control parameters.
setStepSizeControl(double, double, double[], double[]) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
Set the adaptive step size control parameters.
setStepSizeControl(double, double, double, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Set the adaptive step size control parameters.
setStepSizeControl(double, double, double[], double[]) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Set the adaptive step size control parameters.
setStopped(boolean) - Method in class hep.lcio.implementation.event.IMCParticle
 
setStot(double) - Method in class jhplot.stat.ConfidenceLevel
 
setStrictValuesFlag(boolean) - Method in class org.jfree.chart.axis.LogarithmicAxis
Sets the 'strictValuesFlag' flag; if true and 'allowNegativesFlag' is false then this axis will throw a runtime exception if any of its values are less than or equal to zero; if false then the axis will adjust for values less than or equal to zero as needed.
setString(String) - Method in class graph.ScanString
Set the string to be scanned
setString(String, Font, Color, Dimension) - Method in class jhplot.gui.GHMargin
Sets the string.
setString(String) - Method in class jhplot.gui.GHMargin
Set the text on this panel
setString(String, Font, Color) - Method in class jhplot.gui.GHMargin
 
setStringChar(char) - Method in class graph.ScanWord
Set the character that delimeters a string.
setStringPositionX(double) - Method in class jhplot.gui.GHMargin
Set the text position in X relative to the frame width
setStringPositionY(double) - Method in class jhplot.gui.GHMargin
Set the text position in Y relative to the frame height.
setStripOutlinePaint(Paint) - Method in class org.jfree.chart.title.PaintScaleLegend
Sets the paint used to draw the outline of the paint strip, and sends a TitleChangeEvent to all registered listeners.
setStripOutlineStroke(Stroke) - Method in class org.jfree.chart.title.PaintScaleLegend
Sets the stroke used to draw the outline around the paint strip and sends a TitleChangeEvent to all registered listeners.
setStripOutlineVisible(boolean) - Method in class org.jfree.chart.title.PaintScaleLegend
Sets the flag that controls whether or not an outline is drawn around the paint strip, and sends a TitleChangeEvent to all registered listeners.
setStripWidth(double) - Method in class org.jfree.chart.title.PaintScaleLegend
Sets the width of the paint strip and sends a TitleChangeEvent to all registered listeners.
setStroke(Stroke) - Method in class jhplot.shapes.HShape
Set the Stroke to a specific value
setStroke(Stroke) - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Sets the stroke used to draw the connecting line and sends an AnnotationChangeEvent to all registered listeners.
setStroke(Stroke) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the stroke that will be used to draw shapes.
setStroke(Stroke) - Method in class org.jfree.chart.plot.Crosshair
Sets the stroke for the crosshair line and sends a property change event with the name "stroke" to all registered listeners.
setStroke(Stroke) - Method in class org.jfree.chart.plot.dial.ArcDialFrame
Sets the stroke and sends a DialLayerChangeEvent to all registered listeners.
setStroke(Stroke) - Method in class org.jfree.chart.plot.dial.DialPointer.Pin
Sets the stroke and sends a DialLayerChangeEvent to all registered listeners.
setStroke(Stroke) - Method in class org.jfree.chart.plot.dial.StandardDialFrame
Sets the stroke and sends a DialLayerChangeEvent to all registered listeners.
setStroke(Stroke) - Method in class org.jfree.chart.plot.Marker
Sets the stroke and sends a MarkerChangeEvent to all registered listeners.
setStroke(Stroke) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesStroke(int, Stroke) and AbstractRenderer.setBaseStroke(Stroke).
setStroke(Stroke, boolean) - Method in class org.jfree.chart.renderer.AbstractRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on AbstractRenderer.setSeriesStroke(int, Stroke, boolean) and AbstractRenderer.setBaseStroke(Stroke, boolean).
setStroke(Stroke) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on CategoryItemRenderer.setSeriesStroke(int, Stroke) and CategoryItemRenderer.setBaseStroke(Stroke).
setStroke(Stroke) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
This method should no longer be used (as of version 1.0.6). It is sufficient to rely on XYItemRenderer.setSeriesStroke(int, Stroke) and XYItemRenderer.setBaseStroke(Stroke).
setStyle(String) - Method in class jhplot.DrawOptions
Sets the style.
setSubdetectorEnergies(float[]) - Method in class hep.lcio.implementation.event.ICluster
 
setSubdetectorHitNumbers(int[]) - Method in class hep.lcio.implementation.event.ITrack
 
setSubdivisionCount(int) - Method in class org.jfree.chart.title.PaintScaleLegend
Sets the subdivision count and sends a TitleChangeEvent to all registered listeners.
setSubLabelFont(Font) - Method in class org.jfree.chart.axis.ExtendedCategoryAxis
Sets the font for the sublabels and sends an AxisChangeEvent to all registered listeners.
setSubLabelFont(Font) - Method in class org.jfree.chart.axis.SubCategoryAxis
Sets the font used to display the sub-category labels and sends an AxisChangeEvent to all registered listeners.
setSubLabelPaint(Paint) - Method in class org.jfree.chart.axis.ExtendedCategoryAxis
Sets the paint for the sublabels and sends an AxisChangeEvent to all registered listeners.
setSubLabelPaint(Paint) - Method in class org.jfree.chart.axis.SubCategoryAxis
Sets the paint used to display the sub-category labels and sends an AxisChangeEvent to all registered listeners.
setSubMatrix(MutableMatrix, Matrix, int, int) - Static method in class hep.physics.matrix.MatrixOp
Fill in part of a matrix with the contents of another matrix.
setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Replace the submatrix starting at (row, column) using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Replace the submatrix starting at (row, column) using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Replace the submatrix starting at (row, column) using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(T[][], int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Replace the submatrix starting at (row, column) using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubrange(int, double, double) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the bounds for a subrange.
setSubrangeInfo(int, double, double) - Method in class org.jfree.chart.plot.JThermometer
Sets the range.
setSubrangeInfo(int, double, double, double, double) - Method in class org.jfree.chart.plot.JThermometer
Sets the range.
setSubrangeInfo(int, double, double) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets information for a particular range.
setSubrangeInfo(int, double, double, double, double) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the subrangeInfo attribute of the ThermometerPlot object
setSubrangePaint(int, Paint) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the paint to be used for a subrange and sends a PlotChangeEvent to all registered listeners.
setSubset() - Method in class hep.lcio.implementation.event.ILCCollection
 
setSubset(boolean) - Method in class hep.lcio.implementation.event.ILCCollection
 
setSubTicLength(int, double) - Method in class jhplot.HPlot
Sets the length of the subticks.
setSubTicLength(double) - Method in class jhplot.HPlot
Sets the length of the subticks for all axises.
setSubTicLength(int, double) - Method in class jplot.GraphSettings
Sets the length of the subtics.
setSubTicNumber(int, int) - Method in class jhplot.HPlot
Sets the number of subticks between ticks.
setSubTicNumber(int, int) - Method in class jplot.GraphSettings
Sets the number of the subtics.
setSubtitlePaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the subtitle paint.
setSubtitles(List) - Method in class org.jfree.chart.JFreeChart
Sets the title list for the chart (completely replaces any existing titles) and sends a ChartChangeEvent to all registered listeners.
setSubVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Set a set of consecutive elements.
setSubVector(int, RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Set a sequence of consecutive elements.
setSubVector(int, double[]) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Set a set of consecutive elements.
setSubVector(int, FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Set a set of consecutive elements.
setSubVector(int, RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Set a sequence of consecutive elements.
setSubVector(int, RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Set a sequence of consecutive elements.
setSubVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Set a set of consecutive elements.
setSumImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the sum.
setSumImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the Sum.
setSumImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the Sum.
setSumImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the Sum.
setSumImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the Sum.
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the sum of logs.
setSummary(int, double) - Method in class promc.io.PBufFile.Record.H2D.Builder
repeated double summary = 9 [packed = true];
setSumsqImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the sum of squares.
setSurface() - Method in class jhplot.HPlot3D
Set surface type of plot
setSurface(boolean) - Method in class jhplot.HPlot3D
Set surface type of plot
setSurface(SurfaceModel) - Method in class jplot3d.JSurfacePanel
 
setSurfaceType(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setSurfaceVertex(SurfaceVertex[][]) - Method in class jplot3d.SurfaceModelCanvas
 
setSymbol(int) - Method in class jhplot.DrawOptions
Set symbol types.
setSymbol(String) - Method in class jhplot.DrawOptions
Set symbol types using a string.
setSymbol(int) - Method in class jplot.LinePars
Sets the symbol type (symbolic constant)
setSymbolColor(Color) - Method in class jhplot.P2D
Sets symbol color
setSymbolColor(Color) - Method in class jplot3d.JPoint
Sets color.
setSymbolSize(int) - Method in class jhplot.DrawOptions
Set the size of the symbols
setSymbolSize(int) - Method in class jhplot.P2D
Sets the symbol size
setSymbolSize(float) - Method in class jplot.LinePars
Sets the size of the symbol in points
setT(double) - Method in class hep.physics.vec.BasicHepLorentzVector
 
setT(double) - Method in class hephysics.vec.HepLorentzVector
Set time
setT(int, float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float T = 16 [packed = true];
setT(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
setT(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint32 T = 16 [packed = true];
setTanLambda(float) - Method in class hep.lcio.implementation.event.ITrack
 
setTanLambda(float) - Method in class hep.lcio.implementation.event.ITrackState
 
setTauTag(int, int) - Method in class proreco.io.ProMC.ProMCEvent.BLJets.Builder
repeated sint32 TauTag = 6 [packed = true];
setTauTag(int, int) - Method in class proreco.io.ProMC.ProMCEvent.GenJets.Builder
repeated sint32 TauTag = 6 [packed = true];
setTautag(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Jets.Builder
repeated sint32 Tautag = 6 [packed = true];
setTdsFactor(float) - Method in class jplot.GraphSettings
Sets the factor used to plot a TDS circle.
setTempFilePrefix(String) - Static method in class org.jfree.chart.servlet.ServletUtilities
Sets the prefix for the temporary file names generated by this class.
setTemplateValue(Number) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the template value and sends a DialLayerChangeEvent to all registered listeners.
setTempOneTimeFilePrefix(String) - Static method in class org.jfree.chart.servlet.ServletUtilities
Sets the prefix for the "one time" temporary file names generated by this class.
setText(String) - Method in class graph.TextLine
Set the String to use with the class
setText(String) - Method in class jhplot.HKey
Sets a text of the label.
setText(String) - Method in class jhplot.HLabel
Sets a text of the label.
setText(String) - Method in class jhplot.HLabelEq
Sets a equation text of the label.
setText(String[]) - Method in class jhplot.HMLabel
Sets the text of the label.
setText(String) - Method in class jhplot.shapes.Text
Set a string with the text
setText(String, Font, Color) - Method in class jhplot.utils.DrawingPanel
 
setText(String, Font) - Method in class jhplot.utils.DrawingPanel
 
setText(String) - Method in class jhplot.utils.DrawingPanel
 
setText(String) - Method in class jplot.GraphLabel
Sets the text of the label to something new.
setText(String[]) - Method in class jplot.GraphLabel
Sets the multi text of the label to something new.
setText(String) - Method in class jplot.Utils.CheckBoxWithText
 
setText(String) - Method in class jplot.Utils.LabeledTextField
 
setText(String) - Method in class org.jfree.chart.annotations.TextAnnotation
Sets the text for the annotation and sends an AnnotationChangeEvent to all registered listeners.
setText(String) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the text for the annotation.
setText(String) - Method in class org.jfree.chart.title.TextTitle
Sets the title to the specified text and sends a TitleChangeEvent to all registered listeners.
setText(String) - Method in class org.jlab.groot.ui.LatexText
 
setTextAlignment(HorizontalAlignment) - Method in class org.jfree.chart.title.TextTitle
Sets the text alignment and sends a TitleChangeEvent to all registered listeners.
setTextAnchor(TextAnchor) - Method in class org.jfree.chart.annotations.TextAnnotation
Sets the text anchor (the point on the text bounding rectangle that is aligned to the (x, y) coordinate of the annotation) and sends an AnnotationChangeEvent to all registered listeners.
setTextAnchor(TextAnchor) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the text anchor (the point on the text bounding rectangle that is aligned to the (x, y) coordinate of the annotation) and sends an AnnotationChangeEvent to all registered listeners.
setTextAnchor(RectangleAnchor) - Method in class org.jfree.chart.block.LabelBlock
Sets the text anchor.
setTextAnchor(TextAnchor) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the text anchor and sends a DialLayerChangeEvent to all registered listeners.
setTextAntiAlias(boolean) - Method in class org.jfree.chart.JFreeChart
Sets the value in the rendering hints table for RenderingHints.KEY_TEXT_ANTIALIASING to either RenderingHints.VALUE_TEXT_ANTIALIAS_ON or RenderingHints.VALUE_TEXT_ANTIALIAS_OFF, then sends a ChartChangeEvent to all registered listeners.
setTextAntiAlias(Object) - Method in class org.jfree.chart.JFreeChart
Sets the value in the rendering hints table for RenderingHints.KEY_TEXT_ANTIALIASING and sends a ChartChangeEvent to all registered listeners.
setTextBottom(String, Font, Color) - Method in class jhplot.gui.GHPanel
Sets a text on global bottom margin.
setTextBottom(String, Font) - Method in class jhplot.gui.GHPanel
Sets a text on global bottom margin using black color.
setTextBottom(String) - Method in class jhplot.gui.GHPanel
Set the global bottom margin with default attributes.
setTextBottom(String, double) - Method in class jhplot.gui.GHPanel
Set the global bottom margin with default attributes.
setTextBottomColorBack(Color) - Method in class jhplot.gui.GHPanel
Get the background color of bottom margin
setTextColor(Color) - Method in class jplot3d.ColorModelSet
 
setTextColor(Color) - Method in interface jplot3d.SurfaceColor
 
setTextFont(Font) - Method in class jhepsim.mainGUI
Set text font
setTextLeft(String, Font, Color) - Method in class jhplot.gui.GHPanel
Sets a text on global left margin
setTextLeft(String, Font) - Method in class jhplot.gui.GHPanel
Sets a text on global left margin using black color.
setTextLeft(String) - Method in class jhplot.gui.GHPanel
Set the global left margin with default attributes.
setTextLeft(String, double) - Method in class jhplot.gui.GHPanel
Set the global left margin with default attributes.
setTextLeftColorBack(Color) - Method in class jhplot.gui.GHPanel
Get the background color of left margin
setTextPosBottomX(double) - Method in class jhplot.gui.GHPanel
Set the text position in X relative to width for bottom margin
setTextPosBottomY(double) - Method in class jhplot.gui.GHPanel
Set the text position in Y relative to width for bottom margin
setTextPosition(int, int) - Method in class jhplot.utils.DrawingPanel
 
setTextPosLeftX(double) - Method in class jhplot.gui.GHPanel
Set the text position in X relative to width for left margin
setTextPosLeftY(double) - Method in class jhplot.gui.GHPanel
Set the text position in Y relative to width for left margin
setTextPosRightX(double) - Method in class jhplot.gui.GHPanel
Set the text position in X relative to width for right margin
setTextPosRightY(double) - Method in class jhplot.gui.GHPanel
Set the text position in Y relative to width for right margin
setTextPosTopX(double) - Method in class jhplot.gui.GHPanel
Set the text position in X relative to width for top margin
setTextPosTopY(double) - Method in class jhplot.gui.GHPanel
Set the text position in Y relative to width for top margin
setTextRight(String, Font, Color) - Method in class jhplot.gui.GHPanel
Sets a text on global right margin
setTextRight(String, Font) - Method in class jhplot.gui.GHPanel
Sets a text on global right margin using black color.
setTextRight(String) - Method in class jhplot.gui.GHPanel
Set the global right margin with default attributes.
setTextRight(String, double) - Method in class jhplot.gui.GHPanel
Set the global right margin with default attributes.
setTextRightColorBack(Color) - Method in class jhplot.gui.GHPanel
Get the background color of left margin
setTextRotationBottom(int) - Method in class jhplot.gui.GHPanel
Set the text rotation for bottom margin
setTextRotationLeft(int) - Method in class jhplot.gui.GHPanel
Set the text rotation for left margin
setTextRotationRight(int) - Method in class jhplot.gui.GHPanel
Set the text rotation for right margin
setTextRotationTop(int) - Method in class jhplot.gui.GHPanel
Set the text rotation for top margin
setTextSize(double, double) - Method in class jplot.GraphLabel
Sets the size of the text-label:
setTextTop(String, Font, Color) - Method in class jhplot.gui.GHPanel
Sets a text on global top margin
setTextTop(String, Font) - Method in class jhplot.gui.GHPanel
Sets a text on global top margin using black color.
setTextTop(String) - Method in class jhplot.gui.GHPanel
Set the global top margin with default attributes.
setTextTopColorBack(Color) - Method in class jhplot.gui.GHPanel
Get the background color of top margin
setTheme(String) - Method in class jhplot.HChart
Set a custom theme for chart.
setThermometerPaint(Paint) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the paint used to draw the thermometer outline and sends a PlotChangeEvent to all registered listeners.
setThermometerPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the thermometer paint.
setThermometerStroke(Stroke) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the stroke used to draw the thermometer outline and sends a PlotChangeEvent to all registered listeners.
setThetaPhiP(double, double, double) - Method in class hephysics.particle.LParticle
Set HepLorentzVector using theta angle, phi and total momentum P.
setThMomPower(double) - Method in class hep.physics.jet.EventShape
 
setThreadFactory(ThreadFactory) - Method in class org.apache.commons.io.monitor.FileAlterationMonitor
Sets the thread factory.
setTicColor(int, Color) - Method in class jhplot.HPlot
Sets the color used by the labels drawn at each tick.
setTicColor(Color) - Method in class jhplot.HPlot
Sets the color used by the labels drawn at each tick (for all axises).
setTicColor(int, Color) - Method in class jplot.GraphSettings
Sets the color used by the labels drawn at each tic.
setTicFont(int, Font) - Method in class jhplot.HPlot
Sets the font used by the labels drawn at each tick.
setTicFont(Font) - Method in class jhplot.HPlot
Sets the font used by the labels drawn at each tick (for all axises).
setTicFont(Font) - Method in class jhplot.HPlot3D
Set font for the ticks
setTicFont(int, Font) - Method in class jplot.GraphSettings
Sets the font used by the labels drawn at each tic.
setTicFont(Font) - Method in interface jplot3d.SurfaceModel
 
setTicFont(Font) - Method in class jplot3d.SurfaceModelCanvas
 
setTickColor(int, Color) - Method in class jhplot.HChart
Set tick color.
setTickFont(Font) - Method in class jhplot.HChart
Set font of ticks.
setTickFontStyle(int) - Method in class org.jfree.chart.plot.JThermometer
Sets the tick font style.
setTickLabelFont(Font) - Method in class org.jfree.chart.axis.Axis
Sets the font for the tick labels and sends an AxisChangeEvent to all registered listeners.
setTickLabelFont(Comparable, Font) - Method in class org.jfree.chart.axis.CategoryAxis
Sets the font for the tick label for the specified category and sends an AxisChangeEvent to all registered listeners.
setTickLabelFont(Font) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the font used to display the tick labels and sends a DialLayerChangeEvent to all registered listeners.
setTickLabelFont(Font) - Method in class org.jfree.chart.plot.JThermometer
Sets the tick label font.
setTickLabelFont(Font) - Method in class org.jfree.chart.plot.MeterPlot
Sets the tick label font and sends a PlotChangeEvent to all registered listeners.
setTickLabelFormat(NumberFormat) - Method in class org.jfree.chart.plot.MeterPlot
Sets the format for the tick labels and sends a PlotChangeEvent to all registered listeners.
setTickLabelFormatter(NumberFormat) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the number formatter used to convert the tick label values to strings, and sends a DialLayerChangeEvent to all registered listeners.
setTickLabelInsets(RectangleInsets) - Method in class org.jfree.chart.axis.Axis
Sets the insets for the tick labels and sends an AxisChangeEvent to all registered listeners.
setTickLabelOffset(double) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the tick label offset and sends a DialLayerChangeEvent to all registered listeners.
setTickLabelPaint(Paint) - Method in class org.jfree.chart.axis.Axis
Sets the paint used to draw tick labels (if they are showing) and sends an AxisChangeEvent to all registered listeners.
setTickLabelPaint(Comparable, Paint) - Method in class org.jfree.chart.axis.CategoryAxis
Sets the paint for the tick label for the specified category and sends an AxisChangeEvent to all registered listeners.
setTickLabelPaint(Paint) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the paint used to draw the tick labels and sends a DialLayerChangeEvent to all registered listeners.
setTickLabelPaint(Paint) - Method in class org.jfree.chart.plot.MeterPlot
Sets the tick label paint and sends a PlotChangeEvent to all registered listeners.
setTickLabelPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the tick label paint.
setTickLabelsVisible(boolean) - Method in class org.jfree.chart.axis.Axis
Sets the flag that determines whether or not the tick labels are visible and sends an AxisChangeEvent to all registered listeners.
setTickLabelsVisible(boolean) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the flag that controls whether or not the tick labels are displayed, and sends a DialLayerChangeEvent to all registered listeners.
setTickLabelsVisible(boolean) - Method in class org.jfree.chart.plot.MeterPlot
Sets the flag that controls whether or not the tick labels are visible and sends a PlotChangeEvent to all registered listeners.
setTickLength(double) - Method in class org.jfree.chart.renderer.xy.HighLowRenderer
Sets the tick length (in Java2D units) and sends a RendererChangeEvent to all registered listeners.
setTickMarkInsideLength(float) - Method in class org.jfree.chart.axis.Axis
Sets the inside length of the tick marks and sends an AxisChangeEvent to all registered listeners.
setTickMarkOutsideLength(float) - Method in class org.jfree.chart.axis.Axis
Sets the outside length of the tick marks and sends an AxisChangeEvent to all registered listeners.
setTickMarkPaint(Paint) - Method in class org.jfree.chart.axis.Axis
Sets the paint used to draw tick marks and sends an AxisChangeEvent to all registered listeners.
setTickMarkPosition(DateTickMarkPosition) - Method in class org.jfree.chart.axis.DateAxis
Sets the tick mark position (start, middle or end of the time period) and sends an AxisChangeEvent to all registered listeners.
setTickMarkStroke(Stroke) - Method in class org.jfree.chart.axis.Axis
Sets the stroke used to draw tick marks and sends an AxisChangeEvent to all registered listeners.
setTickMarksVisible(boolean) - Method in class org.jfree.chart.axis.Axis
Sets the flag that indicates whether or not the tick marks are showing and sends an AxisChangeEvent to all registered listeners.
setTickPaint(Paint) - Method in class org.jfree.chart.plot.MeterPlot
Sets the paint used to draw the tick labels around the dial and sends a PlotChangeEvent to all registered listeners.
setTickRadius(double) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the tick radius and sends a DialLayerChangeEvent to all registered listeners.
setTicks(List) - Method in class org.jfree.chart.axis.AxisState
Sets the list of ticks.
setTickSize(double) - Method in class org.jfree.chart.plot.MeterPlot
Sets the tick size and sends a PlotChangeEvent to all registered listeners.
setTickSize(int) - Method in class org.jlab.groot.base.AxisAttributes
 
setTickUnit(DateTickUnit) - Method in class org.jfree.chart.axis.DateAxis
Sets the tick unit for the axis.
setTickUnit(DateTickUnit, boolean, boolean) - Method in class org.jfree.chart.axis.DateAxis
Sets the tick unit attribute and, if requested, sends an AxisChangeEvent to all registered listeners.
setTickUnit(NumberTickUnit) - Method in class org.jfree.chart.axis.LogAxis
Sets the tick unit for the axis and sends an AxisChangeEvent to all registered listeners.
setTickUnit(NumberTickUnit, boolean, boolean) - Method in class org.jfree.chart.axis.LogAxis
Sets the tick unit for the axis and, if requested, sends an AxisChangeEvent to all registered listeners.
setTickUnit(NumberTickUnit) - Method in class org.jfree.chart.axis.NumberAxis
Sets the tick unit for the axis and sends an AxisChangeEvent to all registered listeners.
setTickUnit(NumberTickUnit, boolean, boolean) - Method in class org.jfree.chart.axis.NumberAxis
Sets the tick unit for the axis and, if requested, sends an AxisChangeEvent to all registered listeners.
setTickValues(double[]) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Sets the tick values.
setTickValues(List) - Method in class org.jfree.chart.plot.ColorPalette
Deprecated.
Store ticks.
setTicLabels(boolean) - Method in class jhplot.HPlot
Sets whether all tick-labels will be written or not.
setTicLabels(int, boolean) - Method in class jhplot.HPlot
Sets whether tick-labels will be shown or not.
setTicLength(int, double) - Method in class jhplot.HPlot
Sets the length of the ticks.
setTicLength(double) - Method in class jhplot.HPlot
Sets the length of the ticks for all axes.
setTicLength(int, double) - Method in class jplot.GraphSettings
Sets the length of the tics.
setTicOffset(double) - Method in class jhplot.HPlot3D
Set tick offset
setTicOffset(float) - Method in interface jplot3d.SurfaceModel
 
setTicOffset(float) - Method in class jplot3d.SurfaceModelCanvas
 
setTics(int, boolean) - Method in class jhplot.HPlot
Sets whether or not to draw ticks (little lines on the axes).
setTics(boolean) - Method in class jhplot.HPlot
Sets whether or not to draw ticks (little lines on the axes) for all axis.
setTicsMirror(int, boolean) - Method in class jhplot.HPlot
Sets true or false to draw mirror ticks
setTicsMirror(boolean) - Method in class jhplot.HPlot
Sets true or false to draw mirror ticks for X and Y
setTicsRotate(int, boolean) - Method in class jhplot.HPlot
Defines whether we should rotate ticks.
setTime(float) - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
setTime(float) - Method in class hep.lcio.implementation.event.IMCParticle
 
setTime(float) - Method in class hep.lcio.implementation.event.ISimTrackerHit
 
setTime(float) - Method in class hep.lcio.implementation.event.ITPCHit
 
setTime(float) - Method in class hep.lcio.implementation.event.ITrackerData
 
setTime(float) - Method in class hep.lcio.implementation.event.ITrackerHit
 
setTime(float) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setTime(float) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setTime(float) - Method in class hep.lcio.implementation.event.ITrackerPulse
 
setTime(int) - Method in class hep.lcio.implementation.event.ITrackerRawData
 
setTime(double) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Set current time.
setTimeBase(RegularTimePeriod) - Method in class org.jfree.data.time.DynamicTimeSeriesCollection
Fill the pointsInTime with times using TimePeriod.next(): Will silently return if the time array was already populated.
setTimeline(Timeline) - Method in class org.jfree.chart.axis.DateAxis
Sets the underlying timeline to use for this axis.
setTimeSeries(boolean) - Method in class org.jfree.data.jdbc.JDBCXYDataset
Sets a flag that indicates whether or not the data represents a time series.
setTimeStamp(long) - Method in class hep.lcio.implementation.event.ILCEvent
 
setTimeStamp(int) - Method in class hep.lcio.implementation.event.IRawCalorimeterHit
 
setTimestamp(long) - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
setTimestamp(long) - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
setTimestamp(long) - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
setTimestamp(long) - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 timestamp = 4;
setTimeZone(TimeZone) - Method in class org.jfree.chart.axis.DateAxis
Sets the time zone for the axis and sends an AxisChangeEvent to all registered listeners.
setTimeZone(TimeZone) - Method in class org.jfree.chart.axis.PeriodAxis
Sets the time zone that is used to convert the time periods into absolute milliseconds.
setTipRadius(double) - Method in class org.jfree.chart.annotations.CategoryPointerAnnotation
Sets the tip radius and sends an AnnotationChangeEvent to all registered listeners.
setTipRadius(double) - Method in class org.jfree.chart.annotations.XYPointerAnnotation
Sets the tip radius and sends an AnnotationChangeEvent to all registered listeners.
setTitle(String) - Method in class jhplot.DrawOptions
Sets the title.
setTitle(String) - Method in class jhplot.F3D
Set a title
setTitle(String) - Method in class jhplot.FProxy
Set title.
setTitle(String) - Method in class jhplot.H3D
Sets the title
setTitle(String) - Method in class jhplot.HProf1D
Sets the title
setTitle(String) - Method in class jhplot.HProf2D
Set title
setTitle(String) - Method in class jhplot.P0D
Set a new title
setTitle(String) - Method in class jhplot.P0I
Set a new title
setTitle(String) - Method in class jhplot.P3D
Set a new title
setTitle(String) - Method in class jhplot.Plottable
Set a new title
setTitle(String) - Method in class jhplot.PND
Set a new title
setTitle(String) - Method in class jhplot.PNI
Set a new title
setTitle(String) - Method in class jhplot.stat.DataKeeper
 
setTitle(String) - Method in class jplot3d.JSurfacePanel
 
setTitle(TextTitle) - Method in class org.jfree.chart.JFreeChart
Sets the main title for the chart and sends a ChartChangeEvent to all registered listeners.
setTitle(String) - Method in class org.jfree.chart.JFreeChart
Sets the chart title and sends a ChartChangeEvent to all registered listeners.
setTitle(String) - Method in class org.jlab.groot.base.DatasetAttributes
 
setTitle(String) - Method in class org.jlab.groot.base.PadAttributes
 
setTitle(String) - Method in class org.jlab.groot.data.GraphErrors
 
setTitle(String) - Method in class org.jlab.groot.data.H1F
 
setTitle(String) - Method in class org.jlab.groot.data.H2F
Sets the specified parameter as the title of the histogram
setTitle(String) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setTitle(String) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
setTitle(String) - Method in class org.jlab.groot.math.Axis
 
setTitleColor(Color) - Method in class graph.Axis
Set the color of the title
setTitleContainer(BlockContainer) - Method in class org.jfree.chart.title.CompositeTitle
Sets the title container.
setTitleFont(Font) - Method in class graph.Axis
Set the font of the title
setTitleFont(FontProperties) - Method in class org.jlab.groot.base.PadAttributes
 
setTitleFont(String) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setTitleFontName(String) - Method in class org.jlab.groot.base.AxisAttributes
 
setTitleFontName(String) - Method in class org.jlab.groot.base.PadAttributes
 
setTitleFontSize(int) - Method in class org.jlab.groot.base.AxisAttributes
 
setTitleFontSize(int) - Method in class org.jlab.groot.base.PadAttributes
 
setTitleFontSize(int) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setTitleName(String) - Method in class jplot.DataChangeListener
 
setTitleOffset(int) - Method in class org.jlab.groot.base.AxisAttributes
 
setTitleOffset(int) - Method in class org.jlab.groot.base.PadAttributes
 
setTitleOffset(int) - Method in class org.jlab.groot.graphics.EmbeddedPad
 
setTitlePaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the title paint.
setTitleRotation(int) - Method in class graph.Axis
Set the title rotation angle.
setTitleSize(int) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
setTitleString() - Method in class jplot.DataChangeListener
Write the title of the CHESS frame with the actual CHESS script file, adding a '*' if the file is modified but not yet saved.
setTitleText(String) - Method in class graph.Axis
Set the title of the axis
setTitleX(String) - Method in class org.jlab.groot.base.DatasetAttributes
 
setTitleX(String) - Method in class org.jlab.groot.data.GraphErrors
 
setTitleX(String) - Method in class org.jlab.groot.data.H1F
Sets the x-axis title to the specified parameter
setTitleX(String) - Method in class org.jlab.groot.data.H2F
Sets the x-axis title to the specified parameter
setTitleY(String) - Method in class org.jlab.groot.base.DatasetAttributes
 
setTitleY(String) - Method in class org.jlab.groot.data.GraphErrors
 
setTitleY(String) - Method in class org.jlab.groot.data.H1F
Sets the y-axis title to the specified parameter
setTitleY(String) - Method in class org.jlab.groot.data.H2F
Sets the y-axis title to the specified parameter
setTokens(String[][]) - Static method in class jminhep.utils.ResourceLoader
 
setTolerance(double) - Method in class cern.colt.matrix.linalg.Property
Sets the tolerance to Math.abs(newTolerance).
setTolerance(double) - Method in class org.nfunk.jep.function.Comparative
Sets the tolerance used for comparing complex numbers
setTooltip(String, double, double) - Method in class org.jfree.chart.fx.ChartCanvas
Sets the tooltip text, with the (x, y) location being used for the anchor.
setTooltipEnabled(boolean) - Method in class org.jfree.chart.fx.ChartCanvas
Sets the flag that controls whether or not tooltips are enabled.
setTooltipEnabled(boolean) - Method in class org.jfree.chart.fx.ChartViewer
Sets the flag that controls whether or not the chart tooltips are shown by this viewer.
setTooltipEnabled(boolean) - Method in class org.jfree.chart.fx.ChartViewerSkin
 
setToolTipGenerator(ContourToolTipGenerator) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the tool tip generator.
setToolTipGenerator(PieToolTipGenerator) - Method in class org.jfree.chart.plot.PiePlot
Sets the tool tip generator and sends a PlotChangeEvent to all registered listeners.
setToolTipGenerator(CategoryToolTipGenerator) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the tool tip generator for the plot and sends a PlotChangeEvent to all registered listeners.
setToolTipGenerator(CategoryToolTipGenerator) - Method in class org.jfree.chart.renderer.category.AbstractCategoryItemRenderer
setToolTipGenerator(CategoryToolTipGenerator) - Method in interface org.jfree.chart.renderer.category.CategoryItemRenderer
Deprecated.
setToolTipGenerator(XYToolTipGenerator) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Deprecated.
As of version 1.0.6, this override setting should not be used. You can use the base setting instead (AbstractXYItemRenderer.setBaseToolTipGenerator(XYToolTipGenerator)).
setToolTipGenerator(XYToolTipGenerator) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Deprecated.
As of version 1.0.6, this override setting should not be used. You can use the base setting instead (XYItemRenderer.setBaseToolTipGenerator(XYToolTipGenerator)).
setToolTipText(String) - Method in class org.jfree.chart.annotations.AbstractXYAnnotation
Sets the tool tip text for the annotation.
setToolTipText(String) - Method in class org.jfree.chart.block.LabelBlock
Sets the tool tip text.
setToolTipText(String) - Method in class org.jfree.chart.entity.ChartEntity
Sets the tool tip text.
setToolTipText(String) - Method in class org.jfree.chart.LegendItem
Sets the tool tip text for this legend item.
setToolTipText(String) - Method in class org.jfree.chart.title.LegendItemBlockContainer
Sets the tool tip text.
setToolTipText(String) - Method in class org.jfree.chart.title.TextTitle
Sets the tool tip text to the specified text and sends a TitleChangeEvent to all registered listeners.
setTop(double) - Method in class org.jfree.chart.axis.AxisSpace
Sets the space reserved for axes at the top of the plot area.
setTopMargin(double) - Method in class jplot.GraphSettings
Sets the distance between the top-border of the panel and the top X-axis.
setTopMargin(int) - Method in class org.jlab.groot.base.PadMargins
 
setTotal(double) - Method in class org.jfree.chart.plot.PiePlotState
Sets the total.
setTrackerData(TrackerData) - Method in class hep.lcio.implementation.event.ITrackerPulse
 
setTrackerHits(List) - Method in class hep.lcio.implementation.event.ITrack
 
setTracks(List) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setTracks(List) - Method in class hep.lcio.implementation.event.ITrack
 
setTracks(ProMC.ProMCEvent.Tracks) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Tracks tracks = 8;
setTracks(ProMC.ProMCEvent.Tracks.Builder) - Method in class proreco.io.ProMC.ProMCEvent.Builder
optional .promc.ProMCEvent.Tracks tracks = 8;
setTransform(AffineTransform) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the transform.
setTransient() - Method in class hep.lcio.implementation.event.ILCCollection
 
setTransient(boolean) - Method in class hep.lcio.implementation.event.ILCCollection
 
setTransition_matrix(Matrix) - Method in class jhplot.math.kalman.JKalman
Getter
setTranslateX(double) - Method in class org.jfree.chart.block.BlockParams
Sets the translation required to convert local x-coordinates into the coordinate space of the container.
setTranslateY(double) - Method in class org.jfree.chart.block.BlockParams
Sets the translation required to convert local y-coordinates into the coordinate space of the container.
setTransparency(double) - Method in class jhplot.shapes.HShape
Get the transparency level
setTranspose(boolean) - Method in class org.jfree.data.jdbc.JDBCCategoryDataset
Sets a flag that controls whether or not the table values are transposed when added to the dataset.
setTransposed(boolean) - Method in class org.jfree.data.gantt.XYTaskDataset
Sets the flag that controls whether or not the dataset is transposed and sends a DatasetChangeEvent to all registered listeners.
setTrapNullValues(boolean) - Method in class org.nfunk.jep.EvaluatorVisitor
Sets the behaviour when a variable's value is null.
setTraverse(boolean) - Method in class org.nfunk.jep.JEP
Sets the value of the traverse option.
setTree(JTree) - Method in class org.jlab.groot.tree.DynamicTree
 
setTree(DynamicTree) - Method in class org.jlab.groot.tree.TreeAnalyzer
 
setTree(DynamicTree) - Method in class org.jlab.groot.tree.TreeSelector
 
setTreeCuts(List<TreeCut>) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setTreeExpressions(List<TreeExpression>) - Method in class org.jlab.groot.tree.DatasetDescriptor
 
setTSB(double[]) - Method in class jhplot.stat.ConfidenceLevel
 
setTSD(double) - Method in class jhplot.stat.ConfidenceLevel
 
setTSS(double[]) - Method in class jhplot.stat.ConfidenceLevel
 
setTwoParticleRes(double) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
For angular resolution studies.
setType(int) - Method in class hep.lcio.implementation.event.ICalorimeterHit
 
setType(int) - Method in class hep.lcio.implementation.event.ICluster
 
setType(int) - Method in class hep.lcio.implementation.event.IParticleID
 
setType(int) - Method in class hep.lcio.implementation.event.IReconstructedParticle
 
setType(int) - Method in class hep.lcio.implementation.event.ITrackerHit
 
setType(int) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setType(int) - Method in class hep.lcio.implementation.event.ITrackerHitZCylinder
 
setType(int) - Method in class jhplot.DrawOptions
Set type of the object Should be: LinePars.H1D, LineParsF1D, LineParsF1D
setType(int) - Method in class jhplot.FProxy
Set type.
setType(int) - Method in class jhplot.shapes.Arrow
Set the type of arrow: 1,2,3
setType(int) - Method in class jplot.LinePars
Set the type of the data
setType(ChartChangeEventType) - Method in class org.jfree.chart.event.ChartChangeEvent
Sets the event type.
setType(int) - Method in class org.jfree.chart.event.ChartProgressEvent
Sets the event type.
setType(HistogramType) - Method in class org.jfree.data.statistics.HistogramDataset
Sets the histogram type and sends a DatasetChangeEvent to all registered listeners.
setType(int) - Method in class org.nfunk.jep.evaluation.CommandElement
 
setTypeBit(int) - Method in class hep.lcio.implementation.event.ICluster
 
setTypeBit(int, boolean) - Method in class hep.lcio.implementation.event.ICluster
 
setTypeBit(int) - Method in class hep.lcio.implementation.event.ITrack
 
setTypeBit(int, boolean) - Method in class hep.lcio.implementation.event.ITrack
 
setU(float[]) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setUnderflow(double) - Method in class promc.io.PBufFile.Record.H1D.Builder
optional double underflow = 13;
setUnit(String) - Method in class jplot.Utils.LabeledTextField
 
setUnit(String) - Method in class org.jlab.groot.tree.Branch
 
setUnits(Vector) - Method in class jplot.Utils.LabeledTextField
 
setUnits(String[]) - Method in class jplot.Utils.LabeledTextField
 
setUnits(int) - Method in class org.jfree.chart.plot.JThermometer
Sets the unit type.
setUnits(String) - Method in class org.jfree.chart.plot.MeterPlot
Sets the units for the dial and sends a PlotChangeEvent to all registered listeners.
setUnits(int) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the units to be displayed in the thermometer.
setUnits(String) - Method in class org.jfree.chart.plot.ThermometerPlot
Deprecated.
Use setUnits(int) instead. Deprecated as of version 1.0.6, because this method is a little obscure and redundant anyway.
setUp() - Method in class org.nfunk.jeptesting.BugsTest
 
setUp() - Method in class org.nfunk.jeptesting.JEPTest
Sets up the parser.
setUpArrow(Shape) - Method in class org.jfree.chart.axis.ValueAxis
Sets the shape that can be displayed as an arrow pointing upwards at the end of an axis line and sends an AxisChangeEvent to all registered listeners.
setUpPaint(Paint) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Sets the paint used to fill candles when the price moves up from open to close and sends a RendererChangeEvent to all registered listeners.
setUpper(double) - Method in class jhplot.math.num.pdf.Uniform
Modify the upper bound parameter.
setUpperBound(double) - Method in class org.jfree.chart.axis.ValueAxis
Sets the upper bound for the axis range, and sends an AxisChangeEvent to all registered listeners.
setUpperBound(double) - Method in class org.jfree.chart.plot.dial.StandardDialRange
Sets the upper bound of the dial range and sends a DialLayerChangeEvent to all registered listeners.
setUpperBound(double) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Sets the upper bound for the scale and sends a DialLayerChangeEvent to all registered listeners.
setUpperBound(double) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the upper bound for the thermometer.
setUpperLimit(int, double) - Method in class org.freehep.math.minuit.MnUserParameters
 
setUpperLimit(String, double) - Method in class org.freehep.math.minuit.MnUserParameters
 
setUpperLimit(int, double) - Method in class org.freehep.math.minuit.MnUserParameterState
 
setUpperLimit(String, double) - Method in class org.freehep.math.minuit.MnUserParameterState
 
setUpperMargin(double) - Method in class org.jfree.chart.axis.CategoryAxis
Sets the upper margin for the axis and sends an AxisChangeEvent to all registered listeners.
setUpperMargin(double) - Method in class org.jfree.chart.axis.ValueAxis
Sets the upper margin for the axis (as a percentage of the axis range) and sends an AxisChangeEvent to all registered listeners.
setUpperValue(int) - Method in class org.jlab.groot.ui.RangeSlider
Sets the upper value in the range.
setURL(String) - Method in class org.jfree.chart.annotations.AbstractXYAnnotation
Sets the URL for the annotation.
setURLGenerator(XYURLGenerator) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Sets the URL generator for HTML image maps.
setURLGenerator(PieURLGenerator) - Method in class org.jfree.chart.plot.PiePlot
Sets the URL generator and sends a PlotChangeEvent to all registered listeners.
setURLGenerator(CategoryURLGenerator) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the URL generator for the plot and sends a PlotChangeEvent to all registered listeners.
setURLGenerator(XYURLGenerator) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Sets the URL generator.
setURLGenerator(XYURLGenerator) - Method in interface org.jfree.chart.renderer.PolarItemRenderer
Sets the URL generator for HTML image maps.
setURLGenerator(XYURLGenerator) - Method in class org.jfree.chart.renderer.xy.AbstractXYItemRenderer
Sets the URL generator for HTML image maps and sends a RendererChangeEvent to all registered listeners.
setURLGenerator(XYURLGenerator) - Method in interface org.jfree.chart.renderer.xy.XYItemRenderer
Sets the URL generator for HTML image maps.
setURLText(String) - Method in class org.jfree.chart.block.LabelBlock
Sets the URL text.
setURLText(String) - Method in class org.jfree.chart.entity.ChartEntity
Sets the URL text.
setURLText(String) - Method in class org.jfree.chart.LegendItem
Sets the URL text.
setURLText(String) - Method in class org.jfree.chart.title.LegendItemBlockContainer
Sets the URL text.
setURLText(String) - Method in class org.jfree.chart.title.TextTitle
Sets the URL text to the specified text and sends a TitleChangeEvent to all registered listeners.
setUseAnalyticalDerivatives(boolean) - Method in class org.freehep.math.minuit.MnApplication
By default if the function to be minimized implements FCNGradientBase then the analytical gradient provided by the function will be used.
setUseAxesRatio(boolean) - Method in class jplot.GraphSettings
Sets whether or not to use a fixed ratio between X- and Y-axes lengths.
setUseDataPosition(boolean) - Method in class jplot.GraphLabel
Allows the user to used the current x- and y-positions using the data coordinates, will use default positions otherwise
setUseFillPaint(boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the flag that controls whether the fill paint is used to fill shapes, and sends a RendererChangeEvent to all registered listeners.
setUseFillPaint(boolean) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Sets the flag that controls whether the fill paint is used to fill shapes, and sends a RendererChangeEvent to all registered listeners.
setUseFillPaint(boolean) - Method in class org.jfree.chart.renderer.DefaultPolarItemRenderer
Sets the flag that controls whether the fill paint is used to fill shapes, and sends a RendererChangeEvent to all registered listeners.
setUseFillPaint(boolean) - Method in class org.jfree.chart.renderer.xy.XYAreaRenderer
Sets the flag that controls whether or not the series fill paint is used to fill the area under the line and sends a RendererChangeEvent to all listeners.
setUseFillPaint(boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the flag that controls whether the fill paint is used to fill shapes, and sends a RendererChangeEvent to all registered listeners.
setUseFillPaint(boolean) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Sets the flag that controls whether the fill paint is used to fill shapes, and sends a RendererChangeEvent to all registered listeners.
setUseLegendPosition(boolean) - Method in class jplot.GraphSettings
Sets whether or not to set the legend position in X,Y coordinates as defined by the graph.
setUseLogScale(int, boolean) - Method in class jplot.GraphSettings
Sets true or false to plot on a log scale.
setUseNumberOfTics(int, boolean) - Method in class jplot.GraphSettings
Says whether the user fixes the number of tics for a specific axis.
setUseOutlinePaint(boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the flag that controls whether the outline paint is used for shape outlines, and sends a RendererChangeEvent to all registered listeners.
setUseOutlinePaint(boolean) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Sets the flag that controls whether the outline paint is used for shape outlines, and sends a RendererChangeEvent to all registered listeners.
setUseOutlinePaint(boolean) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Sets the flag that controls whether or not the renderer's outline paint is used to draw the candlestick outline, and sends a RendererChangeEvent to all registered listeners.
setUseOutlinePaint(boolean) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Sets the flag that controls whether the outline paint is used to draw shape outlines, and sends a RendererChangeEvent to all registered listeners.
setUseOutlinePaint(boolean) - Method in class org.jfree.chart.renderer.xy.XYShapeRenderer
Sets the flag that controls whether the outline paint is used for shape outlines, and sends a RendererChangeEvent to all registered listeners.
setUseOutlinePaintForWhiskers(boolean) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Sets the flag that, if true, causes the whiskers to be drawn using the series outline paint, and sends a RendererChangeEvent to all registered listeners.
setUsePosition(boolean) - Method in class jplot.GraphLabel
Allows the user to used the current x- and y-positions, will use default positions otherwise.
setUseSeriesOffset(boolean) - Method in class org.jfree.chart.renderer.category.LineAndShapeRenderer
Sets the flag that controls whether or not the x-position for each data item is offset within its category according to the series, and sends a RendererChangeEvent to all registered listeners.
setUseSeriesOffset(boolean) - Method in class org.jfree.chart.renderer.category.ScatterRenderer
Sets the flag that controls whether or not the x-position for each data item is offset within its category according to the series, and sends a RendererChangeEvent to all registered listeners.
setUseSubrangePaint(boolean) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the range colour change option.
setUseYInterval(boolean) - Method in class org.jfree.chart.renderer.xy.XYBarRenderer
Sets the flag that determines whether the y-interval from the dataset is used to calculate the length of each bar, and sends a RendererChangeEvent to all registered listeners.
setV(float[]) - Method in class hep.lcio.implementation.event.ITrackerHitPlane
 
setV(double, double, double) - Method in class hep.physics.vec.BasicHep3Vector
 
setV(double, double, double) - Method in class hephysics.vec.Hep3Vector
Set vector
setV3(double, double, double, double) - Method in class hep.physics.vec.BasicHepLorentzVector
 
setV3(double, Hep3Vector) - Method in class hep.physics.vec.BasicHepLorentzVector
 
setV3(Hep3Vector) - Method in class hephysics.vec.HepLorentzVector
Set 3-vector
setV3(double, double, double) - Method in class hephysics.vec.HepLorentzVector
Set 3-vector position or Px,Py,Pz
setVal(double) - Method in class jhplot.math.ValueErr
Set value
setValidEntries(int) - Method in class jhplot.H1D
Sets number of valid entries.
setValidEntries(int) - Method in class jhplot.H2D
Set in-range entries.
setValidEntries(int) - Method in class jhplot.HProf1D
Sets number of valid entries.
setValidEntries(int) - Method in class jhplot.HProf2D
Set in-range entries.
setValidValue(boolean) - Method in interface org.lsmp.djep.matrixJep.MatrixVariableI
makes the vaule valid.
setValidValue(boolean) - Method in class org.nfunk.jep.Variable
Sets whether the value of variable is valid.
setValue(double) - Method in class graph.IsoCurve
Set the value to contour
setValue(String, int) - Method in interface hep.lcio.event.LCParameters
Set integer value for the given key.
setValue(String, float) - Method in interface hep.lcio.event.LCParameters
Set float value for the given key.
setValue(String, String) - Method in interface hep.lcio.event.LCParameters
Set string value for the given key.
setValue(String, int) - Method in class hep.lcio.implementation.event.ILCParameters
 
setValue(String, float) - Method in class hep.lcio.implementation.event.ILCParameters
 
setValue(String, String) - Method in class hep.lcio.implementation.event.ILCParameters
 
setValue(int, double) - Method in class jhplot.stat.DataKeeper
Set a value at index
setValue(String, Object) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Sets the context (key, value) pair.
setValue(int, double) - Method in class org.freehep.math.minuit.MnApplication
 
setValue(String, double) - Method in class org.freehep.math.minuit.MnApplication
 
setValue(int, double) - Method in class org.freehep.math.minuit.MnUserParameters
Set the value of parameter.
setValue(String, double) - Method in class org.freehep.math.minuit.MnUserParameters
Set the value of parameter.
setValue(int, double) - Method in class org.freehep.math.minuit.MnUserParameterState
 
setValue(String, double) - Method in class org.freehep.math.minuit.MnUserParameterState
 
setValue(double) - Method in class org.jfree.chart.annotations.CategoryTextAnnotation
Sets the value and sends an AnnotationChangeEvent to all registered listeners.
setValue(double) - Method in class org.jfree.chart.plot.Crosshair
Sets the crosshair value and sends a property change event with the name 'value' to all registered listeners.
setValue(double) - Method in class org.jfree.chart.plot.JThermometer
Sets the value of the thermometer.
setValue(Number) - Method in class org.jfree.chart.plot.JThermometer
Sets the value of the thermometer.
setValue(double) - Method in class org.jfree.chart.plot.ValueMarker
Sets the value for the marker and sends a MarkerChangeEvent to all registered listeners.
setValue(Number, Comparable, Comparable) - Method in class org.jfree.data.category.DefaultCategoryDataset
Adds or updates a value in the table and sends a DatasetChangeEvent to all registered listeners.
setValue(double, Comparable, Comparable) - Method in class org.jfree.data.category.DefaultCategoryDataset
Adds or updates a value in the table and sends a DatasetChangeEvent to all registered listeners.
setValue(Number) - Method in class org.jfree.data.DefaultKeyedValue
Sets the value.
setValue(Comparable, double) - Method in class org.jfree.data.DefaultKeyedValues
Updates an existing value, or adds a new value to the collection.
setValue(Comparable, Number) - Method in class org.jfree.data.DefaultKeyedValues
Updates an existing value, or adds a new value to the collection.
setValue(Number, Comparable, Comparable) - Method in class org.jfree.data.DefaultKeyedValues2D
Adds or updates a value.
setValue(Comparable, Number) - Method in class org.jfree.data.general.DefaultKeyedValueDataset
Sets the value for the dataset and sends a DatasetChangeEvent to all registered listeners.
setValue(Comparable, Number) - Method in class org.jfree.data.general.DefaultPieDataset
Sets the data value for a key and sends a DatasetChangeEvent to all registered listeners.
setValue(Comparable, double) - Method in class org.jfree.data.general.DefaultPieDataset
Sets the data value for a key and sends a DatasetChangeEvent to all registered listeners.
setValue(Number) - Method in class org.jfree.data.general.DefaultValueDataset
Sets the value and sends a DatasetChangeEvent to all registered listeners.
setValue(Number, Comparable, Comparable) - Method in class org.jfree.data.general.WaferMapDataset
Sets a value in the dataset and updates min and max value entries.
setValue(Number) - Method in class org.jfree.data.time.TimePeriodValue
Sets the value for this data item.
setValue(Number) - Method in class org.jfree.data.time.TimeSeriesDataItem
Sets the value for this data item.
setValue(Number) - Method in class org.jfree.data.xml.ItemHandler
Sets the value.
setValue(int, double) - Method in class org.jlab.groot.data.DataVector
 
setValue(String) - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserItem
 
setValue(double) - Method in class org.jlab.groot.math.UserParameter
 
setValue(Number) - Method in class org.jlab.groot.tree.Branch
 
setValue(int) - Method in class org.jlab.groot.ui.RangeSlider
Sets the lower value in the range.
setValue(Object) - Method in class org.lsmp.djep.matrixJep.nodeTypes.ASTMConstant
 
setValue(Object) - Method in class org.nfunk.jep.ASTConstant
 
setValue(Object) - Method in class org.nfunk.jep.evaluation.CommandElement
 
setValue(Object) - Method in class org.nfunk.jep.Variable
Sets the value of the variable.
setValue(double) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
setValue(long) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
setValue(double) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat.Builder
required double value = 2;
setValue(long) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt.Builder
required sint64 value = 2;
setValue(int, double) - Method in class promc.io.PBufFile.Record.P0D.Builder
repeated double value = 2 [packed = true];
setValue(int, long) - Method in class promc.io.PBufFile.Record.P0I.Builder
repeated int64 value = 2 [packed = true];
setValue(int, double) - Method in class promc.io.PBufFile.Record.PND.Builder
repeated double value = 2 [packed = true];
setValue(int, int) - Method in class promc.io.PBufFile.Record.PNI.Builder
repeated int32 value = 2 [packed = true];
setValue(double) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
setValue(long) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
setValue(double) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
setValue(long) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
setValue(double) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat.Builder
required double value = 2;
setValue(long) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt.Builder
required sint64 value = 2;
setValue1(double) - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Sets the y-value for the start of the line and sends an AnnotationChangeEvent to all registered listeners.
setValue2(double) - Method in class org.jfree.chart.annotations.CategoryLineAnnotation
Sets the y-value for the end of the line and sends an AnnotationChangeEvent to all registered listeners.
setValueAnchor(RectangleAnchor) - Method in class org.jfree.chart.plot.dial.DialValueIndicator
Sets the value anchor and sends a DialLayerChangeEvent to all registered listeners.
setValueAt(Object, int, int) - Method in class org.jfree.data.time.TimeSeriesTableModel
Updates the time series.
setValueAt(Object, int, int) - Method in class org.jfree.data.xy.XYDatasetTableModel
Updates the XYDataset if allowed.
setValueFont(Font) - Method in class jplot3dp.ModelView
 
setValueFont(Font) - Method in class org.jfree.chart.plot.JThermometer
Sets the value font.
setValueFont(Font) - Method in class org.jfree.chart.plot.MeterPlot
Sets the font used to display the value label and sends a PlotChangeEvent to all registered listeners.
setValueFont(Font) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the font used to display the current value.
setValueFormat(DecimalFormat) - Method in class org.jfree.chart.plot.JThermometer
Sets the value format for the thermometer.
setValueFormat(NumberFormat) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the formatter for the value label and sends a PlotChangeEvent to all registered listeners.
setValueLocation(int) - Method in class org.jfree.chart.plot.JThermometer
Sets the location at which the temperature value is displayed.
setValueLocation(int) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the location at which the current value is displayed and sends a PlotChangeEvent to all registered listeners.
setValuePaint(Paint) - Method in class org.jfree.chart.plot.JThermometer
Sets the value paint.
setValuePaint(Paint) - Method in class org.jfree.chart.plot.MeterPlot
Sets the paint used to display the value label and sends a PlotChangeEvent to all registered listeners.
setValuePaint(Paint) - Method in class org.jfree.chart.plot.ThermometerPlot
Sets the paint used to display the current value and sends a PlotChangeEvent to all registered listeners.
setValues(String, int[]) - Method in interface hep.lcio.event.LCParameters
Set integer values for the given key.
setValues(String, float[]) - Method in interface hep.lcio.event.LCParameters
Set float values for the given key.
setValues(String, String[]) - Method in interface hep.lcio.event.LCParameters
Set string values for the given key.
setValues(String, int[]) - Method in class hep.lcio.implementation.event.ILCParameters
 
setValues(String, float[]) - Method in class hep.lcio.implementation.event.ILCParameters
 
setValues(String, String[]) - Method in class hep.lcio.implementation.event.ILCParameters
 
setValues(double[]) - Method in class jhplot.stat.DataKeeper
 
setValues() - Method in class jplot.panels.PanelAxes.AxesOptions
 
setValues() - Method in class jplot.panels.PanelAxes.BoxOptions
 
setValues() - Method in class jplot.panels.PanelAxes.GridOptions
 
setValues() - Method in class jplot.panels.PanelAxes
 
setValues(GraphSettings) - Method in class jplot.panels.PanelGrid
Return the current values
setValues() - Method in class jplot.panels.PanelLabel
Return the current values.
setValues() - Method in class jplot.panels.PanelLegend
 
setValues() - Method in class jplot.panels.PanelScaling
 
setValues() - Method in class jplot.PiperOptions
 
setValuesArray(SurfaceVertex[][]) - Method in class jplot3d.JSurface
Sets the new vertices array of surface.
setValuesFileURL(String) - Method in class org.apache.commons.math3.random.ValueServer
Sets the values file URL using a string URL representation.
setValuesFileURL(URL) - Method in class org.apache.commons.math3.random.ValueServer
Sets the the values file URL.
setVar(Variable) - Method in class org.lsmp.djep.matrixJep.nodeTypes.ASTMVarNode
 
setVar(Variable) - Method in class org.nfunk.jep.ASTVarNode
Sets the name of the variable.
setVariable(String, double) - Method in class jhplot.math.exp4j.Expression
 
setVariable(String, double) - Method in class jplot3dp.MathParser.MathParser
 
setVariables(String) - Method in class jhplot.FProxy
Set variable using commas
setVariables(Map<String, Double>) - Method in class jhplot.math.exp4j.Expression
 
setVarianceDirection(SemiVariance.Direction) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Sets the variance direction
setVarianceImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the variance.
setVarianceImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the variance.
setVarianceImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the variance.
setVarName(String) - Method in class org.nfunk.jep.evaluation.CommandElement
 
setVars(String) - Method in class promc.io.PBufFile.Record.FND.Builder
required string vars = 3;
setVarsBytes(ByteString) - Method in class promc.io.PBufFile.Record.FND.Builder
required string vars = 3;
setVarValue(int, MatrixValueI) - Method in class org.lsmp.djep.mrpe.MRpEval
Sets value of rpe variable.
setVarValue(int, double) - Method in class org.lsmp.djep.mrpe.MRpEval
Sets value of rpe variable.
setVarValue(String, Object) - Method in class org.nfunk.jep.JEP
Sets the value of a variable.
setVarValue(String, Object) - Method in class org.nfunk.jep.SymbolTable
Sets the value of variable with the given name.
setVectM(Vector3, double) - Method in class j4np.physics.LorentzVector
 
setVerbosity(int) - Method in class hep.lcio.util.ObjectComparator
 
setVerbosity(int) - Static method in class hep.lcio.util.SIODump
 
setVersion(int) - Method in class jhplot.io.HFileMap
Set file version.
setVersion(long) - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
setVersion(long) - Method in class promc.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
setVersion(long) - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
setVersion(long) - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription.Builder
required uint64 version = 1;
setVertex(double[]) - Method in class hep.lcio.implementation.event.IMCParticle
 
setVertexIsNotEndpointOfParent(boolean) - Method in class hep.lcio.implementation.event.IMCParticle
 
setVertical(boolean) - Method in class org.jlab.groot.graphics.GraphicsAxis
 
setVerticalAlignment(VerticalAlignment) - Method in class org.jfree.chart.title.Title
Sets the vertical alignment for the title, and notifies any registered listeners of the change.
setVerticalAxisTrace(boolean) - Method in class org.jfree.chart.ChartPanel
A flag that controls trace lines on the vertical axis.
setVerticalTickLabels(boolean) - Method in class org.jfree.chart.axis.ValueAxis
Sets the flag that controls whether the tick labels are displayed vertically (that is, rotated 90 degrees from horizontal).
setView(double, double, double, double) - Method in class org.jfree.chart.plot.dial.DialPlot
Sets the viewing rectangle, relative to the dial's framing rectangle, and sends a PlotChangeEvent to all registered listeners.
setVisible(boolean) - Method in class org.jfree.chart.axis.Axis
Sets a flag that controls whether or not the axis is visible and sends an AxisChangeEvent to all registered listeners.
setVisible(boolean) - Method in class org.jfree.chart.plot.Crosshair
Sets the flag that controls the visibility of the crosshair and sends a proerty change event (with the name 'visible') to all registered listeners.
setVisible(boolean) - Method in class org.jfree.chart.plot.dial.AbstractDialLayer
Sets the flag that determines whether or not this layer is drawn by the plot, and sends a DialLayerChangeEvent to all registered listeners.
setVisible(boolean) - Method in class org.jfree.chart.title.Title
Sets a flag that controls whether or not the title should be drawn, and sends a TitleChangeEvent to all registered listeners.
setVisibleSeriesArray(int[]) - Method in class org.jfree.chart.renderer.category.CategoryItemRendererState
Sets an array with the indices of the visible rows.
setVolumePaint(Paint) - Method in class org.jfree.chart.renderer.xy.CandlestickRenderer
Sets the paint used to fill the volume bars, and sends a RendererChangeEvent to all registered listeners.
setWallPaint(Paint) - Method in class org.jfree.chart.renderer.category.BarRenderer3D
Sets the paint used to hightlight the left and bottom walls in the plot background, and sends a RendererChangeEvent to all registered listeners.
setWallPaint(Paint) - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Sets the paint used to highlight the left and bottom walls in the plot background, and sends a RendererChangeEvent to all registered listeners.
setWallPaint(Paint) - Method in class org.jfree.chart.renderer.xy.XYLine3DRenderer
Sets the paint used to hightlight the left and bottom walls in the plot background and sends a RendererChangeEvent to all registered listeners.
setWallPaint(Paint) - Method in class org.jfree.chart.StandardChartTheme
Sets the wall paint for charts with a 3D effect.
setWebFilled(boolean) - Method in class org.jfree.chart.plot.SpiderWebPlot
Sets the webFilled flag and sends a PlotChangeEvent to all registered listeners.
setWeight(int) - Method in class cern.jet.random.sampling.WeightedRandomSampler
Not yet commented.
setWeight(double) - Method in class hep.lcio.implementation.event.ILCEvent
 
setWeight(float) - Method in class hep.lcio.implementation.event.ILCRelation
 
setWeight(int) - Method in class org.jfree.chart.plot.CategoryPlot
Sets the weight for the plot and sends a PlotChangeEvent to all registered listeners.
setWeight(int) - Method in class org.jfree.chart.plot.XYPlot
Sets the weight for the plot and sends a PlotChangeEvent to all registered listeners.
setWeight(double) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional double Weight = 14;
setWeight(int, float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float weight = 17 [packed = true];
setWeight(double) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
setWeight(double) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional double Weight = 14;
setWeight(int, long) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
setWeight(double) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
setWeight(double) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
setWeight(int, long) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated uint64 weight = 17 [packed = true];
setWeight(double) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double weight = 20;
setWhiskerWidth(double) - Method in class org.jfree.chart.renderer.category.BoxAndWhiskerRenderer
Sets the width of the whiskers as a fraction of the bar width and sends a RendererChangeEvent to all registered listeners.
setWhoAm(int) - Method in class jhplot.shapes.HShape
Set primitive type
setWholeFormat(NumberFormat) - Method in class org.apache.commons.math3.fraction.ProperBigFractionFormat
Modify the whole format.
setWholeFormat(NumberFormat) - Method in class org.apache.commons.math3.fraction.ProperFractionFormat
Modify the whole format.
setWidth(double) - Method in class org.jfree.chart.block.AbstractBlock
Sets the natural width of the block, if this is known in advance.
setWidth(float) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
setWidth(float) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
setWidth(float) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
setWidth(float) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData.Builder
optional float width = 4;
setWidthBin(double) - Method in class jplot.LinePars
Set the histogram bin width, in case of histogram
setWidthRadius(double) - Method in class org.jfree.chart.plot.dial.DialPointer.Pointer
Sets the width radius and sends a DialLayerChangeEvent to all registered listeners.
setWindowSize(int) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
WindowSize controls the number of values that contribute to the reported statistics.
setWindowSize(int) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
WindowSize controls the number of values that contribute to the reported statistics.
setWireframeType(boolean) - Method in class jplot3d.SurfaceModelCanvas
 
setWrapper(BlockContainer) - Method in class org.jfree.chart.title.LegendTitle
Sets the wrapper container for the legend.
setX(double) - Method in class graph.ParseFunction
Set the value of the independent variable X.
setX(double) - Method in class hephysics.vec.Hep3Vector
Set X component
setX(double) - Method in class hephysics.vec.HepLorentzVector
Set X position.
setX(double) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the x coordinate for the text anchor point (measured against the domain axis) and sends an AnnotationChangeEvent to all registered listeners.
setX(double) - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Set the x-coordinate for the item's location.
setX(float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X = 15;
setX(int, float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float X = 13 [packed = true];
setX(int, double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double x = 2 [packed = true];
setX(int, double) - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double x = 2 [packed = true];
setX(int, double) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double x = 2 [packed = true];
setX(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
setX(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 X = 13 [packed = true];
setX(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 X = 5 [packed = true];
setX1(float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X1 = 8;
setX1(double) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
setX1(float) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float X1 = 8;
setX1(double) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
setX1(double) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
setX1(int, float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X1 = 8;
setX1(double) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x1 = 5;
setX2(float) - Method in class proeic.io.ProMC.ProMCEvent.Event.Builder
optional float X2 = 9;
setX2(double) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
setX2(float) - Method in class promc.io.ProMC.ProMCEvent.Event.Builder
optional float X2 = 9;
setX2(double) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
setX2(double) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
setX2(int, float) - Method in class proreco.io.ProMC.ProMCEvent.Event.Builder
repeated float X2 = 9;
setX2(double) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.Builder
optional double x2 = 6;
setXColumn(int) - Method in class jplot.DataFile
Sets the index of the column used for the X-axis.
setXE1left(DoubleArrayList) - Method in class jhplot.P1D
Error on X left.Statistical error.
setXE1right(DoubleArrayList) - Method in class jhplot.P1D
Error on X.
setXE2left(DoubleArrayList) - Method in class jhplot.P1D
Set left second-level errors
setXE2right(DoubleArrayList) - Method in class jhplot.P1D
Set right second-level errors
setXlabel(String) - Method in class jplot3d.JSurfacePanel
 
setXlabel(String) - Method in interface jplot3d.SurfaceModel
 
setXlabel(String) - Method in class jplot3d.SurfaceModelCanvas
 
setXleft(int, double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xleft = 4 [packed = true];
setXMax(float) - Method in class jplot3d.SurfaceModelCanvas
 
setXMin(float) - Method in class jplot3d.SurfaceModelCanvas
 
setXOffset(double) - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Sets the x-offset and sends a RendererChangeEvent to all registered listeners.
setXOffset(double) - Method in class org.jfree.chart.renderer.xy.XYLine3DRenderer
Sets the x-offset and sends a RendererChangeEvent to all registered listeners.
setXORMode(Color) - Method in class org.jfree.chart.fx.FXGraphics2D
Not implemented - the method does nothing.
setXOuter(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 XOuter = 8 [packed = true];
setXPosition(TimePeriodAnchor) - Method in class org.jfree.data.time.ohlc.OHLCSeriesCollection
Sets the position within each time period that is used for the X values when the collection is used as an XYDataset, then sends a DatasetChangeEvent is sent to all registered listeners.
setXPosition(TimePeriodAnchor) - Method in class org.jfree.data.time.TimePeriodValuesCollection
Sets the position of the x axis within each time period.
setXPosition(TimePeriodAnchor) - Method in class org.jfree.data.time.TimeSeriesCollection
Sets the position within each time period that is used for the X values when the collection is used as an XYDataset, then sends a DatasetChangeEvent is sent to all registered listeners.
setXPosition(TimePeriodAnchor) - Method in class org.jfree.data.time.TimeTableXYDataset
Sets the position within each time period that is used for the X values, then sends a DatasetChangeEvent to all registered listeners.
setXRange(double) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Randomly varies the x origin by +/-dx.
setXright(int, double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xright = 5 [packed = true];
setXScaling(float) - Method in class jplot3d.Projector
Sets the scaling factor in x direction.
setXsysleft(int, double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysleft = 8 [packed = true];
setXsysright(int, double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double xsysright = 9 [packed = true];
setXval(DoubleArrayList) - Method in class jhplot.P1D
Set X values as array
setXValue(double[]) - Method in class org.jfree.chart.ClipPath
Deprecated.
Sets the xValue.
setXYBarPainter(XYBarPainter) - Method in class org.jfree.chart.StandardChartTheme
Sets the XY bar painter.
setXYZ(double, double, double) - Method in class j4np.physics.Vector3
 
setXYZT(double, double, double, double) - Method in class hephysics.particle.LParticle
Set x,y,z and time for a particle (vertex position)
setY(double) - Method in class graph.ParseFunction
Set the value of the independent variable Y.
setY(double) - Method in class hephysics.vec.Hep3Vector
Y component
setY(double) - Method in class hephysics.vec.HepLorentzVector
Set Y position.
setY(double) - Method in class org.jfree.chart.annotations.XYTextAnnotation
Sets the y coordinate for the text anchor point (measured against the range axis) and sends an AnnotationChangeEvent to all registered listeners.
setY(double) - Method in class org.jfree.chart.DrawableLegendItem
Deprecated.
Set the y-coordinate for the item's location.
setY(double) - Method in class org.jfree.data.xy.XYDataItem
Sets the y-value for this data item.
setY(Number) - Method in class org.jfree.data.xy.XYDataItem
Sets the y-value for this data item.
setY(int, float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Y = 14 [packed = true];
setY(int, double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double y = 3 [packed = true];
setY(int, double) - Method in class promc.io.PBufFile.Record.PXY.Builder
repeated double y = 3 [packed = true];
setY(int, double) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double y = 3 [packed = true];
setY(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
setY(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Y = 14 [packed = true];
setY(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Y = 6 [packed = true];
setYCut(double) - Method in class hep.physics.jet.AbstractJetFinder
Set the YCut value.
setYE1down(DoubleArrayList) - Method in class jhplot.P1D
Set statististical down error
setYE1upper(DoubleArrayList) - Method in class jhplot.P1D
Set statistical error on Y 91st level)
setYE2down(DoubleArrayList) - Method in class jhplot.P1D
Set second level down error on Y
setYE2upper(DoubleArrayList) - Method in class jhplot.P1D
Set second level upper error on Y
setYlabel(String) - Method in class jplot3d.JSurfacePanel
 
setYlabel(String) - Method in interface jplot3d.SurfaceModel
 
setYlabel(String) - Method in class jplot3d.SurfaceModelCanvas
 
setYlower(int, double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ylower = 7 [packed = true];
setYMax(float) - Method in class jplot3d.SurfaceModelCanvas
 
setYMin(float) - Method in class jplot3d.SurfaceModelCanvas
 
setYOffset(double) - Method in class org.jfree.chart.renderer.category.LineRenderer3D
Sets the y-offset and sends a RendererChangeEvent to all registered listeners.
setYOffset(double) - Method in class org.jfree.chart.renderer.xy.XYLine3DRenderer
Sets the y-offset and sends a RendererChangeEvent to all registered listeners.
setYOuter(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 YOuter = 9 [packed = true];
setYRange(double) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Randomly varies the y origin by +/-dy.
setYScaling(float) - Method in class jplot3d.Projector
Sets the scaling factor in y direction.
setYsyslower(int, double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysyslower = 11 [packed = true];
setYsysupper(int, double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double ysysupper = 10 [packed = true];
setYupper(int, double) - Method in class promc.io.PBufFile.Record.P1D.Builder
repeated double yupper = 6 [packed = true];
setYval(DoubleArrayList) - Method in class jhplot.P1D
Set Y values
setYValue(double[]) - Method in class org.jfree.chart.ClipPath
Deprecated.
Sets the yValue.
setZ(double) - Method in class graph.ParseFunction
Set the value of the independent variable Z.
setZ(double) - Method in class hephysics.vec.Hep3Vector
Set Z component
setZ(double) - Method in class hephysics.vec.HepLorentzVector
Set Z position.
setZ(int, float) - Method in class proeic.io.ProMC.ProMCEvent.Particles.Builder
repeated float Z = 15 [packed = true];
setZ(int, double) - Method in class promc.io.PBufFile.Record.PXYZ.Builder
repeated double z = 4 [packed = true];
setZ(int, int) - Method in class promc.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
setZ(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Particles.Builder
repeated sint32 Z = 15 [packed = true];
setZ(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 Z = 7 [packed = true];
setZ0(float) - Method in class hep.lcio.implementation.event.ITrack
 
setZ0(float) - Method in class hep.lcio.implementation.event.ITrackState
 
setZeroStrokeWidth(double) - Method in class org.jfree.chart.fx.FXGraphics2D
Sets the width to use for the stroke when the current AWT stroke has a width of 0.0.
setZlabel(String) - Method in class jplot3d.JSurfacePanel
 
setZlabel(String) - Method in interface jplot3d.SurfaceModel
 
setZlabel(String) - Method in class jplot3d.SurfaceModelCanvas
 
setZMax(float) - Method in class jplot3d.SurfaceModelCanvas
 
setZMin(float) - Method in class jplot3d.SurfaceModelCanvas
 
setZoomAroundAnchor(boolean) - Method in class org.jfree.chart.ChartPanel
Sets the flag that controls whether or not zoom operations are centered around the current anchor point.
setZoomFactor(double) - Method in class org.jfree.chart.fx.interaction.ScrollHandlerFX
Sets the zoom factor (a percentage amount by which the mouse wheel movement will change the chart size).
setZoomFillPaint(Paint) - Method in class org.jfree.chart.ChartPanel
Sets the zoom rectangle fill paint.
setZoomFillPaint(Paint) - Method in class org.jfree.chart.fx.ChartViewerSkin
Sets the fill paint for the zoom rectangle.
setZoomInFactor(double) - Method in class org.jfree.chart.ChartPanel
Sets the zoom in factor.
setZoomOutFactor(double) - Method in class org.jfree.chart.ChartPanel
Sets the zoom out factor.
setZoomOutlinePaint(Paint) - Method in class org.jfree.chart.ChartPanel
Sets the zoom rectangle outline paint.
setZoomRectangleVisible(boolean) - Method in class org.jfree.chart.fx.ChartViewerSkin
Sets the visibility of the zoom rectangle.
setZoomTriggerDistance(int) - Method in class org.jfree.chart.ChartPanel
Sets the zoom trigger distance.
setZOuter(int, int) - Method in class proreco.io.ProMC.ProMCEvent.Tracks.Builder
repeated sint32 ZOuter = 10 [packed = true];
setZRange(double) - Method in class hep.physics.event.generator.diagnostic.DiagnosticEventGenerator
Randomly varies the z origin by +/-dz.
setZRange(float, float) - Method in class jplot3d.Projector
 
setZScaling(float) - Method in class jplot3d.Projector
Sets the scaling factor in z direction.
setZValue(int, int, double) - Method in class org.jfree.data.general.DefaultHeatMapDataset
Updates a z-value in the dataset and sends a DatasetChangeEvent to all registered listeners.
setZValue(int, int, double, boolean) - Method in class org.jfree.data.general.DefaultHeatMapDataset
Updates a z-value in the dataset and, if requested, sends a DatasetChangeEvent to all registered listeners.
ShadowGenerator - Interface in org.jfree.chart.util
An interface that defines the API for a shadow generator.
shape(AbstractMatrix1D) - Static method in class cern.colt.matrix.impl.AbstractFormatter
Returns a short string representation describing the shape of the matrix.
shape(AbstractMatrix2D) - Static method in class cern.colt.matrix.impl.AbstractFormatter
Returns a short string representation describing the shape of the matrix.
shape(AbstractMatrix3D) - Static method in class cern.colt.matrix.impl.AbstractFormatter
Returns a short string representation describing the shape of the matrix.
SHAPES - Static variable in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Constant for the type of rendering (shapes only).
SHAPES - Static variable in class org.jfree.chart.renderer.xy.XYAreaRenderer
Useful constant for specifying the type of rendering (shapes only).
SHAPES - Static variable in class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Useful constant for specifying the type of rendering (shapes only).
SHAPES_AND_LINES - Static variable in class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Constant for the type of rendering (shapes and lines).
SHAPES_AND_LINES - Static variable in class org.jfree.chart.renderer.xy.XYAreaRenderer
Useful constant for specifying the type of rendering (shapes and lines).
shear(double, double) - Method in class org.jfree.chart.fx.FXGraphics2D
Applies a shear transformation.
shift(double) - Method in class jhplot.H1D
Shift all bins by some value
shift(double) - Method in class jhplot.HProf1D
Shift all bins by some value
shift(double[], double) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
Compute the coefficients of the polynomial \(P_s(x)\) whose values at point x will be the same as the those from the original polynomial \(P(x)\) when computed at x + shift.
shift() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Shift one step forward.
shift(Range, double) - Static method in class org.jfree.data.Range
Shifts the range by the specified amount.
shift(Range, double, boolean) - Static method in class org.jfree.data.Range
Shifts the range by the specified amount.
shiftLeft - Static variable in class cern.jet.math.IntFunctions
Function that returns a << b.
shiftLeft(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a << b.
shiftRightSigned - Static variable in class cern.jet.math.IntFunctions
Function that returns a >> b.
shiftRightSigned(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a >> b.
shiftRightUnsigned - Static variable in class cern.jet.math.IntFunctions
Function that returns a >>> b.
shiftRightUnsigned(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a >>> b.
ShipNeedle - Class in org.jfree.chart.needle
A needle in the shape of a ship, for use with the CompassPlot class.
ShipNeedle() - Constructor for class org.jfree.chart.needle.ShipNeedle
 
SHisto - Class in jhplot.utils
This class represents a histogram operation class.
SHisto(int[], double[], double[]) - Constructor for class jhplot.utils.SHisto
Constructor.
SHisto(int[], double[], double[], int) - Constructor for class jhplot.utils.SHisto
Constructor.
SHisto(int, double, double, int) - Constructor for class jhplot.utils.SHisto
Constructor.
ShortArrayList - Class in cern.colt.list
Resizable list holding short elements; implemented with arrays.
ShortArrayList() - Constructor for class cern.colt.list.ShortArrayList
Constructs an empty list.
ShortArrayList(short[]) - Constructor for class cern.colt.list.ShortArrayList
Constructs a list containing the specified elements.
ShortArrayList(int) - Constructor for class cern.colt.list.ShortArrayList
Constructs an empty list with the specified initial capacity.
shortAsUnsigned(short) - Static method in class net.jafama.NumbersUtils
 
ShortComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
ShortProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
ShortTextTitle - Class in org.jfree.chart.title
A text title that is only displayed if the entire text will be visible without line wrapping.
ShortTextTitle(String) - Constructor for class org.jfree.chart.title.ShortTextTitle
Creates a new title.
shortValue() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation performs casting to a short.
show() - Static method in class j4np.physics.PDGDatabase
 
show(H1D) - Method in class jhplot.HTable
Show a H1D histogram.
show(F1D) - Method in class jhplot.HTable
Show a function
show(P0D) - Method in class jhplot.HTable
show P0D data
show(P1D) - Method in class jhplot.HTable
Show P1D data
show(P2D) - Method in class jhplot.HTable
show P2D data
show(P3D) - Method in class jhplot.HTable
show P3D data
Show() - Method in class jminhep.clcontrol.SummaryPad
 
show(Vector) - Method in class jplot.GraphGeneral
Draws the graph on the graphics canvas of this panel.
show(String) - Method in class jplot.JPlot
Refreshes the actual graph with new data.
show(Frame, int, int) - Method in class jplot.LabelProperties
Pops up a modal frame including the font panel.
show(int, int) - Method in class jplot.panels.PanelAxes
 
show(Frame, Color, int, int) - Method in class jplot.panels.PanelColor
Pops up a modal frame including the color panel.
show(Frame, int, int) - Method in class jplot.panels.PanelGrid
Return a modal JDialog.
show(Frame, int, int) - Method in class jplot.panels.PanelLabel
Return a modal JDialog.
show(Frame, int, int) - Method in class jplot.panels.PanelLegend
Return a modal JDialog.
show(Frame, int, int) - Method in class jplot.panels.PanelSave
Return a modal JDialog.
show(Frame, int, int) - Method in class jplot.PiperOptions
Return a modal JDialog.
show(int, int, File) - Method in class jplot.SimpleEditor
Pops up a frame with the report printed in it.
show(int, int, String) - Method in class jplot.SimpleEditor
Pops up a frame with the report printed in it.
show(int, int, LinePars) - Method in class jplot.StyleChooser
Return a modal JDialog with a customized linestyle chooser.
show() - Method in class org.jlab.groot.graphics.GraphicsAxis
prints string representation of the axis.
show() - Method in class org.jlab.groot.io.ArgumentParser.ArgumentParserCommand
 
show() - Method in class org.jlab.groot.io.ArgumentParser
 
show() - Method in class org.jlab.groot.io.TextFileReader
 
show() - Method in class org.jlab.groot.math.Func1D
 
show() - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
show() - Method in class org.jlab.groot.tree.Tree
 
show() - Method in class org.jlab.groot.ui.GraphicsAxis
prints string representation of the axis.
SHOW_BAD - Static variable in class org.lsmp.djepJUnit.GroupJepTest
 
SHOW_BAD - Static variable in class org.lsmp.djepJUnit.JepTest
 
SHOW_BAD - Static variable in class org.lsmp.djepJUnit.MRpTest
 
SHOW_BAD - Static variable in class org.lsmp.djepJUnit.RewriteTest
 
SHOW_BAD - Static variable in class org.lsmp.djepJUnit.RpTest
 
SHOW_BAD - Static variable in class org.lsmp.djepJUnit.SJepTest
 
showAllGraph(boolean) - Method in class jhplot.HPlot
Set the all graphs visible or not
showAttributes() - Method in class jminhep.cluster.DataPoint
Print all attributes of a data point
showAxis() - Method in class org.jlab.groot.base.AxisAttributes
 
showAxis() - Method in class org.jlab.groot.ui.GraphicsAxisFrame
 
showBorder(boolean) - Method in class jhplot.gui.GHMargin
Show or not the blue borders during editing.
showBorderNoUpdate(boolean) - Method in class jhplot.gui.GHMargin
Show or not the blue borders during editing.
showBorders(boolean) - Method in class jhplot.gui.GHPanel
Show borders of margins for edditing
ShowCenters - Static variable in class jminhep.clcontrol.Global
 
showCenters(String, DataHolder) - Method in class jminhep.gui.Plotter
Add series
ShowColors - Class in jhplot.utils
 
ShowColors() - Constructor for class jhplot.utils.ShowColors
 
showDialog(Frame, String, Font) - Static method in class jhepsim.FontChooser
Method used to show the font chooser, and select a new font.
showDialog(Frame, Font) - Static method in class jhepsim.FontChooser
Shows the font chooser with a standard title ("Font Chooser").
showDialog(Frame, String, Font) - Static method in class jminhep.gui.FontChooser
Method used to show the font chooser, and select a new font.
showDialog(Frame, Font) - Static method in class jminhep.gui.FontChooser
Shows the font chooser with a standard title ("Font Chooser").
ShowFonts - Class in jhplot.utils
A font selection dialog.
ShowFonts() - Constructor for class jhplot.utils.ShowFonts
Construct a FontChooser -- Sets title and gets array of fonts on the system.
showFPS(boolean) - Method in class org.jlab.groot.graphics.EmbeddedCanvas
 
showGraph(boolean) - Method in class jhplot.HPlot
Set the current graph visible or not
showGraph(boolean, boolean) - Method in class jplot.JPlot
Displays the graph in a separate frame.
showGraph(boolean) - Method in class jplot.JPlot
Display the graph in a separate frame.
showGraph() - Method in class jplot.JPlot
Display the graph in a separate frame.
showIt() - Method in class fitter.Fitter
 
showIt() - Method in class fitter.SEditor
 
showIt(Frame, int, int) - Method in class jplot.panels.PanelScaling
Return a modal JDialog.
showMessage(String) - Static method in class jhplot.JHPlot
Show a text on status bar permanently.
showMouse(String, double, double, double, double, int, int) - Static method in class jhplot.JHPlot
Show mouse positions
showOutput(String) - Method in class fitter.Fitter
Show output in jehep or prompt
showPlot() - Method in class jminhep.gui.Plotter
 
showPreview() - Method in class org.jlab.groot.ui.CutPanel
 
ShowProbab - Static variable in class jminhep.clcontrol.Global
 
ShowSeeds - Static variable in class jminhep.clcontrol.Global
 
showSeeds(String, DataHolder) - Method in class jminhep.gui.Plotter
Add series
showStatusBarText(String) - Static method in class jhplot.JHPlot
Show a text on status bar for 5 sec.
showZoomRectangle(double, double, double, double) - Method in class org.jfree.chart.fx.ChartViewer
Sets the size and location of the zoom rectangle and makes it visible if it wasn't already visible.
showZoomRectangle(double, double, double, double) - Method in class org.jfree.chart.fx.ChartViewerSkin
Sets the location and size of the zoom rectangle and makes it visible if it is not already visible.
SHPlot - Class in jhplot
A class to create a 2D canvas with several plots.
SHPlot3D - Class in jhplot
A class to create a 3D canvas to display H2D and F2D objects.
shrink(String) - Static method in class jplot.Translate
It returns a string shrinked in size Replace ant character &..; by "w".
shrink(Rectangle2D, Rectangle2D) - Method in class org.jfree.chart.axis.AxisSpace
Shrinks an area by the space attributes.
shuffle() - Method in class cern.colt.list.AbstractList
Randomly permutes the receiver.
shuffle(int[], int, MathArrays.Position) - Static method in class org.apache.commons.math3.util.MathArrays
Shuffle the entries of the given array.
shuffle(int[], int, MathArrays.Position, RandomGenerator) - Static method in class org.apache.commons.math3.util.MathArrays
Shuffle the entries of the given array, using the Fisher–Yates algorithm.
shuffle(int[], RandomGenerator) - Static method in class org.apache.commons.math3.util.MathArrays
Shuffle the entries of the given array.
shuffle(int[]) - Static method in class org.apache.commons.math3.util.MathArrays
Shuffle the entries of the given array.
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractBooleanList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractByteList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractCharList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractDoubleList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractFloatList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractIntList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractList
Randomly permutes the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractLongList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractShortList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.ByteArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.CharArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.DoubleArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.FloatArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.IntArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.LongArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.ShortArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
ShuntingYard - Class in jhplot.math.exp4j.shuntingyard
Shunting yard implementation to convert infix to reverse polish notation
ShuntingYard() - Constructor for class jhplot.math.exp4j.shuntingyard.ShuntingYard
 
si - Variable in class Jampack.Rot
The imaginary part of the sine of the rotation
side(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Deprecated.
side(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Deprecated.
side(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Deprecated.
as of 3.6, this method which was only intended for internal use is not used anymore
Side - Enum in org.apache.commons.math3.geometry.partitioning
Enumerate representing the location of an element with respect to an hyperplane of a space.
side(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
side(Arc) - Method in class org.apache.commons.math3.geometry.spherical.oned.ArcsSet
Deprecated.
Sigma(double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer.Sigma
 
Sigma(double[]) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer.Sigma
Deprecated.
 
Sigmoid - Class in org.apache.commons.math3.analysis.function
Sigmoid function.
Sigmoid() - Constructor for class org.apache.commons.math3.analysis.function.Sigmoid
Usual sigmoid function, where the lower asymptote is 0 and the higher asymptote is 1.
Sigmoid(double, double) - Constructor for class org.apache.commons.math3.analysis.function.Sigmoid
Sigmoid function.
Sigmoid.Parametric - Class in org.apache.commons.math3.analysis.function
Parametric function where the input array contains the parameters of the sigmoid function, ordered as follows: Lower asymptote Higher asymptote
sign - Static variable in class cern.jet.math.Functions
Function that returns a < 0 ? -1 : a > 0 ? 1 : 0.
sign - Static variable in class cern.jet.math.IntFunctions
Function that returns a < 0 ? -1 : a > 0 ? 1 : 0.
sign(double) - Method in class jhplot.math.ValueErr
Sign function
SIGN - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
signFromBit(float) - Static method in class net.jafama.FastMath
 
signFromBit(double) - Static method in class net.jafama.FastMath
 
signFromBit(float) - Static method in class net.jafama.NumbersUtils
 
signFromBit(double) - Static method in class net.jafama.NumbersUtils
 
signFromBit(float) - Static method in class net.jafama.StrictFastMath
 
signFromBit(double) - Static method in class net.jafama.StrictFastMath
 
signum(float) - Static method in class net.jafama.FastMath
 
signum(double) - Static method in class net.jafama.FastMath
 
signum(int) - Static method in class net.jafama.NumbersUtils
 
signum(long) - Static method in class net.jafama.NumbersUtils
 
signum(float) - Static method in class net.jafama.StrictFastMath
 
signum(double) - Static method in class net.jafama.StrictFastMath
 
signum() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute the signum of the instance.
signum() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute the signum of the instance.
Signum - Class in org.apache.commons.math3.analysis.function
signum function.
Signum() - Constructor for class org.apache.commons.math3.analysis.function.Signum
 
signum() - Method in class org.apache.commons.math3.dfp.Dfp
Compute the signum of the instance.
signum() - Method in interface org.apache.commons.math3.RealFieldElement
Compute the signum of the instance.
signum() - Method in class org.apache.commons.math3.util.Decimal64
Compute the signum of the instance.
signum(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the signum of a number.
signum(float) - Static method in class org.apache.commons.math3.util.FastMath
Compute the signum of a number.
SILENT - Static variable in class hep.lcio.util.ObjectComparator
 
SIMCALORIMETERHIT - Static variable in interface hep.lcio.event.LCIO
 
SimCalorimeterHit - Interface in hep.lcio.event
The generic simulated calorimeter hit.
SimJob - Class in hep.lcio.example
 
SimJob() - Constructor for class hep.lcio.example.SimJob
 
SimpleBounds - Class in org.apache.commons.math3.optim
Simple optimization constraints: lower and upper bounds.
SimpleBounds(double[], double[]) - Constructor for class org.apache.commons.math3.optim.SimpleBounds
 
SimpleBounds - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
SimpleBounds(double[], double[]) - Constructor for class org.apache.commons.math3.optimization.SimpleBounds
Deprecated.
 
SimpleCharStream - Class in jplot3dp.MathParser
An implementation of interface CharStream, where the stream is assumed to contain only ASCII characters (without unicode processing).
SimpleCharStream(Reader, int, int, int) - Constructor for class jplot3dp.MathParser.SimpleCharStream
 
SimpleCharStream(Reader, int, int) - Constructor for class jplot3dp.MathParser.SimpleCharStream
 
SimpleCharStream(Reader) - Constructor for class jplot3dp.MathParser.SimpleCharStream
 
SimpleCharStream(InputStream, int, int, int) - Constructor for class jplot3dp.MathParser.SimpleCharStream
 
SimpleCharStream(InputStream, int, int) - Constructor for class jplot3dp.MathParser.SimpleCharStream
 
SimpleCharStream(InputStream) - Constructor for class jplot3dp.MathParser.SimpleCharStream
 
SimpleCurveFitter - Class in org.apache.commons.math3.fitting
Fits points to a user-defined function.
SimpleEditor - Class in jplot
The class shows a frame which enables to look at and eventually edit a file, any type of file.
SimpleEditor(JPanel, String, boolean, int, int) - Constructor for class jplot.SimpleEditor
Principal constructor, builds the panel which includes the report as text.
SimpleEditor(JPanel, String, boolean) - Constructor for class jplot.SimpleEditor
Constructor, builds a simple editor/viewer with default dimensions.
SimpleHistogramBin - Class in org.jfree.data.statistics
A bin for the SimpleHistogramDataset.
SimpleHistogramBin(double, double) - Constructor for class org.jfree.data.statistics.SimpleHistogramBin
Creates a new bin.
SimpleHistogramBin(double, double, boolean, boolean) - Constructor for class org.jfree.data.statistics.SimpleHistogramBin
Creates a new bin.
SimpleHistogramDataset - Class in org.jfree.data.statistics
A dataset used for creating simple histograms with custom defined bins.
SimpleHistogramDataset(Comparable) - Constructor for class org.jfree.data.statistics.SimpleHistogramDataset
Creates a new histogram dataset.
SimpleLongArrayList - Class in cern.colt.list
Resizable list holding long elements; implemented with arrays; not efficient; just to demonstrate which methods you must override to implement a fully functional list.
SimpleLongArrayList() - Constructor for class cern.colt.list.SimpleLongArrayList
Constructs an empty list.
SimpleLongArrayList(long[]) - Constructor for class cern.colt.list.SimpleLongArrayList
Constructs a list containing the specified elements.
SimpleLongArrayList(int) - Constructor for class cern.colt.list.SimpleLongArrayList
Constructs an empty list with the specified initial capacity.
SimpleMD5 - Class in jhplot.security
 
SimpleMD5() - Constructor for class jhplot.security.SimpleMD5
 
SimpleNode - Class in org.nfunk.jep
 
SimpleNode(int) - Constructor for class org.nfunk.jep.SimpleNode
 
SimpleNode(Parser, int) - Constructor for class org.nfunk.jep.SimpleNode
 
SimplePathVisitor - Class in org.apache.commons.io.file
A SimpleFileVisitor typed to a Path.
SimplePointChecker<PAIR extends Pair<double[],? extends Object>> - Class in org.apache.commons.math3.optim
Simple implementation of the ConvergenceChecker interface using only point coordinates.
SimplePointChecker(double, double) - Constructor for class org.apache.commons.math3.optim.SimplePointChecker
Build an instance with specified thresholds.
SimplePointChecker(double, double, int) - Constructor for class org.apache.commons.math3.optim.SimplePointChecker
Builds an instance with specified thresholds.
SimplePointChecker<PAIR extends Pair<double[],? extends Object>> - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
SimplePointChecker() - Constructor for class org.apache.commons.math3.optimization.SimplePointChecker
SimplePointChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.SimplePointChecker
Deprecated.
Build an instance with specified thresholds.
SimplePointChecker(double, double, int) - Constructor for class org.apache.commons.math3.optimization.SimplePointChecker
Deprecated.
Builds an instance with specified thresholds.
SimpleRegression - Class in org.apache.commons.math3.stat.regression
Estimates an ordinary least squares regression model with one independent variable.
SimpleRegression() - Constructor for class org.apache.commons.math3.stat.regression.SimpleRegression
Create an empty SimpleRegression instance
SimpleRegression(boolean) - Constructor for class org.apache.commons.math3.stat.regression.SimpleRegression
Create a SimpleRegression instance, specifying whether or not to estimate an intercept.
SimpleTest - Class in org.nfunk.jepexamples
A seven line program for testing whether the JEP library can be found by the compiler and at run-time.
Upon successful compilation and running of the program, the program should print out one line: "1+2 = 3.0"
SimpleTest() - Constructor for class org.nfunk.jepexamples.SimpleTest
 
SimpleTimePeriod - Class in org.jfree.data.time
An arbitrary period of time, measured to millisecond precision using java.util.Date.
SimpleTimePeriod(long, long) - Constructor for class org.jfree.data.time.SimpleTimePeriod
Creates a new time allocation.
SimpleTimePeriod(Date, Date) - Constructor for class org.jfree.data.time.SimpleTimePeriod
Creates a new time allocation.
SimpleUnivariateValueChecker - Class in org.apache.commons.math3.optim.univariate
Simple implementation of the ConvergenceChecker interface that uses only objective function values.
SimpleUnivariateValueChecker(double, double) - Constructor for class org.apache.commons.math3.optim.univariate.SimpleUnivariateValueChecker
Build an instance with specified thresholds.
SimpleUnivariateValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optim.univariate.SimpleUnivariateValueChecker
Builds an instance with specified thresholds.
SimpleUnivariateValueChecker - Class in org.apache.commons.math3.optimization.univariate
Deprecated.
As of 3.1 (to be removed in 4.0).
SimpleUnivariateValueChecker() - Constructor for class org.apache.commons.math3.optimization.univariate.SimpleUnivariateValueChecker
SimpleUnivariateValueChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.univariate.SimpleUnivariateValueChecker
Deprecated.
Build an instance with specified thresholds.
SimpleUnivariateValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optimization.univariate.SimpleUnivariateValueChecker
Deprecated.
Builds an instance with specified thresholds.
SimpleValueChecker - Class in org.apache.commons.math3.optim
Simple implementation of the ConvergenceChecker interface using only objective function values.
SimpleValueChecker(double, double) - Constructor for class org.apache.commons.math3.optim.SimpleValueChecker
Build an instance with specified thresholds.
SimpleValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optim.SimpleValueChecker
Builds an instance with specified thresholds.
SimpleValueChecker - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
SimpleValueChecker() - Constructor for class org.apache.commons.math3.optimization.SimpleValueChecker
SimpleValueChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.SimpleValueChecker
Deprecated.
Build an instance with specified thresholds.
SimpleValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optimization.SimpleValueChecker
Deprecated.
Builds an instance with specified thresholds.
SimpleVectorValueChecker - Class in org.apache.commons.math3.optim
Simple implementation of the ConvergenceChecker interface using only objective function values.
SimpleVectorValueChecker(double, double) - Constructor for class org.apache.commons.math3.optim.SimpleVectorValueChecker
Build an instance with specified thresholds.
SimpleVectorValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optim.SimpleVectorValueChecker
Builds an instance with specified tolerance thresholds and iteration count.
SimpleVectorValueChecker - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
SimpleVectorValueChecker() - Constructor for class org.apache.commons.math3.optimization.SimpleVectorValueChecker
SimpleVectorValueChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.SimpleVectorValueChecker
Deprecated.
Build an instance with specified thresholds.
SimpleVectorValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optimization.SimpleVectorValueChecker
Deprecated.
Builds an instance with specified tolerance thresholds and iteration count.
SimplexOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
This class implements simplex-based direct search optimization.
SimplexOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.SimplexOptimizer
 
SimplexOptimizer(double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.SimplexOptimizer
 
SimplexOptimizer - Class in org.apache.commons.math3.optimization.direct
Deprecated.
As of 3.1 (to be removed in 4.0).
SimplexOptimizer() - Constructor for class org.apache.commons.math3.optimization.direct.SimplexOptimizer
SimplexOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.SimplexOptimizer
Deprecated.
 
SimplexOptimizer(double, double) - Constructor for class org.apache.commons.math3.optimization.direct.SimplexOptimizer
Deprecated.
 
SimplexSolver - Class in org.apache.commons.math3.optim.linear
Solves a linear problem using the "Two-Phase Simplex" method.
SimplexSolver() - Constructor for class org.apache.commons.math3.optim.linear.SimplexSolver
Builds a simplex solver with default settings.
SimplexSolver(double) - Constructor for class org.apache.commons.math3.optim.linear.SimplexSolver
Builds a simplex solver with a specified accepted amount of error.
SimplexSolver(double, int) - Constructor for class org.apache.commons.math3.optim.linear.SimplexSolver
Builds a simplex solver with a specified accepted amount of error.
SimplexSolver(double, int, double) - Constructor for class org.apache.commons.math3.optim.linear.SimplexSolver
Builds a simplex solver with a specified accepted amount of error.
SimplexSolver - Class in org.apache.commons.math3.optimization.linear
Deprecated.
As of 3.1 (to be removed in 4.0).
SimplexSolver() - Constructor for class org.apache.commons.math3.optimization.linear.SimplexSolver
Deprecated.
Build a simplex solver with default settings.
SimplexSolver(double, int) - Constructor for class org.apache.commons.math3.optimization.linear.SimplexSolver
Deprecated.
Build a simplex solver with a specified accepted amount of error
SimplificationVisitor - Class in org.lsmp.djep.xjep
Simplifies an expression.
SimplificationVisitor() - Constructor for class org.lsmp.djep.xjep.SimplificationVisitor
 
simplify() - Method in class jhplot.F1D
Try to simplify this function.
simplify() - Method in class jhplot.F2D
Try to simplify this function.
simplify() - Method in class jhplot.FND
Treat the function as complex.
simplify(Node) - Method in class org.lsmp.djep.sjep.PolynomialCreator
Simplifies an expression.
simplify(Node, XJep) - Method in class org.lsmp.djep.xjep.SimplificationVisitor
must be implemented for subclasses.
simplify(Node) - Method in class org.lsmp.djep.xjep.XJep
Returns a simplification of an expression tree.
simplifyAdd(Node, Node) - Method in class org.lsmp.djep.xjep.SimplificationVisitor
Simplifies an addition.
simplifyBuiltOperatorNode(Operator, Node, Node) - Method in class org.lsmp.djep.xjep.SimplificationVisitor
First create a new node and then simplify it.
simplifyDivide(Node, Node) - Method in class org.lsmp.djep.xjep.SimplificationVisitor
Simplifies a division.
simplifyMultiply(Node, Node) - Method in class org.lsmp.djep.xjep.SimplificationVisitor
Simplifies a multiplication.
simplifyOp(ASTFunNode, Node[]) - Method in class org.lsmp.djep.xjep.SimplificationVisitor
simplifies operators, does not descend into children
simplifyPower(Node, Node) - Method in class org.lsmp.djep.xjep.SimplificationVisitor
Simplify a power.
simplifySubtract(Node, Node) - Method in class org.lsmp.djep.xjep.SimplificationVisitor
Simplifies a subtraction.
simplifyTest(String, String) - Method in class org.lsmp.djepJUnit.MRpTest
 
simplifyTest(String, String) - Method in class org.lsmp.djepJUnit.SJepTest
 
simplifyTest(String, String) - Method in class org.lsmp.djepJUnit.XJepTest
 
simplifyTestString(String, String) - Method in class org.lsmp.djepJUnit.MRpTest
 
simplifyTestString(String, String) - Method in class org.lsmp.djepJUnit.SJepTest
 
simplifyTestString(String, String) - Method in class org.lsmp.djepJUnit.XJepTest
 
simplifyTripple(XOperator, Node, Node) - Method in class org.lsmp.djep.xjep.SimplificationVisitor
Simplifies expressions like 2+(3+x) or (2+x)+3
simpson(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using Simpson's rule.
Simpson - Class in org.lsmp.djep.xjep.function
The Simpson rule for approximation to a definite integral.
Simpson() - Constructor for class org.lsmp.djep.xjep.function.Simpson
 
SIMPSON_MAX_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
Maximal number of iterations for Simpson.
SimpsonIntegrator - Class in org.apache.commons.math3.analysis.integration
Implements Simpson's Rule for integration of real univariate functions.
SimpsonIntegrator(double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
Build a Simpson integrator with given accuracies and iterations counts.
SimpsonIntegrator(int, int) - Constructor for class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
Build a Simpson integrator with given iteration counts.
SimpsonIntegrator() - Constructor for class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
Construct an integrator with default settings.
SimpsonsIntegrator - Class in jhplot.math.num.integration
The extended Simpson's rule for numerically integrating functions.
SimpsonsIntegrator(Function) - Constructor for class jhplot.math.num.integration.SimpsonsIntegrator
Create an integrator for the given function.
SimpsonsIntegrator(Function, int, double) - Constructor for class jhplot.math.num.integration.SimpsonsIntegrator
Create an integrator for the given function.
SIMTRACKERHIT - Static variable in interface hep.lcio.event.LCIO
 
SimTrackerHit - Interface in hep.lcio.event
A generic simulated tracker hit.
sin - Static variable in class cern.jet.math.Functions
Function that returns Math.sin(a).
sin() - Method in class jhplot.math.Complex
Sine of this Complex number (doesn't change this Complex number).
sin(ValueErr) - Method in class jhplot.math.ValueErr
sine of an ValueErr number (trigonometric function)
SIN - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
sin(double) - Static method in class net.jafama.FastMath
 
sin(double) - Static method in class net.jafama.StrictFastMath
 
sin() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Sine operation.
sin(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute sine of a derivative structure.
sin() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Sine operation.
Sin - Class in org.apache.commons.math3.analysis.function
Sine function.
Sin() - Constructor for class org.apache.commons.math3.analysis.function.Sin
 
sin() - Method in class org.apache.commons.math3.complex.Complex
Compute the sine of this complex number.
sin() - Method in class org.apache.commons.math3.dfp.Dfp
Sine operation.
sin(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the sine of the argument.
sin() - Method in interface org.apache.commons.math3.RealFieldElement
Sine operation.
sin() - Method in class org.apache.commons.math3.util.Decimal64
Sine operation.
sin(double) - Static method in class org.apache.commons.math3.util.FastMath
Sine function.
sin(Object) - Method in class org.nfunk.jep.function.Sine
 
sin() - Method in class org.nfunk.jep.type.Complex
Returns the sine of this complex number.
sinAndCos(double, DoubleWrapper) - Static method in class net.jafama.FastMath
Computes sine and cosine together.
sinAndCos(double, DoubleWrapper) - Static method in class net.jafama.StrictFastMath
Computes sine and cosine together.
Sinc - Class in org.apache.commons.math3.analysis.function
Sinc function, defined by
Sinc() - Constructor for class org.apache.commons.math3.analysis.function.Sinc
The sinc function, sin(x) / x.
Sinc(boolean) - Constructor for class org.apache.commons.math3.analysis.function.Sinc
Instantiates the sinc function.
Sine - Class in org.nfunk.jep.function
 
Sine() - Constructor for class org.nfunk.jep.function.Sine
 
SineH - Class in org.nfunk.jep.function
 
SineH() - Constructor for class org.nfunk.jep.function.SineH
 
singleStep(FirstOrderFieldDifferentialEquations<T>, T, T[], T) - Method in class org.apache.commons.math3.ode.nonstiff.RungeKuttaFieldIntegrator
Fast computation of a single step of ODE integration.
singleStep(FirstOrderDifferentialEquations, double, double[], double) - Method in class org.apache.commons.math3.ode.nonstiff.RungeKuttaIntegrator
Fast computation of a single step of ODE integration.
singular(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
SingularMatrixException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a non-singular matrix is expected.
SingularMatrixException() - Constructor for exception org.apache.commons.math3.linear.SingularMatrixException
Construct an exception.
SingularOperatorException - Exception in org.apache.commons.math3.linear
Exception to be thrown when trying to invert a singular operator.
SingularOperatorException() - Constructor for exception org.apache.commons.math3.linear.SingularOperatorException
Creates a new instance of this class.
SingularValueDecomposition - Class in cern.colt.matrix.linalg
For an m x n matrix A with m >= n, the singular value decomposition is an m x n orthogonal matrix U, an n x n diagonal matrix S, and an n x n orthogonal matrix V so that A = U*S*V'.
SingularValueDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.linalg.SingularValueDecomposition
Constructs and returns a new singular value decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
SingularValueDecomposition - Class in Jama
Singular Value Decomposition.
SingularValueDecomposition(Matrix) - Constructor for class Jama.SingularValueDecomposition
Construct the singular value decomposition Structure to access U, S and V.
SingularValueDecomposition - Class in jhplot.math
Singular Value Decomposition.
SingularValueDecomposition(double[][]) - Constructor for class jhplot.math.SingularValueDecomposition
Construct the singular value decomposition
SingularValueDecomposition - Class in org.apache.commons.math3.linear
Calculates the compact Singular Value Decomposition of a matrix.
SingularValueDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.SingularValueDecomposition
Calculates the compact Singular Value Decomposition of the given matrix.
sinh(double) - Static method in class graph.SpecialFunction
 
sinh() - Method in class jhplot.math.Complex
Hyperbolic sine of this Complex number (doesn't change this Complex number).
sinh(double) - Static method in class jhplot.math.num.special.Trigonometric
Returns the hyperbolic sine of x.
sinh(ValueErr) - Method in class jhplot.math.ValueErr
Hyperbolic sine of a value with error
SINH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
sinh(double) - Static method in class net.jafama.FastMath
Some properties of sinh(x) = (exp(x)-exp(-x))/2: 1) defined on ]-Infinity,+Infinity[ 2) result in ]-Infinity,+Infinity[ 3) sinh(x) = -sinh(-x) (implies sinh(0) = 0) 4) sinh(epsilon) ~= epsilon 5) lim(sinh(x),x->+Infinity) = +Infinity (y increasing exponentially faster than x) 6) reaches +Infinity (double overflow) for x >= 710.475860073944, i.e.
sinh(double) - Static method in class net.jafama.StrictFastMath
Some properties of sinh(x) = (exp(x)-exp(-x))/2: 1) defined on ]-Infinity,+Infinity[ 2) result in ]-Infinity,+Infinity[ 3) sinh(x) = -sinh(-x) (implies sinh(0) = 0) 4) sinh(epsilon) ~= epsilon 5) lim(sinh(x),x->+Infinity) = +Infinity (y increasing exponentially faster than x) 6) reaches +Infinity (double overflow) for x >= 710.475860073944, i.e.
sinh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Hyperbolic sine operation.
sinh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute hyperbolic sine of a derivative structure.
sinh() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Hyperbolic sine operation.
Sinh - Class in org.apache.commons.math3.analysis.function
Hyperbolic sine function.
Sinh() - Constructor for class org.apache.commons.math3.analysis.function.Sinh
 
sinh() - Method in class org.apache.commons.math3.complex.Complex
Compute the hyperbolic sine of this complex number.
sinh() - Method in class org.apache.commons.math3.dfp.Dfp
Hyperbolic sine operation.
sinh() - Method in interface org.apache.commons.math3.RealFieldElement
Hyperbolic sine operation.
sinh() - Method in class org.apache.commons.math3.util.Decimal64
Hyperbolic sine operation.
sinh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the hyperbolic sine of a number.
sinh(Object) - Method in class org.nfunk.jep.function.SineH
 
sinh() - Method in class org.nfunk.jep.type.Complex
 
sinhAndCosh(double, DoubleWrapper) - Static method in class net.jafama.FastMath
Computes hyperbolic sine and hyperbolic cosine together.
sinhAndCosh(double, DoubleWrapper) - Static method in class net.jafama.StrictFastMath
Computes hyperbolic sine and hyperbolic cosine together.
sinPhi() - Method in class hep.physics.vec.SpacePoint
sin(phi)
sinPhi() - Method in class hephysics.vec.SpacePoint
sin(phi)
sinQuick(double) - Static method in class net.jafama.FastMath
Quick sin, with accuracy of about 1.6e-3 (PI/) for |angle| < 6588395.0 (Integer.MAX_VALUE * (2*PI/) - 2) (- 2 due to removing PI/2 before using cosine tab), and no accuracy at all for larger values.
sinQuick(double) - Static method in class net.jafama.StrictFastMath
Quick sin, with accuracy of about 1.6e-3 (PI/) for |angle| < 6588395.0 (Integer.MAX_VALUE * (2*PI/) - 2) (- 2 due to removing PI/2 before using cosine tab), and no accuracy at all for larger values.
sinTheta() - Method in class hep.physics.vec.SpacePoint
sin(theta)
sinTheta() - Method in class hephysics.vec.SpacePoint
sin(theta)
SIODump - Class in hep.lcio.example
Small programm that dumps the structure and contents of an (LCIO) SIO file to the screen.
SIODump() - Constructor for class hep.lcio.example.SIODump
 
SIODump - Class in hep.lcio.util
A utility for making ASCII dumps of LCIO files.
SIODump() - Constructor for class hep.lcio.util.SIODump
 
SIODump.Resolver - Class in hep.lcio.util
 
SIODumpCommandHandler - Class in hep.lcio.util
Command-line handling for Tony's SIODump utility.
SIODumpCommandHandler() - Constructor for class hep.lcio.util.SIODumpCommandHandler
 
SIOFactory - Class in hep.lcio.implementation.sio
 
SIOFactory() - Constructor for class hep.lcio.implementation.sio.SIOFactory
 
SIOTrackerPulse - Class in hep.lcio.implementation.sio
 
SIOTrackerPulse(SIOInputStream, int, SIOEvent, int, int) - Constructor for class hep.lcio.implementation.sio.SIOTrackerPulse
 
SIOVersion - Class in hep.lcio.implementation.sio
Simple helper class to encode/decode the LCIO version number.
SIOVersion() - Constructor for class hep.lcio.implementation.sio.SIOVersion
 
size() - Method in class cern.colt.bitvector.BitMatrix
Returns the size of the receiver which is columns()*rows().
size() - Method in class cern.colt.bitvector.BitVector
Returns the size of the receiver.
size() - Method in class cern.colt.list.AbstractBooleanList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractByteList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractCharList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractCollection
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractDoubleList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractFloatList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractIntList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractLongList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractShortList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.adapter.DoubleListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.adapter.FloatListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.adapter.IntListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.adapter.LongListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.adapter.ObjectListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.ObjectArrayList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.map.AbstractMap
Returns the number of (key,value) associations currently contained.
size() - Method in class cern.colt.matrix.impl.AbstractMatrix
Returns the number of cells.
size() - Method in class cern.colt.matrix.impl.AbstractMatrix1D
Returns the number of cells.
size() - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Returns the number of cells which is rows()*columns().
size() - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Returns the number of cells which is slices()*rows()*columns().
size() - Method in class cern.hep.aida.bin.AbstractBin
Returns the number of elements contained.
size - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.size().
size() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the number of elements contained in the receiver.
size() - Method in class cern.hep.aida.bin.StaticBin1D
Returns the number of elements contained in the receiver.
size() - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Returns the number of elements currently contained in the receiver (identical to the number of values added so far).
size() - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Deprecated.
Deprecated. Returns the number of bin boundaries.
size() - Method in class jhplot.io.EFile
Get the number of events stored in the file.
size() - Method in class jhplot.io.PFile
Get number of objects stored in the file.
size() - Method in class jhplot.math.io.LEDataOutputStream
 
size() - Method in class jhplot.P1D
Return the length of the data vector.
size() - Method in class jhplot.P2D
Return the length of the data vector.
size() - Method in class jhplot.P3D
Return the length of the data vector.
size() - Method in class jhplot.PND
Data size (number of rows)
size() - Method in class jhplot.PNI
Data size (number of rows)
size() - Method in class jhplot.VHolder
Return the size of the data, i.e.
size() - Method in class jplot.DataArray
Return the length of the data vector.
size() - Method in class jplot.DataArray2D
Return the length of the data vector.
size() - Method in class jplot.DataArray3D
Return the length of the data vector.
size() - Method in class jplot3dp.ModelView.FunctionsList
 
size() - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
Returns the current size of the byte array.
size() - Method in class org.apache.commons.io.output.ByteArrayOutputStream
 
size() - Method in class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
 
size() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Deprecated.
Get the number of elements of the tree.
size() - Method in class org.apache.commons.math3.util.IntegerSequence.Range
Gets the number of elements contained in the range.
size() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Get the number of elements stored in the map.
size() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Get the number of elements stored in the map.
size() - Method in class org.jfree.chart.axis.TickUnits
Returns the number of tick units in this collection.
size() - Method in class org.jlab.groot.data.DataVector
 
Size - Class in org.lsmp.djep.vectorJep.function
Returns the size of an Scaler, Vector or Matrix.
Size() - Constructor for class org.lsmp.djep.vectorJep.function.Size
 
SIZE_COMPARATOR - Static variable in class org.apache.commons.io.comparator.SizeFileComparator
Size comparator instance - directories are treated as zero size
SIZE_REVERSE - Static variable in class org.apache.commons.io.comparator.SizeFileComparator
Reverse size comparator instance - directories are treated as zero size
SIZE_SUMDIR_COMPARATOR - Static variable in class org.apache.commons.io.comparator.SizeFileComparator
Size comparator instance which sums the size of a directory's contents using FileUtils.sizeOfDirectory(File)
SIZE_SUMDIR_REVERSE - Static variable in class org.apache.commons.io.comparator.SizeFileComparator
Reverse size comparator instance which sums the size of a directory's contents using FileUtils.sizeOfDirectory(File)
SizeB - Static variable in class jminhep.gui.SetEnv
 
SizeCommandHandler - Class in hep.lcio.util
A utility for printing the size in bytes of SIO collections.
SizeCommandHandler() - Constructor for class hep.lcio.util.SizeCommandHandler
 
sizeData() - Method in class jhplot.HPlot
The data size, i.e.
SizeData - Static variable in class jminhep.clcontrol.Global
 
sizeData() - Method in class jplot.JPlot
 
SizeFileComparator - Class in org.apache.commons.io.comparator
Compare the length/size of two files for order (see File.length() and FileUtils.sizeOfDirectory(File)).
SizeFileComparator() - Constructor for class org.apache.commons.io.comparator.SizeFileComparator
Construct a file size comparator instance (directories treated as zero size).
SizeFileComparator(boolean) - Constructor for class org.apache.commons.io.comparator.SizeFileComparator
Construct a file size comparator instance specifying whether the size of the directory contents should be aggregated.
sizeFileFilter(long) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that returns true if the file is bigger than a certain size.
sizeFileFilter(long, boolean) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that filters based on file size.
SizeFileFilter - Class in org.apache.commons.io.filefilter
Filters files based on size, can filter either smaller files or files equal to or larger than a given threshold.
SizeFileFilter(long) - Constructor for class org.apache.commons.io.filefilter.SizeFileFilter
Constructs a new size file filter for files equal to or larger than a certain size.
SizeFileFilter(long, boolean) - Constructor for class org.apache.commons.io.filefilter.SizeFileFilter
Constructs a new size file filter for files based on a certain size threshold.
SizeFrame(int, int) - Static method in class jminhep.gui.SetEnv
 
sizeOf(File) - Static method in class org.apache.commons.io.FileUtils
Returns the size of the specified file or directory.
sizeOfAsBigInteger(File) - Static method in class org.apache.commons.io.FileUtils
Returns the size of the specified file or directory.
sizeOfDirectory(File) - Static method in class org.apache.commons.io.FileUtils
Counts the size of a directory recursively (sum of the length of all files).
sizeOfDirectoryAsBigInteger(File) - Static method in class org.apache.commons.io.FileUtils
Counts the size of a directory recursively (sum of the length of all files).
sizeOfRange(double, double) - Method in class cern.hep.aida.bin.QuantileBin1D
Returns how many elements are contained in the range [minElement,maxElement].
sizeRangeFileFilter(long, long) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that accepts files whose size is >= minimum size and <= maximum size.
SizeX - Static variable in class jminhep.gui.SetEnv
 
SizeY - Static variable in class jminhep.gui.SetEnv
 
SJepConsole - Class in org.lsmp.djepExamples
 
SJepConsole() - Constructor for class org.lsmp.djepExamples.SJepConsole
 
SJepTest - Class in org.lsmp.djepJUnit
 
SJepTest(String) - Constructor for class org.lsmp.djepJUnit.SJepTest
 
skeepZero(String[]) - Static method in class jplot.Utils
remove .0 stuff and remove 10^{1}
skew() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the skew, which is moment(3,mean()) / standardDeviation()3.
skew(double, double) - Static method in class cern.jet.stat.Descriptive
Returns the skew of a data sequence.
skew(DoubleArrayList, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the skew of a data sequence, which is moment(data,3,mean) / standardDeviation3.
skew() - Method in class jhplot.P0D
Returns the skew, which is moment(3,mean()) / standardDeviation() Run getStat(0 for evaluation
skew() - Method in class jhplot.P0I
Returns the skew, which is moment(3,mean()) / standardDeviation() Run getStat(0 for evaluation
Skewness - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the skewness of the available values.
Skewness() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Skewness
Constructs a Skewness
Skewness(ThirdMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Skewness
Constructs a Skewness with an external moment
Skewness(Skewness) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Skewness
Copy constructor, creates a new Skewness identical to the original
skip(long) - Method in class org.apache.commons.io.input.BOMInputStream
Invokes the delegate's skip(long) method, detecting and optionally skipping BOM.
skip(long) - Method in class org.apache.commons.io.input.BoundedInputStream
Invokes the delegate's skip(long) method.
skip(long) - Method in class org.apache.commons.io.input.BrokenInputStream
Throws the configured exception.
skip(long) - Method in class org.apache.commons.io.input.BrokenReader
Throws the configured exception.
skip(long) - Method in class org.apache.commons.io.input.CharSequenceInputStream
 
skip(long) - Method in class org.apache.commons.io.input.CharSequenceReader
Skip the specified number of characters.
skip(long) - Method in class org.apache.commons.io.input.CountingInputStream
Skips the stream over the specified number of bytes, adding the skipped amount to the count.
skip(long) - Method in class org.apache.commons.io.input.NullInputStream
Skip a specified number of bytes.
skip(long) - Method in class org.apache.commons.io.input.NullReader
Skips a specified number of characters.
skip(long) - Method in class org.apache.commons.io.input.ProxyInputStream
Invokes the delegate's skip(long) method.
skip(long) - Method in class org.apache.commons.io.input.ProxyReader
Invokes the delegate's skip(long) method.
skip(long) - Method in class org.apache.commons.io.input.RandomAccessFileInputStream
 
skip(long) - Method in class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
 
skip(InputStream, long) - Static method in class org.apache.commons.io.IOUtils
Skips bytes from an input byte stream.
skip(ReadableByteChannel, long) - Static method in class org.apache.commons.io.IOUtils
Skips bytes from a ReadableByteChannel.
skip(Reader, long) - Static method in class org.apache.commons.io.IOUtils
Skips characters from an input character stream.
skipBytes(int) - Method in class jhplot.math.io.LEDataInputStream
 
skipBytes(int) - Method in class jhplot.math.io.LERandomAccessFile
 
skipBytes(int) - Method in class org.apache.commons.io.input.SwappedDataInputStream
Invokes the delegate's skip(int) method.
skipFully(InputStream, long) - Static method in class org.apache.commons.io.IOUtils
Skips the requested number of bytes or fail if there are not enough left.
skipFully(ReadableByteChannel, long) - Static method in class org.apache.commons.io.IOUtils
Skips the requested number of bytes or fail if there are not enough left.
skipFully(Reader, long) - Static method in class org.apache.commons.io.IOUtils
Skips the requested number of characters or fail if there are not enough left.
skipNEvents(int) - Method in interface hep.lcio.io.LCReader
Skips the next n events from the current position.
skipTo(int) - Method in class org.apache.commons.math3.random.HaltonSequenceGenerator
Skip to the i-th point in the Halton sequence.
skipTo(int) - Method in class org.apache.commons.math3.random.SobolSequenceGenerator
Skip to the i-th point in the Sobol sequence.
skp(HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Useful: for x1*x2+y1*y2+z1*z2
slice(int, int, int[], int[]) - Method in class org.jlab.groot.matrix.SparseVectorGrid
 
slices() - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Returns the number of slices.
sliceX(int) - Method in interface colt.hep.aida.IHistogram2D
Slice parallel to the Y axis at bin indexY and one bin wide.
sliceX(int, int) - Method in interface colt.hep.aida.IHistogram2D
Create a slice parallel to the axis X axis, between "indexY1" and "indexY2" (inclusive).
sliceX(int) - Method in class org.jlab.groot.data.H2F
Creates a 1-D Histogram slice of the specified y Bin
sliceXY(int) - Method in interface colt.hep.aida.IHistogram3D
Create a slice parallel to the XY plane at bin indexZ and one bin wide.
sliceXY(int, int) - Method in interface colt.hep.aida.IHistogram3D
Create a slice parallel to the XY plane, between "indexZ1" and "indexZ2" (inclusive).
sliceXZ(int) - Method in interface colt.hep.aida.IHistogram3D
Create a slice parallel to the XZ plane at bin indexY and one bin wide.
sliceXZ(int, int) - Method in interface colt.hep.aida.IHistogram3D
Create a slice parallel to the XZ plane, between "indexY1" and "indexY2" (inclusive).
sliceY(int) - Method in interface colt.hep.aida.IHistogram2D
Slice parallel to the X axis at bin indexX and one bin wide.
sliceY(int, int) - Method in interface colt.hep.aida.IHistogram2D
Create a slice parallel to the axis Y axis, between "indexX1" and "indexX2" (inclusive) The returned IHistogram1D represents an instantaneous snapshot of the histogram at the time the slice was created.
sliceY(int) - Method in class org.jlab.groot.data.H2F
Creates a 1-D Histogram slice of the specified x Bin
sliceYZ(int) - Method in interface colt.hep.aida.IHistogram3D
Create a slice parallel to the YZ plane at bin indexX and one bin wide.
sliceYZ(int, int) - Method in interface colt.hep.aida.IHistogram3D
Create a slice parallel to the YZ plane, between "indexX1" and "indexX2" (inclusive).
Slicing - Class in jhplot.math
BSD License
Slicing(double[][], int[], String) - Constructor for class jhplot.math.Slicing
Construct a Slice from a matrix and an orthogonal slicing.
Slicing(double[][], double[][]) - Constructor for class jhplot.math.Slicing
Construct a Slice from a matrix and an orthogonal slicing.
Slicing(double[][], double[][], double[][]) - Constructor for class jhplot.math.Slicing
Construct a Slice from a matrix and an orthogonal slicing.
Slicing(double[][], int[][]) - Constructor for class jhplot.math.Slicing
Construct a Slice from a matrix and an orthogonal slicing.
slideColor() - Method in class jplot.LinePars
 
SlidingCategoryDataset - Class in org.jfree.data.category
A CategoryDataset implementation that presents a subset of the categories in an underlying dataset.
SlidingCategoryDataset(CategoryDataset, int, int) - Constructor for class org.jfree.data.category.SlidingCategoryDataset
Creates a new instance.
SlidingGanttCategoryDataset - Class in org.jfree.data.gantt
A GanttCategoryDataset implementation that presents a subset of the categories in an underlying dataset.
SlidingGanttCategoryDataset(GanttCategoryDataset, int, int) - Constructor for class org.jfree.data.gantt.SlidingGanttCategoryDataset
Creates a new instance.
SMALL_LOG_VALUE - Static variable in class org.jfree.chart.axis.LogarithmicAxis
Smallest arbitrarily-close-to-zero value allowed.
SMALL_NUMBER - Variable in class org.jlab.groot.math.Dimension1D
 
SmallButton - Class in jplot
Class small button displays a button in the new 'window' style, i.e., you only see the button in raised or lowered state if you are on it with the mouse.
SmallButton(Action, String) - Constructor for class jplot.SmallButton
Principal constructor, builds the button with a specific action and a tool tip.
SmallColorPreview - Class in jplot
 
SmallColorPreview(Color, int, int) - Constructor for class jplot.SmallColorPreview
 
SmallScrollPane - Class in jplot
This panel builds a list and returns it wrapped in a minimized scroll pane panel.
SmallScrollPane(Object[], boolean) - Constructor for class jplot.SmallScrollPane
Constructor.
SmallScrollPane(Object[]) - Constructor for class jplot.SmallScrollPane
Constructor.
SmallToggleButton - Class in jplot
Class small button displays a toggle button in the new 'window' style, i.e., pressed lesses the button in a 'lowered' state, else it remains raised.
SmallToggleButton(boolean, ImageIcon, ImageIcon, String) - Constructor for class jplot.SmallToggleButton
Principal constructor, builds the button with a specific action and a tool tip.
smooth(double[], double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Compute a weighted loess fit on the data at the original abscissae.
smooth(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Compute a loess fit on the data at the original abscissae.
SmoothedDataHistogram - Class in org.apache.commons.math3.ml.neuralnet.twod.util
Visualization of high-dimensional data projection on a 2D-map.
SmoothedDataHistogram(int, DistanceMeasure) - Constructor for class org.apache.commons.math3.ml.neuralnet.twod.util.SmoothedDataHistogram
 
SmoothingPolynomialBicubicSplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Deprecated.
To be removed in 4.0 (see MATH-1166).
SmoothingPolynomialBicubicSplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
Deprecated.
Default constructor.
SmoothingPolynomialBicubicSplineInterpolator(int) - Constructor for class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
Deprecated.
 
SmoothingPolynomialBicubicSplineInterpolator(int, int) - Constructor for class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
Deprecated.
 
SmpBlas - Class in cern.colt.matrix.linalg
Parallel implementation of the Basic Linear Algebra System for symmetric multi processing boxes.
smpBlas - Static variable in class cern.colt.matrix.linalg.SmpBlas
The public global parallel blas; initialized via SmpBlas.allocateBlas(int, cern.colt.matrix.linalg.Blas).
SNAN - Static variable in class org.apache.commons.math3.dfp.Dfp
Indicator value for signaling NaN.
SobolSequenceGenerator - Class in org.apache.commons.math3.random
Implementation of a Sobol sequence.
SobolSequenceGenerator(int) - Constructor for class org.apache.commons.math3.random.SobolSequenceGenerator
Construct a new Sobol sequence generator for the given space dimension.
SobolSequenceGenerator(int, InputStream) - Constructor for class org.apache.commons.math3.random.SobolSequenceGenerator
Construct a new Sobol sequence generator for the given space dimension with direction vectors loaded from the given stream.
softmax(int, double[]) - Static method in class jhplot.math.ArrayMathUtils
produces a double between 0 and 1 based on the given array x and the index that must be between (0 and x.length) For further information see also: http://www-ccs.ucsd.edu/matlab/toolbox/nnet/softmax.html
SOLARFLUX - Static variable in class graph.SpecialFunction
Solar Flux.
SOLARLUM - Static variable in class graph.SpecialFunction
Solar Luminosity.
SOLARMASS - Static variable in class graph.SpecialFunction
Solar Mass.
SOLARRADIUS - Static variable in class graph.SpecialFunction
Solar Radius.
SolutionCallback - Class in org.apache.commons.math3.optim.linear
A callback object that can be provided to a linear optimizer to keep track of the best solution found.
SolutionCallback() - Constructor for class org.apache.commons.math3.optim.linear.SolutionCallback
 
solve(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Solves A*X = B.
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.CholeskyDecomposition
Solves A*X = B; returns X.
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.LUDecomposition
Solves A*X = B.
solve(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Solves the system of equations A*X = B (in-place).
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Solves the system of equations A*X = B (in-place).
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.QRDecomposition
Least squares solution of A*X = B; returns X.
solve(Matrix) - Method in class Jama.CholeskyDecomposition
Solve A*X = B
solve(Matrix) - Method in class Jama.LUDecomposition
Solve A*X = B
solve(Matrix) - Method in class Jama.Matrix
Solve A*X = B
solve(Matrix) - Method in class Jama.QRDecomposition
Least squares solution of A*X = B
Solve - Class in Jampack
Solve solves linear systems of the form
Solve() - Constructor for class Jampack.Solve
 
solve(double[][]) - Method in class jhplot.math.CholeskyDecomposition
Solve A*X = B
solve(Matrix) - Method in class jhplot.math.kalman.jama.LUDecomposition
Solve A*X = B
solve(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Solve A*X = B
solve(Matrix) - Method in class jhplot.math.kalman.jama.QRDecomposition
Least squares solution of A*X = B
solve(double[][], double[][]) - Static method in class jhplot.math.LinearAlgebra
 
solve(double[][]) - Method in class jhplot.math.LUDecomposition
Solve A*X = B
solve(double[][]) - Method in class jhplot.math.QRDecomposition
Least squares solution of A*X = B
solve(int, FUNC, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Solve for a zero in the given interval, start at startValue.
solve(int, FUNC, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Solve for a zero root in the given interval.
solve(int, FUNC, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Solve for a zero in the vicinity of startValue.
solve(int, UnivariateFunction, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
Solve for a zero in the given interval.
solve(int, UnivariateFunction, double, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
Solve for a zero in the given interval, start at startValue.
solve(int, UnivariateFunction, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
Solve for a zero in the given interval, start at startValue.
solve(int, FUNC, double, double) - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Solve for a zero root in the given interval.
solve(int, FUNC, double, double, double) - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Solve for a zero in the given interval, start at startValue.
solve(int, FUNC, double) - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Solve for a zero in the vicinity of startValue.
solve(int, RealFieldUnivariateFunction<T>, T, T, AllowedSolution) - Method in interface org.apache.commons.math3.analysis.solvers.BracketedRealFieldUnivariateSolver
Solve for a zero in the given interval.
solve(int, RealFieldUnivariateFunction<T>, T, T, T, AllowedSolution) - Method in interface org.apache.commons.math3.analysis.solvers.BracketedRealFieldUnivariateSolver
Solve for a zero in the given interval, start at startValue.
solve(int, FUNC, double, double, AllowedSolution) - Method in interface org.apache.commons.math3.analysis.solvers.BracketedUnivariateSolver
Solve for a zero in the given interval.
solve(int, FUNC, double, double, double, AllowedSolution) - Method in interface org.apache.commons.math3.analysis.solvers.BracketedUnivariateSolver
Solve for a zero in the given interval, start at startValue.
solve(int, UnivariateFunction, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Solve for a zero in the given interval.
solve(int, UnivariateFunction, double, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Solve for a zero in the given interval, start at startValue.
solve(int, RealFieldUnivariateFunction<T>, T, T, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.FieldBracketingNthOrderBrentSolver
Solve for a zero in the given interval.
solve(int, RealFieldUnivariateFunction<T>, T, T, T, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.FieldBracketingNthOrderBrentSolver
Solve for a zero in the given interval, start at startValue.
solve(int, UnivariateDifferentiableFunction, double, double) - Method in class org.apache.commons.math3.analysis.solvers.NewtonRaphsonSolver
Find a zero near the midpoint of min and max.
solve(int, DifferentiableUnivariateFunction, double, double) - Method in class org.apache.commons.math3.analysis.solvers.NewtonSolver
Deprecated.
Find a zero near the midpoint of min and max.
solve(UnivariateFunction, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Convenience method to find a zero of a univariate real function.
solve(UnivariateFunction, double, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Convenience method to find a zero of a univariate real function.
solve(int, UnivariateDfpFunction, Dfp, Dfp, AllowedSolution) - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Deprecated.
Solve for a zero in the given interval.
solve(int, UnivariateDfpFunction, Dfp, Dfp, Dfp, AllowedSolution) - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Deprecated.
Solve for a zero in the given interval, start at startValue.
solve(RealVector) - Method in interface org.apache.commons.math3.linear.DecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(RealMatrix) - Method in interface org.apache.commons.math3.linear.DecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealLinearOperator, RealVector, boolean, double) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system (A - shift · I) · x = b.
solve(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealVector, boolean, double) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns the solution to the system (A - shift · I) · x = b.
solve(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system A · x = b.
Solve - Class in org.lsmp.djep.jama
z = solve(x,y) solves x*z = y where x,y,z are real matricies.
Solve() - Constructor for class org.lsmp.djep.jama.Solve
 
solveAllComplex(double[], double) - Method in class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Find all complex roots for the polynomial with the given coefficients, starting from the given initial value.
solveAllComplex(double[], double, int) - Method in class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Find all complex roots for the polynomial with the given coefficients, starting from the given initial value.
solveComplex(double[], double) - Method in class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Find a complex root for the polynomial with the given coefficients, starting from the given initial value.
solveComplex(double[], double, int) - Method in class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Find a complex root for the polynomial with the given coefficients, starting from the given initial value.
solveCubic(double, double, double, double) - Static method in class jhplot.math.Numeric
Calculates the roots of the cubic equation, a must be different from 0 (or use quadratic equation solver).
solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.ConjugateGradient
Returns an estimate of the solution to the linear system A · x = b.
solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system A · x = b.
solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector, boolean, double) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system (A - shift · I) · x = b.
solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system A · x = b.
solveLinear(double, double) - Static method in class jhplot.math.Numeric
Calculates the roots of the linear equation, a must be different from 0.
solveLowerTriangularSystem(RealMatrix, RealVector) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Solve a system of composed of a Lower Triangular Matrix RealMatrix.
solveQuadratic(double, double, double) - Static method in class jhplot.math.Numeric
Calculates the roots of the quadratic equation, a must be different from 0 (or use linear equation solver).
solveQuartic(double, double, double, double, double) - Static method in class jhplot.math.Numeric
Calculates the roots of the quartics equation, a must be different from 0 (or use cubic equation solver).
SOLVER_DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.AbstractRealDistribution
Default accuracy.
solveTranspose(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Solves X*A = B, which is also A'*X' = B'.
solveTranspose(Matrix) - Method in class Jama.Matrix
Solve X*A = B, which is also A'*X' = B'
solveTranspose(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Solve X*A = B, which is also A'*X' = B'
solveTranspose(double[][], double[][]) - Static method in class jhplot.math.LinearAlgebra
 
solveUpperTriangularSystem(RealMatrix, RealVector) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Solver a system composed of an Upper Triangular Matrix RealMatrix.
sort() - Method in class cern.colt.list.AbstractList
Sorts the receiver into ascending order.
sort(DoubleMatrix1D) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the vector into ascending order, according to the natural ordering.
sort(DoubleMatrix1D, DoubleComparator) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the vector into ascending order, according to the order induced by the specified comparator.
sort(DoubleMatrix2D, double[]) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the virtual column aggregates; Particularly efficient when comparing expensive aggregates, because aggregates need not be recomputed time and again, as is the case for comparator based sorts.
sort(DoubleMatrix2D, int) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
sort(DoubleMatrix2D, DoubleMatrix1DComparator) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix rows according to the order induced by the specified comparator.
sort(DoubleMatrix2D, BinFunction1D) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix rows into ascending order, according to the natural ordering of the values computed by applying the given aggregation function to each row; Particularly efficient when comparing expensive aggregates, because aggregates need not be recomputed time and again, as is the case for comparator based sorts.
sort(DoubleMatrix3D, int, int) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
sort(DoubleMatrix3D, DoubleMatrix2DComparator) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix slices according to the order induced by the specified comparator.
sort(ObjectMatrix1D) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the vector into ascending order, according to the natural ordering.
sort(ObjectMatrix1D, Comparator) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the vector into ascending order, according to the order induced by the specified comparator.
sort(ObjectMatrix2D, int) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
sort(ObjectMatrix2D, ObjectMatrix1DComparator) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the matrix rows according to the order induced by the specified comparator.
sort(ObjectMatrix3D, int, int) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
sort(ObjectMatrix3D, ObjectMatrix2DComparator) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the matrix slices according to the order induced by the specified comparator.
sort(double[]) - Static method in class jhplot.math.DoubleArray
Sorts an array in ascending order.
sort(double[][], int) - Static method in class jhplot.math.DoubleArray
Sorts the rows of a matrix using a specified column as the key.
sort(int[], Object[], Comparator, boolean) - Static method in class jhplot.math.SortUtils
Do a sort on indices.
sort(Object[], Comparator, boolean) - Static method in class jhplot.math.SortUtils
Do a sort on indices.
sort(Object[], Comparator) - Static method in class jhplot.math.SortUtils
Do an unstable sort.
sort(int[], Object[], Comparator) - Static method in class jhplot.math.SortUtils
Do an unstable sort.
sort(int, int) - Method in class jhplot.P0D
Sort a slice of the list (ascending) using the Sun quicksort implementation.
sort(int, int) - Method in class jhplot.P0I
Sort a slice of the list (ascending) using the Sun quicksort implementation.
sort(int) - Method in class jhplot.P1D
Sorting the original array using either X or Y values.
Sort(double[]) - Static method in class jminhep.utils.ArrayOps
Sort array
sort(boolean) - Method in class jplot.DataArray
Sorts the arrays in ascending or descending order.
sort(boolean) - Method in class jplot.DataArray3D
Sorts the arrays in ascending or descending order.
sort(double[], Iterable<Neuron>, DistanceMeasure) - Static method in class org.apache.commons.math3.ml.neuralnet.MapUtils
Creates a list of neurons sorted in increased order of the distance to the given features.
sort() - Method in class org.jfree.chart.plot.PieLabelDistributor
Sorts the label records into ascending order by y-value.
sortByKeys(SortOrder) - Method in class org.jfree.data.DefaultKeyedValues
Sorts the items in the list by key.
sortByKeys(SortOrder) - Method in class org.jfree.data.general.DefaultPieDataset
Sorts the dataset's items by key and sends a DatasetChangeEvent to all registered listeners.
sortByValues(SortOrder) - Method in class org.jfree.data.DefaultKeyedValues
Sorts the items in the list by value.
sortByValues(SortOrder) - Method in class org.jfree.data.general.DefaultPieDataset
Sorts the dataset's items by value and sends a DatasetChangeEvent to all registered listeners.
sortDataByDate() - Method in class org.jfree.data.xy.DefaultOHLCDataset
Sorts the data into ascending order by date.
sortedElements() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns a copy of the currently stored elements, sorted ascending.
sortFromTo(int, int) - Method in class cern.colt.list.AbstractList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.ByteArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.CharArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.IntArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.LongArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.ShortArrayList
Sorts the specified range of the receiver into ascending order.
sortIndex() - Method in class jhplot.P0D
Return indexes of sorted array in increasing order.
sortIndex() - Method in class jhplot.P0I
Return indexes of sorted array in increasing order.
Sorting - Class in cern.colt.matrix.doublealgo
Matrix quicksorts and mergesorts.
Sorting - Class in cern.colt.matrix.objectalgo
Matrix quicksorts and mergesorts.
Sorting - Class in cern.colt
Quicksorts, mergesorts and binary searches; complements java.util.Arrays.
Sorting - Class in jhplot.math
Quick Sort algorithm.
Sorting(double[], boolean) - Constructor for class jhplot.math.Sorting
Construct an ascending order.
sortInPlace(double[], double[]...) - Static method in class org.apache.commons.math3.util.MathArrays
Sort an array in ascending order in place and perform the same reordering of entries on other arrays.
sortInPlace(double[], MathArrays.OrderDirection, double[]...) - Static method in class org.apache.commons.math3.util.MathArrays
Sort an array in place and perform the same reordering of entries on other arrays.
sortMaxToMin(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a sorted array from the maximum to the minimum value.
sortMaxToMin(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a sorted array from the maximum to the minimum value.
sortMinToMax(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a sorted array from the minimum to the maximum value.
sortMinToMax(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a sorted array from the minimum to the maximum value.
SortUtils - Class in jhplot.math
Utility class providing some useful static sort methods.
SortUtils() - Constructor for class jhplot.math.SortUtils
 
SOUTH_LEFT - Static variable in class org.jfree.chart.plot.PolarAxisLocation
Axis left of south.
SOUTH_RIGHT - Static variable in class org.jfree.chart.plot.PolarAxisLocation
Axis right of south.
Space - Interface in org.apache.commons.math3.geometry
This interface represents a generic space, with affine and vectorial counterparts.
SpacePoint - Class in hep.physics.vec
A Hep3Vector representing a point in space.
SpacePoint() - Constructor for class hep.physics.vec.SpacePoint
Default constructor.
SpacePoint(SpacePoint) - Constructor for class hep.physics.vec.SpacePoint
Copy constructor
SpacePoint(Hep3Vector) - Constructor for class hep.physics.vec.SpacePoint
 
SpacePoint - Class in hephysics.vec
A Hep3Vector representing a point in space.
SpacePoint() - Constructor for class hephysics.vec.SpacePoint
Default constructor.
SpacePoint(SpacePoint) - Constructor for class hephysics.vec.SpacePoint
Copy constructor
SpacePoint(Hep3Vector) - Constructor for class hephysics.vec.SpacePoint
 
SpacePoint.Representation - Enum in hep.physics.vec
 
SpacePoint.Representation - Enum in hephysics.vec
 
sparse - Static variable in class cern.colt.matrix.DoubleFactory1D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.DoubleFactory2D
A factory producing sparse hash matrices.
sparse - Static variable in class cern.colt.matrix.DoubleFactory3D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.ObjectFactory1D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.ObjectFactory2D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.ObjectFactory3D
A factory producing sparse matrices.
SparseDoubleMatrix1D - Class in cern.colt.matrix.impl
Sparse hashed 1-d matrix (aka vector) holding double elements.
SparseDoubleMatrix1D(double[]) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix1D
Constructs a matrix with a copy of the given values.
SparseDoubleMatrix1D(int) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix1D
Constructs a matrix with a given number of cells.
SparseDoubleMatrix1D(int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix1D
Constructs a matrix with a given number of parameters.
SparseDoubleMatrix2D - Class in cern.colt.matrix.impl
Sparse hashed 2-d matrix holding double elements.
SparseDoubleMatrix2D(double[][]) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix2D
Constructs a matrix with a copy of the given values.
SparseDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix2D
Constructs a matrix with a given number of rows and columns and default memory usage.
SparseDoubleMatrix2D(int, int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix2D
Constructs a matrix with a given number of rows and columns using memory as specified.
SparseDoubleMatrix3D - Class in cern.colt.matrix.impl
Sparse hashed 3-d matrix holding double elements.
SparseDoubleMatrix3D(double[][][]) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix3D
Constructs a matrix with a copy of the given values.
SparseDoubleMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix3D
Constructs a matrix with a given number of slices, rows and columns and default memory usage.
SparseDoubleMatrix3D(int, int, int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix3D
Constructs a matrix with a given number of slices, rows and columns using memory as specified.
SparseFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Sparse matrix implementation based on an open addressed map.
SparseFieldMatrix(Field<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
Create a matrix with no data.
SparseFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
Create a new SparseFieldMatrix with the supplied row and column dimensions.
SparseFieldMatrix(SparseFieldMatrix<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
Copy constructor.
SparseFieldMatrix(FieldMatrix<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
Generic copy constructor.
SparseFieldVector<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
This class implements the FieldVector interface with a OpenIntToFieldHashMap backing store.
SparseFieldVector(Field<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
Build a 0-length vector.
SparseFieldVector(Field<T>, int) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
Construct a vector of zeroes.
SparseFieldVector(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
Build a vector with known the sparseness (for advanced use only).
SparseFieldVector(Field<T>, T[]) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
Create from a Field array.
SparseFieldVector(SparseFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
Copy constructor.
SparseGradient - Class in org.apache.commons.math3.analysis.differentiation
First derivative computation with large number of variables.
SparseGridBuilder - Class in org.jlab.groot.matrix
 
SparseGridBuilder() - Constructor for class org.jlab.groot.matrix.SparseGridBuilder
 
SparseGridBuilder(int) - Constructor for class org.jlab.groot.matrix.SparseGridBuilder
 
SparseGridIO - Class in org.jlab.groot.matrix
 
SparseGridIO() - Constructor for class org.jlab.groot.matrix.SparseGridIO
 
SparseIndex - Class in org.jlab.groot.matrix
 
SparseIndex(int[]) - Constructor for class org.jlab.groot.matrix.SparseIndex
 
SparseIndexPane - Class in org.jlab.groot.matrix
 
SparseIndexPane(int[], int) - Constructor for class org.jlab.groot.matrix.SparseIndexPane
 
sparseIterator() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Create a sparse iterator over the vector, which may omit some entries.
sparseIterator() - Method in class org.apache.commons.math3.linear.RealVector
Create a sparse iterator over the vector, which may omit some entries.
SparseObjectMatrix1D - Class in cern.colt.matrix.impl
Sparse hashed 1-d matrix (aka vector) holding Object elements.
SparseObjectMatrix1D(Object[]) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix1D
Constructs a matrix with a copy of the given values.
SparseObjectMatrix1D(int) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix1D
Constructs a matrix with a given number of cells.
SparseObjectMatrix1D(int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix1D
Constructs a matrix with a given number of parameters.
SparseObjectMatrix2D - Class in cern.colt.matrix.impl
Sparse hashed 2-d matrix holding Object elements.
SparseObjectMatrix2D(Object[][]) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix2D
Constructs a matrix with a copy of the given values.
SparseObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix2D
Constructs a matrix with a given number of rows and columns and default memory usage.
SparseObjectMatrix2D(int, int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix2D
Constructs a matrix with a given number of rows and columns using memory as specified.
SparseObjectMatrix3D - Class in cern.colt.matrix.impl
Sparse hashed 3-d matrix holding Object elements.
SparseObjectMatrix3D(Object[][][]) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix3D
Constructs a matrix with a copy of the given values.
SparseObjectMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix3D
Constructs a matrix with a given number of slices, rows and columns and default memory usage.
SparseObjectMatrix3D(int, int, int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix3D
Constructs a matrix with a given number of slices, rows and columns using memory as specified.
SparseRealMatrix - Interface in org.apache.commons.math3.linear
Marker interface for RealMatrix implementations that require sparse backing storage
SparseRealVector - Class in org.apache.commons.math3.linear
Marker class for RealVectors that require sparse backing storage
SparseRealVector() - Constructor for class org.apache.commons.math3.linear.SparseRealVector
 
SparseVectorGrid - Class in org.jlab.groot.matrix
 
SparseVectorGrid() - Constructor for class org.jlab.groot.matrix.SparseVectorGrid
 
SparseVectorGrid(int[]) - Constructor for class org.jlab.groot.matrix.SparseVectorGrid
 
SparseVectorGrid(int, int[]) - Constructor for class org.jlab.groot.matrix.SparseVectorGrid
 
SpearmansCorrelation - Class in org.apache.commons.math3.stat.correlation
Spearman's rank correlation.
SpearmansCorrelation() - Constructor for class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Create a SpearmansCorrelation without data.
SpearmansCorrelation(RankingAlgorithm) - Constructor for class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Create a SpearmansCorrelation with the given ranking algorithm.
SpearmansCorrelation(RealMatrix) - Constructor for class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Create a SpearmansCorrelation from the given data matrix.
SpearmansCorrelation(RealMatrix, RankingAlgorithm) - Constructor for class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Create a SpearmansCorrelation with the given input data matrix and ranking algorithm.
SpecialEvaluationI - Interface in org.nfunk.jep.function
Deprecated.
The interface CallbackEvaluationI should generally be used instead as its simpler and allows different evaluation schemes to be used.
SpecialFunction - Class in graph
This class contains physical constants and special functions not found in the java.lang.Math class.
SpecialPreProcessorI - Interface in org.lsmp.djep.matrixJep
Applies a special preprocessing step for a function or operator.
specialToken - Variable in class jplot3dp.MathParser.Token
This field is used to access special tokens that occur prior to this token, but after the immediately preceding regular (non-special) token.
specialToken - Variable in class org.nfunk.jep.Token
This field is used to access special tokens that occur prior to this token, but after the immediately preceding regular (non-special) token.
SPECTRUM - Static variable in class jplot3d.ColorModel
 
Sphere1D - Class in org.apache.commons.math3.geometry.spherical.oned
This class implements a one-dimensional sphere (i.e.
Sphere1D.NoSubSpaceException - Exception in org.apache.commons.math3.geometry.spherical.oned
Specialized exception for inexistent sub-space.
Sphere2D - Class in org.apache.commons.math3.geometry.spherical.twod
This class implements a two-dimensional sphere (i.e.
SphereGenerator - Class in org.apache.commons.math3.geometry.euclidean.threed
Class generating an enclosing ball from its support points.
SphereGenerator() - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SphereGenerator
 
SphericalCoordinates - Class in org.apache.commons.math3.geometry.euclidean.threed
This class provides conversions related to spherical coordinates.
SphericalCoordinates(Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SphericalCoordinates
Build a spherical coordinates transformer from Cartesian coordinates.
SphericalCoordinates(double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SphericalCoordinates
Build a spherical coordinates transformer from spherical coordinates.
SphericalPolygonsSet - Class in org.apache.commons.math3.geometry.spherical.twod
This class represents a region on the 2-sphere: a set of spherical polygons.
SphericalPolygonsSet(double) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.SphericalPolygonsSet
Build a polygons set representing the whole real 2-sphere.
SphericalPolygonsSet(Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.SphericalPolygonsSet
Build a polygons set representing a hemisphere.
SphericalPolygonsSet(Vector3D, Vector3D, double, int, double) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.SphericalPolygonsSet
Build a polygons set representing a regular polygon.
SphericalPolygonsSet(BSPTree<Sphere2D>, double) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.SphericalPolygonsSet
Build a polygons set from a BSP tree.
SphericalPolygonsSet(Collection<SubHyperplane<Sphere2D>>, double) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.SphericalPolygonsSet
Build a polygons set from a Boundary REPresentation (B-rep).
SphericalPolygonsSet(double, S2Point...) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.SphericalPolygonsSet
Build a polygon from a simple list of vertices.
SpiderWebPlot - Class in org.jfree.chart.plot
A plot that displays data from a CategoryDataset in the form of a "spider web".
SpiderWebPlot() - Constructor for class org.jfree.chart.plot.SpiderWebPlot
Creates a default plot with no dataset.
SpiderWebPlot(CategoryDataset) - Constructor for class org.jfree.chart.plot.SpiderWebPlot
Creates a new spider web plot with the given dataset, with each row representing a series.
SpiderWebPlot(CategoryDataset, TableOrder) - Constructor for class org.jfree.chart.plot.SpiderWebPlot
Creates a new spider web plot with the given dataset.
SplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Computes a natural (also known as "free", "unclamped") cubic spline interpolation for the data set.
SplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.SplineInterpolator
 
split(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Splits (partitions) a list into sublists such that each sublist contains the elements with a given range.
Split - Class in hep.lcio.util
Split utility that takes an LCIO file and breaks it into chunks of given size.
Split() - Constructor for class hep.lcio.util.Split
 
split(File, File, int, int) - Static method in class hep.lcio.util.Split
Static utility function that splits infile into chunks with nevents.
split(Hyperplane<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
Split the instance in two parts by an hyperplane.
split(Hyperplane<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubPlane
Split the instance in two parts by an hyperplane.
split(Hyperplane<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Split the instance in two parts by an hyperplane.
split(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Split the instance in two parts by an hyperplane.
split(SubHyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Split a BSP tree by an external sub-hyperplane.
split(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Split the instance in two parts by an hyperplane.
split(Arc) - Method in class org.apache.commons.math3.geometry.spherical.oned.ArcsSet
Split the instance in two parts by an arc.
split(Hyperplane<Sphere1D>) - Method in class org.apache.commons.math3.geometry.spherical.oned.SubLimitAngle
Split the instance in two parts by an hyperplane.
split(Hyperplane<Sphere2D>) - Method in class org.apache.commons.math3.geometry.spherical.twod.SubCircle
Split the instance in two parts by an hyperplane.
split(String) - Method in class org.lsmp.djepExamples.Console
Splits a string on spaces.
splitApproximately(DoubleArrayList, int) - Method in class cern.hep.aida.bin.QuantileBin1D
Divides (rebins) a copy of the receiver at the given percentage boundaries into bins and returns these bins, such that each bin approximately reflects the data elements of its range.
splitApproximately(IAxis, int) - Method in class cern.hep.aida.bin.QuantileBin1D
Divides (rebins) a copy of the receiver at the given interval boundaries into bins and returns these bins, such that each bin approximately reflects the data elements of its range.
SplitCommandHandler - Class in hep.lcio.util
Command-line handler for the split utility.
SplitSubHyperplane(SubHyperplane<U>, SubHyperplane<U>) - Constructor for class org.apache.commons.math3.geometry.partitioning.SubHyperplane.SplitSubHyperplane
Build a SplitSubHyperplane from its parts.
sqrt - Static variable in class cern.jet.math.Functions
Function that returns Math.sqrt(a).
Sqrt(Z) - Method in class Jampack.Z
Computes the principal value of the square root of a Z.
sqrt() - Method in class jhplot.math.Complex
Complex square root (doesn't change this complex number).
sqrt(ValueErr) - Method in class jhplot.math.ValueErr
Get square root value
SQRT - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
sqrt(double) - Static method in class net.jafama.FastMath
 
sqrt(double) - Static method in class net.jafama.StrictFastMath
 
sqrt() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Square root.
sqrt() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Square root.
Sqrt - Class in org.apache.commons.math3.analysis.function
Square-root function.
Sqrt() - Constructor for class org.apache.commons.math3.analysis.function.Sqrt
 
sqrt() - Method in class org.apache.commons.math3.complex.Complex
Compute the square root of this complex number.
sqrt() - Method in class org.apache.commons.math3.dfp.Dfp
Compute the square root.
sqrt() - Method in class org.apache.commons.math3.linear.JacobiPreconditioner
Returns the square root of this diagonal operator.
sqrt() - Method in interface org.apache.commons.math3.RealFieldElement
Square root.
sqrt() - Method in class org.apache.commons.math3.util.Decimal64
Square root.
sqrt(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the square root of a number.
sqrt(Object) - Method in class org.nfunk.jep.function.SquareRoot
Calculates the square root of the parameter.
sqrt() - Method in class org.nfunk.jep.type.Complex
Calculates the square root of this object.
sqrt1z() - Method in class org.apache.commons.math3.complex.Complex
Compute the square root of 1 - this2 for this complex number.
SQRT_2 - Static variable in interface jhplot.math.num.Constants
√2.
sqrtQuick(double) - Static method in class net.jafama.FastMath
Quick sqrt, with with a max relative error of about 3.41e-2 for values in [Double.MIN_NORMAL,Double.MAX_VALUE], and worse accuracy outside this range.
sqrtQuick(double) - Static method in class net.jafama.StrictFastMath
Quick sqrt, with with a max relative error of about 3.41e-2 for values in [Double.MIN_NORMAL,Double.MAX_VALUE], and worse accuracy outside this range.
square - Static variable in class cern.jet.math.Functions
Function that returns a * a.
square - Static variable in class cern.jet.math.IntFunctions
Function that returns a * a.
square - Variable in class graph.Graph2D
Modify the position of the axis and the range of the axis so that the aspect ratio of the major tick marks are 1 and the plot is square on the screen
square() - Method in class jhplot.math.ValueErr
Square
square(ValueErr) - Method in class jhplot.math.ValueErr
Square
square(double) - Method in class jhplot.math.ValueErr
 
SquareNeighbourhood - Enum in org.apache.commons.math3.ml.neuralnet
Defines neighbourhood types.
SquareRoot - Class in org.nfunk.jep.function
 
SquareRoot() - Constructor for class org.nfunk.jep.function.SquareRoot
 
sr - Static variable in class cern.clhep.Units
 
sr - Variable in class Jampack.Rot
The real part of the sine of the rotation
SS - Static variable in class jminhep.clcontrol.Global
 
StableRandomGenerator - Class in org.apache.commons.math3.random
This class provides a stable normalized random generator.
StableRandomGenerator(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.random.StableRandomGenerator
Create a new generator.
StackedAreaRenderer - Class in org.jfree.chart.renderer.category
A renderer that draws stacked area charts for a CategoryPlot.
StackedAreaRenderer() - Constructor for class org.jfree.chart.renderer.category.StackedAreaRenderer
Creates a new renderer.
StackedAreaRenderer(boolean) - Constructor for class org.jfree.chart.renderer.category.StackedAreaRenderer
Creates a new renderer.
StackedBarRenderer - Class in org.jfree.chart.renderer.category
A stacked bar renderer for use with the CategoryPlot class.
StackedBarRenderer() - Constructor for class org.jfree.chart.renderer.category.StackedBarRenderer
Creates a new renderer.
StackedBarRenderer(boolean) - Constructor for class org.jfree.chart.renderer.category.StackedBarRenderer
Creates a new renderer.
StackedBarRenderer3D - Class in org.jfree.chart.renderer.category
Renders stacked bars with 3D-effect, for use with the CategoryPlot class.
StackedBarRenderer3D() - Constructor for class org.jfree.chart.renderer.category.StackedBarRenderer3D
Creates a new renderer with no tool tip generator and no URL generator.
StackedBarRenderer3D(double, double) - Constructor for class org.jfree.chart.renderer.category.StackedBarRenderer3D
Constructs a new renderer with the specified '3D effect'.
StackedBarRenderer3D(boolean) - Constructor for class org.jfree.chart.renderer.category.StackedBarRenderer3D
Creates a new renderer.
StackedBarRenderer3D(double, double, boolean) - Constructor for class org.jfree.chart.renderer.category.StackedBarRenderer3D
Constructs a new renderer with the specified '3D effect'.
StackedXYAreaRenderer - Class in org.jfree.chart.renderer.xy
A stacked area renderer for the XYPlot class.
StackedXYAreaRenderer() - Constructor for class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Creates a new renderer.
StackedXYAreaRenderer(int) - Constructor for class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Constructs a new renderer.
StackedXYAreaRenderer(int, XYToolTipGenerator, XYURLGenerator) - Constructor for class org.jfree.chart.renderer.xy.StackedXYAreaRenderer
Constructs a new renderer.
StackedXYAreaRenderer2 - Class in org.jfree.chart.renderer.xy
A stacked area renderer for the XYPlot class.
StackedXYAreaRenderer2() - Constructor for class org.jfree.chart.renderer.xy.StackedXYAreaRenderer2
Creates a new renderer.
StackedXYAreaRenderer2(XYToolTipGenerator, XYURLGenerator) - Constructor for class org.jfree.chart.renderer.xy.StackedXYAreaRenderer2
Constructs a new renderer.
StackedXYBarRenderer - Class in org.jfree.chart.renderer.xy
A bar renderer that displays the series items stacked.
StackedXYBarRenderer() - Constructor for class org.jfree.chart.renderer.xy.StackedXYBarRenderer
Creates a new renderer.
StackedXYBarRenderer(double) - Constructor for class org.jfree.chart.renderer.xy.StackedXYBarRenderer
Creates a new renderer.
STAGGER_WIDTH - Static variable in class org.jfree.chart.renderer.category.CategoryStepRenderer
The stagger width.
STANDARD - Static variable in class org.jfree.chart.axis.CategoryLabelPositions
STANDARD category label positions.
STANDARD - Static variable in class org.jfree.chart.LegendRenderingOrder
In order.
STANDARD - Static variable in class org.jfree.chart.plot.PieLabelLinkStyle
STANDARD.
StandardBarPainter - Class in org.jfree.chart.renderer.category
An implementation of the BarPainter interface that preserves the behaviour of bar painting that existed prior to the introduction of the BarPainter interface.
StandardBarPainter() - Constructor for class org.jfree.chart.renderer.category.StandardBarPainter
Creates a new instance.
StandardCategoryItemLabelGenerator - Class in org.jfree.chart.labels
A standard label generator that can be used with a CategoryItemRenderer.
StandardCategoryItemLabelGenerator() - Constructor for class org.jfree.chart.labels.StandardCategoryItemLabelGenerator
Creates a new generator with a default number formatter.
StandardCategoryItemLabelGenerator(String, NumberFormat) - Constructor for class org.jfree.chart.labels.StandardCategoryItemLabelGenerator
Creates a new generator with the specified number formatter.
StandardCategoryItemLabelGenerator(String, NumberFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.StandardCategoryItemLabelGenerator
Creates a new generator with the specified number formatter.
StandardCategoryItemLabelGenerator(String, DateFormat) - Constructor for class org.jfree.chart.labels.StandardCategoryItemLabelGenerator
Creates a new generator with the specified date formatter.
StandardCategorySeriesLabelGenerator - Class in org.jfree.chart.labels
A standard series label generator for plots that use data from a CategoryDataset.
StandardCategorySeriesLabelGenerator() - Constructor for class org.jfree.chart.labels.StandardCategorySeriesLabelGenerator
Creates a default series label generator (uses StandardCategorySeriesLabelGenerator.DEFAULT_LABEL_FORMAT).
StandardCategorySeriesLabelGenerator(String) - Constructor for class org.jfree.chart.labels.StandardCategorySeriesLabelGenerator
Creates a new series label generator.
StandardCategoryToolTipGenerator - Class in org.jfree.chart.labels
A standard tool tip generator that can be used with a CategoryItemRenderer.
StandardCategoryToolTipGenerator() - Constructor for class org.jfree.chart.labels.StandardCategoryToolTipGenerator
Creates a new generator with a default number formatter.
StandardCategoryToolTipGenerator(String, NumberFormat) - Constructor for class org.jfree.chart.labels.StandardCategoryToolTipGenerator
Creates a new generator with the specified number formatter.
StandardCategoryToolTipGenerator(String, DateFormat) - Constructor for class org.jfree.chart.labels.StandardCategoryToolTipGenerator
Creates a new generator with the specified date formatter.
StandardCategoryURLGenerator - Class in org.jfree.chart.urls
A URL generator that can be assigned to a CategoryItemRenderer.
StandardCategoryURLGenerator() - Constructor for class org.jfree.chart.urls.StandardCategoryURLGenerator
Creates a new generator with default settings.
StandardCategoryURLGenerator(String) - Constructor for class org.jfree.chart.urls.StandardCategoryURLGenerator
Constructor that overrides default prefix to the URL.
StandardCategoryURLGenerator(String, String, String) - Constructor for class org.jfree.chart.urls.StandardCategoryURLGenerator
Constructor that overrides all the defaults.
StandardChartTheme - Class in org.jfree.chart
A default implementation of the ChartTheme interface.
StandardChartTheme(String) - Constructor for class org.jfree.chart.StandardChartTheme
Creates a new default instance.
StandardChartTheme(String, boolean) - Constructor for class org.jfree.chart.StandardChartTheme
Creates a new default instance.
StandardContourToolTipGenerator - Class in org.jfree.chart.labels
Deprecated.
This class is no longer supported (as of version 1.0.4). If you are creating contour plots, please try to use XYPlot and XYBlockRenderer.
StandardContourToolTipGenerator() - Constructor for class org.jfree.chart.labels.StandardContourToolTipGenerator
Deprecated.
 
StandardCrosshairLabelGenerator - Class in org.jfree.chart.labels
A default label generator.
StandardCrosshairLabelGenerator() - Constructor for class org.jfree.chart.labels.StandardCrosshairLabelGenerator
Creates a new instance with default attributes.
StandardCrosshairLabelGenerator(String, NumberFormat) - Constructor for class org.jfree.chart.labels.StandardCrosshairLabelGenerator
Creates a new instance with the specified attributes.
StandardDeleteOption - Enum in org.apache.commons.io.file
Defines the standard delete options.
standardDeviation() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the sample standard deviation, which is Math.sqrt(variance()).
standardDeviation(double) - Static method in class cern.jet.stat.Descriptive
Returns the standard deviation from a variance.
standardDeviation(double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the (bias-corrected sample) standard deviation of an array.
standardDeviation(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the (bias-corrected sample) standard deviation of an array.
StandardDeviation - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the sample standard deviation.
StandardDeviation() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Constructs a StandardDeviation.
StandardDeviation(SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Constructs a StandardDeviation from an external second moment.
StandardDeviation(StandardDeviation) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Copy constructor, creates a new StandardDeviation identical to the original
StandardDeviation(boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Contructs a StandardDeviation with the specified value for the isBiasCorrected property.
StandardDeviation(boolean, SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Contructs a StandardDeviation with the specified value for the isBiasCorrected property and the supplied external moment.
StandardDialFrame - Class in org.jfree.chart.plot.dial
A simple circular frame for the DialPlot class.
StandardDialFrame() - Constructor for class org.jfree.chart.plot.dial.StandardDialFrame
Creates a new instance of StandardDialFrame.
StandardDialRange - Class in org.jfree.chart.plot.dial
A layer that draws a range highlight on a dial plot.
StandardDialRange() - Constructor for class org.jfree.chart.plot.dial.StandardDialRange
Creates a new instance of StandardDialRange.
StandardDialRange(double, double, Paint) - Constructor for class org.jfree.chart.plot.dial.StandardDialRange
Creates a new instance of StandardDialRange.
StandardDialScale - Class in org.jfree.chart.plot.dial
A scale for a DialPlot.
StandardDialScale() - Constructor for class org.jfree.chart.plot.dial.StandardDialScale
Creates a new instance of DialScale.
StandardDialScale(double, double, double, double, double, int) - Constructor for class org.jfree.chart.plot.dial.StandardDialScale
Creates a new instance.
StandardEntityCollection - Class in org.jfree.chart.entity
A standard implementation of the EntityCollection interface.
StandardEntityCollection() - Constructor for class org.jfree.chart.entity.StandardEntityCollection
Constructs a new entity collection (initially empty).
standardError() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the sample standard error, which is Math.sqrt(variance() / size())
standardError(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the standard error of a data sequence.
standardError() - Method in class jhplot.P0D
Returns the sample standard error, which is Math.sqrt(variance() / size()).
standardError() - Method in class jhplot.P0I
Returns the sample standard error, which is Math.sqrt(variance() / size()).
standardize(double, double) - Method in class cern.hep.aida.bin.DynamicBin1D
Modifies the receiver to be standardized.
standardize(DoubleArrayList, double, double) - Static method in class cern.jet.stat.Descriptive
Modifies a data sequence to be standardized.
standardize() - Method in class jhplot.PND
Standardize each column.
Standardize(int, int, double[][]) - Static method in class jminhep.utils.VEC
Method for standardizing the input data
StandardPieSectionLabelGenerator - Class in org.jfree.chart.labels
A standard item label generator for plots that use data from a PieDataset.
StandardPieSectionLabelGenerator() - Constructor for class org.jfree.chart.labels.StandardPieSectionLabelGenerator
Creates a new section label generator using StandardPieSectionLabelGenerator.DEFAULT_SECTION_LABEL_FORMAT as the label format string, and platform default number and percentage formatters.
StandardPieSectionLabelGenerator(Locale) - Constructor for class org.jfree.chart.labels.StandardPieSectionLabelGenerator
Creates a new instance for the specified locale.
StandardPieSectionLabelGenerator(String) - Constructor for class org.jfree.chart.labels.StandardPieSectionLabelGenerator
Creates a new section label generator using the specified label format string, and platform default number and percentage formatters.
StandardPieSectionLabelGenerator(String, Locale) - Constructor for class org.jfree.chart.labels.StandardPieSectionLabelGenerator
Creates a new instance for the specified locale.
StandardPieSectionLabelGenerator(String, NumberFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.StandardPieSectionLabelGenerator
Creates an item label generator using the specified number formatters.
StandardPieToolTipGenerator - Class in org.jfree.chart.labels
A standard item label generator for plots that use data from a PieDataset.
StandardPieToolTipGenerator() - Constructor for class org.jfree.chart.labels.StandardPieToolTipGenerator
Creates an item label generator using default number formatters.
StandardPieToolTipGenerator(Locale) - Constructor for class org.jfree.chart.labels.StandardPieToolTipGenerator
Creates a pie tool tip generator for the specified locale, using the default format string.
StandardPieToolTipGenerator(String) - Constructor for class org.jfree.chart.labels.StandardPieToolTipGenerator
Creates a pie tool tip generator for the default locale.
StandardPieToolTipGenerator(String, Locale) - Constructor for class org.jfree.chart.labels.StandardPieToolTipGenerator
Creates a pie tool tip generator for the specified locale.
StandardPieToolTipGenerator(String, NumberFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.StandardPieToolTipGenerator
Creates an item label generator using the specified number formatters.
StandardPieURLGenerator - Class in org.jfree.chart.urls
A URL generator for pie charts.
StandardPieURLGenerator() - Constructor for class org.jfree.chart.urls.StandardPieURLGenerator
Default constructor.
StandardPieURLGenerator(String) - Constructor for class org.jfree.chart.urls.StandardPieURLGenerator
Creates a new generator.
StandardPieURLGenerator(String, String) - Constructor for class org.jfree.chart.urls.StandardPieURLGenerator
Creates a new generator.
StandardPieURLGenerator(String, String, String) - Constructor for class org.jfree.chart.urls.StandardPieURLGenerator
Creates a new generator.
StandardTickUnitSource - Class in org.jfree.chart.axis
A source that can used by the NumberAxis class to obtain a suitable TickUnit.
StandardTickUnitSource() - Constructor for class org.jfree.chart.axis.StandardTickUnitSource
Default constructor.
StandardToolTipTagFragmentGenerator - Class in org.jfree.chart.imagemap
Generates tooltips using the HTML title attribute for image map area tags.
StandardToolTipTagFragmentGenerator() - Constructor for class org.jfree.chart.imagemap.StandardToolTipTagFragmentGenerator
Creates a new instance.
StandardURLTagFragmentGenerator - Class in org.jfree.chart.imagemap
Generates URLs using the HTML href attribute for image map area tags.
StandardURLTagFragmentGenerator() - Constructor for class org.jfree.chart.imagemap.StandardURLTagFragmentGenerator
Creates a new instance.
StandardXYBarPainter - Class in org.jfree.chart.renderer.xy
An implementation of the XYBarPainter interface that preserves the behaviour of bar painting that existed prior to the introduction of the XYBarPainter interface.
StandardXYBarPainter() - Constructor for class org.jfree.chart.renderer.xy.StandardXYBarPainter
Creates a new instance.
StandardXYItemLabelGenerator - Class in org.jfree.chart.labels
A standard item label generator for plots that use data from an XYDataset.
StandardXYItemLabelGenerator() - Constructor for class org.jfree.chart.labels.StandardXYItemLabelGenerator
Creates an item label generator using default number formatters.
StandardXYItemLabelGenerator(String) - Constructor for class org.jfree.chart.labels.StandardXYItemLabelGenerator
Creates an item label generator using the specified number formatters.
StandardXYItemLabelGenerator(String, NumberFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.StandardXYItemLabelGenerator
Creates an item label generator using the specified number formatters.
StandardXYItemLabelGenerator(String, DateFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.StandardXYItemLabelGenerator
Creates an item label generator using the specified formatters.
StandardXYItemLabelGenerator(String, NumberFormat, DateFormat) - Constructor for class org.jfree.chart.labels.StandardXYItemLabelGenerator
Creates an item label generator using the specified formatters (a number formatter for the x-values and a date formatter for the y-values).
StandardXYItemLabelGenerator(String, DateFormat, DateFormat) - Constructor for class org.jfree.chart.labels.StandardXYItemLabelGenerator
Creates a label generator using the specified date formatters.
StandardXYItemRenderer - Class in org.jfree.chart.renderer.xy
Standard item renderer for an XYPlot.
StandardXYItemRenderer() - Constructor for class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Constructs a new renderer.
StandardXYItemRenderer(int) - Constructor for class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Constructs a new renderer.
StandardXYItemRenderer(int, XYToolTipGenerator) - Constructor for class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Constructs a new renderer.
StandardXYItemRenderer(int, XYToolTipGenerator, XYURLGenerator) - Constructor for class org.jfree.chart.renderer.xy.StandardXYItemRenderer
Constructs a new renderer.
StandardXYItemRenderer.State - Class in org.jfree.chart.renderer.xy
Records the state for the renderer.
StandardXYSeriesLabelGenerator - Class in org.jfree.chart.labels
A standard series label generator for plots that use data from an XYDataset.
StandardXYSeriesLabelGenerator() - Constructor for class org.jfree.chart.labels.StandardXYSeriesLabelGenerator
Creates a default series label generator (uses StandardXYSeriesLabelGenerator.DEFAULT_LABEL_FORMAT).
StandardXYSeriesLabelGenerator(String) - Constructor for class org.jfree.chart.labels.StandardXYSeriesLabelGenerator
Creates a new series label generator.
StandardXYToolTipGenerator - Class in org.jfree.chart.labels
A standard tool tip generator for use with an XYItemRenderer.
StandardXYToolTipGenerator() - Constructor for class org.jfree.chart.labels.StandardXYToolTipGenerator
Creates a tool tip generator using default number formatters.
StandardXYToolTipGenerator(String, NumberFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.StandardXYToolTipGenerator
Creates a tool tip generator using the specified number formatters.
StandardXYToolTipGenerator(String, DateFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.StandardXYToolTipGenerator
Creates a tool tip generator using the specified number formatters.
StandardXYToolTipGenerator(String, NumberFormat, DateFormat) - Constructor for class org.jfree.chart.labels.StandardXYToolTipGenerator
Creates a tool tip generator using the specified formatters (a number formatter for the x-values and a date formatter for the y-values).
StandardXYToolTipGenerator(String, DateFormat, DateFormat) - Constructor for class org.jfree.chart.labels.StandardXYToolTipGenerator
Creates a tool tip generator using the specified date formatters.
StandardXYURLGenerator - Class in org.jfree.chart.urls
A URL generator.
StandardXYURLGenerator() - Constructor for class org.jfree.chart.urls.StandardXYURLGenerator
Creates a new default generator.
StandardXYURLGenerator(String) - Constructor for class org.jfree.chart.urls.StandardXYURLGenerator
Creates a new generator with the specified prefix.
StandardXYURLGenerator(String, String, String) - Constructor for class org.jfree.chart.urls.StandardXYURLGenerator
Constructor that overrides all the defaults
StandardXYZToolTipGenerator - Class in org.jfree.chart.labels
A standard item label generator for use with XYZDataset data.
StandardXYZToolTipGenerator() - Constructor for class org.jfree.chart.labels.StandardXYZToolTipGenerator
Creates a new tool tip generator using default number formatters for the x, y and z-values.
StandardXYZToolTipGenerator(String, NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.jfree.chart.labels.StandardXYZToolTipGenerator
Constructs a new tool tip generator using the specified number formatters.
StandardXYZToolTipGenerator(String, DateFormat, DateFormat, DateFormat) - Constructor for class org.jfree.chart.labels.StandardXYZToolTipGenerator
Constructs a new tool tip generator using the specified date formatters.
StandardXYZURLGenerator - Class in org.jfree.chart.urls
A URL generator.
StandardXYZURLGenerator() - Constructor for class org.jfree.chart.urls.StandardXYZURLGenerator
 
start() - Method in class cern.colt.Timer
Starts the timer.
start() - Method in class jminhep.utils.StopWatch
Start this StopWatch object.
start() - Method in class org.apache.commons.io.monitor.FileAlterationMonitor
Starts monitoring.
start(RealVector) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the initial guess.
start(double[]) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the initial guess.
start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrixPreservingVisitor
Start visiting a matrix.
start(int, int, int) - Method in interface org.apache.commons.math3.linear.FieldVectorChangingVisitor
Start visiting a vector.
start(int, int, int) - Method in interface org.apache.commons.math3.linear.FieldVectorPreservingVisitor
Start visiting a vector.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrixPreservingVisitor
Start visiting a matrix.
start(int, int, int) - Method in interface org.apache.commons.math3.linear.RealVectorChangingVisitor
Start visiting a vector.
start(int, int, int) - Method in interface org.apache.commons.math3.linear.RealVectorPreservingVisitor
Start visiting a vector.
start() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated.
As of 3.1.
START - Static variable in class org.jfree.chart.axis.CategoryAnchor
Start of period.
START - Static variable in class org.jfree.chart.axis.DateTickMarkPosition
Start of period.
start(Stage) - Method in class org.jfree.chart.fx.demo.BarChartFXDemo1
Adds a chart viewer to the stage and displays it.
start(Stage) - Method in class org.jfree.chart.fx.demo.PieChartFXDemo1
 
start(Stage) - Method in class org.jfree.chart.fx.demo.TimeSeriesChartFXDemo1
 
START - Static variable in class org.jfree.data.time.DynamicTimeSeriesCollection
Useful constant for controlling the x-value returned for a time period.
START - Static variable in class org.jfree.data.time.TimePeriodAnchor
Start of period.
Start() - Method in class org.nfunk.jep.Parser
GRAMMAR START
startDrag(boolean, int, int, int, int) - Method in class jplot.GraphGeneral.GraphMouseListener
Picks up a mouse-drag event.
started() - Method in class graph.LoadData
 
startedloading() - Method in class graph.Graph2D
Calling this method pauses the plot and displays a flashing message on the screen.
startElement(String, String, String, Attributes) - Method in class org.jfree.data.xml.CategoryDatasetHandler
The start of an element.
startElement(String, String, String, Attributes) - Method in class org.jfree.data.xml.CategorySeriesHandler
The start of an element.
startElement(String, String, String, Attributes) - Method in class org.jfree.data.xml.ItemHandler
The start of an element.
startElement(String, String, String, Attributes) - Method in class org.jfree.data.xml.KeyHandler
The start of an element.
startElement(String, String, String, Attributes) - Method in class org.jfree.data.xml.PieDatasetHandler
Starts an element.
startElement(String, String, String, Attributes) - Method in class org.jfree.data.xml.ValueHandler
The start of an element.
startOfBin(int) - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns the start of the range associated with the given bin.
startSeriesPass(XYDataset, int, int, int, int, int) - Method in class org.jfree.chart.renderer.xy.SamplingXYLineRenderer.State
This method is called by the XYPlot at the start of each series pass.
startSeriesPass(XYDataset, int, int, int, int, int) - Method in class org.jfree.chart.renderer.xy.XYItemRendererState
This method is called by the XYPlot when it starts a pass through the (visible) items in a series.
startSeriesPass(XYDataset, int, int, int, int, int) - Method in class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer.State
This method is called by the XYPlot at the start of each series pass.
startt() - Method in class hep.lcio.util.MergeFileParameters
Get the starting time in ns.
STATBOX - Static variable in class jplot.GraphLabel
 
StatConfidence - Class in jhplot.stat.limit
This is a class to give confidence intervals on various measurements calculated from the number of events observed, the acceptance factor, the background estimate and the associated errors.
StatConfidence(double, double, double, int) - Constructor for class jhplot.stat.limit.StatConfidence
Initialize the limit calculations
StatConfidence(double, int) - Constructor for class jhplot.stat.limit.StatConfidence
Initialize the limit calculations, assuming efficiency 1.
state() - Method in class org.freehep.math.minuit.MnApplication
 
State(PlotRenderingInfo) - Constructor for class org.jfree.chart.renderer.xy.DeviationRenderer.State
Creates a new state instance.
State(PlotRenderingInfo) - Constructor for class org.jfree.chart.renderer.xy.SamplingXYLineRenderer.State
Creates a new state instance.
State(PlotRenderingInfo) - Constructor for class org.jfree.chart.renderer.xy.StandardXYItemRenderer.State
Creates a new state instance.
State(PlotRenderingInfo) - Constructor for class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer.State
Creates a new state instance.
stateChanged(ChangeEvent) - Method in class org.jlab.groot.base.AxisAttributes.AxisAttributesPane
 
StaticBin1D - Class in cern.hep.aida.bin
1-dimensional non-rebinnable bin consuming double elements; Efficiently computes basic statistics of data sequences.
StaticBin1D() - Constructor for class cern.hep.aida.bin.StaticBin1D
Constructs and returns an empty bin.
staticFlag - Static variable in class jplot3dp.MathParser.SimpleCharStream
 
staticFlag - Static variable in class org.nfunk.jep.JavaCharStream
 
staticNextBoolean() - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random boolean.
staticNextDouble(double, double) - Static method in class cern.jet.random.Beta
Returns a random number from the distribution.
staticNextDouble(double, double, double) - Static method in class cern.jet.random.BreitWigner
Returns a random number from the distribution.
staticNextDouble(double, double, double) - Static method in class cern.jet.random.BreitWignerMeanSquare
Returns a random number from the distribution.
staticNextDouble(double) - Static method in class cern.jet.random.ChiSquare
Returns a random number from the distribution.
staticNextDouble(double) - Static method in class cern.jet.random.Exponential
Returns a random number from the distribution with the given lambda.
staticNextDouble(double) - Static method in class cern.jet.random.ExponentialPower
Returns a random number from the distribution.
staticNextDouble(double, double) - Static method in class cern.jet.random.Gamma
Returns a random number from the distribution.
staticNextDouble(double, double) - Static method in class cern.jet.random.Hyperbolic
Returns a random number from the distribution.
staticNextDouble(double) - Static method in class cern.jet.random.Logarithmic
Returns a random number from the distribution.
staticNextDouble(double, double) - Static method in class cern.jet.random.Normal
Returns a random number from the distribution with the given mean and standard deviation.
staticNextDouble(double) - Static method in class cern.jet.random.StudentT
Returns a random number from the distribution.
staticNextDouble() - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (0,1) (excluding 0 and 1).
staticNextDouble(double) - Static method in class cern.jet.random.VonMises
Returns a random number from the distribution.
staticNextDoubleFromTo(double, double) - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
staticNextFloatFromTo(float, float) - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
staticNextInt(int, double) - Static method in class cern.jet.random.Binomial
Returns a random number from the distribution with the given parameters n and p.
staticNextInt(int, int, int) - Static method in class cern.jet.random.HyperGeometric
Returns a random number from the distribution.
staticNextInt(int, double) - Static method in class cern.jet.random.NegativeBinomial
Returns a random number from the distribution with the given parameters n and p.
staticNextInt(double) - Static method in class cern.jet.random.Poisson
Returns a random number from the distribution with the given mean.
staticNextInt(double) - Static method in class cern.jet.random.PoissonSlow
Returns a random number from the distribution with the given mean.
staticNextInt(double, double) - Static method in class cern.jet.random.Zeta
Returns a random number from the distribution.
staticNextIntFromTo(int, int) - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
staticNextLongFromTo(long, long) - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
staticSetRandomEngine(RandomEngine) - Static method in class cern.jet.random.Uniform
Sets the uniform random number generation engine shared by all static methods.
Statistic - Class in cern.colt.matrix.doublealgo
Basic statistics operations on matrices.
Statistic.VectorVectorFunction - Interface in cern.colt.matrix.doublealgo
Interface that represents a function object: a function that takes two argument vectors and returns a single value.
StatisticalBarRenderer - Class in org.jfree.chart.renderer.category
A renderer that handles the drawing a bar plot where each bar has a mean value and a standard deviation line.
StatisticalBarRenderer() - Constructor for class org.jfree.chart.renderer.category.StatisticalBarRenderer
Default constructor.
StatisticalCategoryDataset - Interface in org.jfree.data.statistics
A category dataset that defines a mean and standard deviation value for each item.
StatisticalLineAndShapeRenderer - Class in org.jfree.chart.renderer.category
A renderer that draws shapes for each data item, and lines between data items.
StatisticalLineAndShapeRenderer() - Constructor for class org.jfree.chart.renderer.category.StatisticalLineAndShapeRenderer
Constructs a default renderer (draws shapes and lines).
StatisticalLineAndShapeRenderer(boolean, boolean) - Constructor for class org.jfree.chart.renderer.category.StatisticalLineAndShapeRenderer
Constructs a new renderer.
StatisticalMultivariateSummary - Interface in org.apache.commons.math3.stat.descriptive
Reporting interface for basic multivariate statistics.
StatisticalSummary - Interface in org.apache.commons.math3.stat.descriptive
Reporting interface for basic univariate statistics.
StatisticalSummaryValues - Class in org.apache.commons.math3.stat.descriptive
Value object representing the results of a univariate statistical summary.
StatisticalSummaryValues(double, double, long, double, double, double) - Constructor for class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
Constructor
Statistics - Class in jhplot.stat
A static class for statistical calculations.
Statistics() - Constructor for class jhplot.stat.Statistics
 
Statistics - Class in org.jfree.data.statistics
A utility class that provides some common statistical functions.
Statistics() - Constructor for class org.jfree.data.statistics.Statistics
 
StatisticSample - Class in jhplot.math
A package to create random 1D and 2D arrays.
StatisticSample() - Constructor for class jhplot.math.StatisticSample
 
StatNumber - Class in org.jlab.groot.math
Creates a StatNumber object with a number and an error.
StatNumber() - Constructor for class org.jlab.groot.math.StatNumber
Creates a default StatNumber object with a number and error set to 0.0.
StatNumber(double, double) - Constructor for class org.jlab.groot.math.StatNumber
Creates a StatNumber object with the specified number and error.
StatNumber(double) - Constructor for class org.jlab.groot.math.StatNumber
Creates a StatNumber object with the specified number and calculates its error.
stats() - Method in class cern.colt.matrix.linalg.SmpBlas
Prints various snapshot statistics to System.out; Simply delegates to EDU.oswego.cs.dl.util.concurrent.FJTaskRunnerGroup#stats.
StatShape - Class in jhplot.stat
Shape identification based on a linear regression It calculates eccentricities in the transverse and longitudinal directions, as well as the size of the objects.
StatShape(double[], double[], double[], int) - Constructor for class jhplot.stat.StatShape
Perform a linear regression analysis with weights and prepare for a shape identification.
STATUS_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
STATUS_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
STATUS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
statusbar - Static variable in class jhplot.JHPlot
 
statusbar - Static variable in class jminhep.gui.SetEnv
 
StatUtils - Class in jhplot.stat
Common statistical methods.
StatUtils() - Constructor for class jhplot.stat.StatUtils
 
StatUtils - Class in org.apache.commons.math3.stat
StatUtils provides static methods for computing statistics based on data stored in double[] arrays.
stdDev - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.standardDeviation().
stddeviation(double[]) - Static method in class jhplot.math.StatisticSample
Standard deviation
stddeviation(double[][]) - Static method in class jhplot.math.StatisticSample
Standard deviation
stddeviation() - Method in class jhplot.P0D
Returns the standard deviation (square root of variance)
stddeviation() - Method in class jhplot.P0I
Returns the standard deviation (square root of variance)
stddeviation(double[]) - Static method in class jhplot.stat.Statistics
Standard deviation
stddeviation(double[][]) - Static method in class jhplot.stat.Statistics
Standard deviation
stddeviationX() - Method in class jhplot.P1D
Standard deviation of values X.
stddeviationY() - Method in class jhplot.P1D
Standard deviation of values Y.
stdev(double[]) - Static method in class jhplot.stat.StatUtils
Compute stdev (SQRT(var)) of all values in vector v.
StdhepConvertCommandHandler - Class in hep.lcio.util
 
StdhepConverter - Class in hep.physics.stdhep.convert
A class that converts MCEvent<-->StdhepEvent
StdhepConverter() - Constructor for class hep.physics.stdhep.convert.StdhepConverter
 
StdhepConverter(ParticlePropertyProvider) - Constructor for class hep.physics.stdhep.convert.StdhepConverter
 
StdhepConverter(ParticlePropertyProvider, GeneratorFactory) - Constructor for class hep.physics.stdhep.convert.StdhepConverter
 
STEFANBOLTZ - Static variable in class graph.SpecialFunction
Stefan-Boltzman Constant.
Stencil - Class in cern.colt.matrix.doublealgo
Stencil operations.
stencil27(DoubleMatrix3D, Double27Function, int, DoubleMatrix3DProcedure, int) - Static method in class cern.colt.matrix.doublealgo.Stencil
27 point stencil operation.
stencil9(DoubleMatrix2D, Double9Function, int, DoubleMatrix2DProcedure, int) - Static method in class cern.colt.matrix.doublealgo.Stencil
9 point stencil operation.
stepAccepted(double, double[]) - Method in class org.apache.commons.math3.ode.events.EventState
Acknowledge the fact the step has been accepted by the integrator.
stepAccepted(FieldODEStateAndDerivative<T>) - Method in class org.apache.commons.math3.ode.events.FieldEventState
Acknowledge the fact the step has been accepted by the integrator.
StepFunction - Class in org.apache.commons.math3.analysis.function
StepFunction(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.function.StepFunction
Builds a step function from a list of arguments and the corresponding values.
StepHandler - Interface in org.apache.commons.math3.ode.sampling
This interface represents a handler that should be called after each successful step.
StepInterpolator - Interface in org.apache.commons.math3.ode.sampling
This interface represents an interpolator over the last step during an ODE integration.
StepNormalizer - Class in org.apache.commons.math3.ode.sampling
This class wraps an object implementing FixedStepHandler into a StepHandler.
StepNormalizer(double, FixedStepHandler) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
Simple constructor.
StepNormalizer(double, FixedStepHandler, StepNormalizerMode) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
Simple constructor.
StepNormalizer(double, FixedStepHandler, StepNormalizerBounds) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
Simple constructor.
StepNormalizer(double, FixedStepHandler, StepNormalizerMode, StepNormalizerBounds) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
Simple constructor.
StepNormalizerBounds - Enum in org.apache.commons.math3.ode.sampling
Step normalizer bounds settings.
StepNormalizerMode - Enum in org.apache.commons.math3.ode.sampling
steradian - Static variable in class cern.clhep.Units
 
STICKS - Static variable in class jplot.LinePars
 
stirlingCorrection(int) - Static method in class cern.jet.math.Arithmetic
Returns the StirlingCorrection.
stirlingFormula(double) - Static method in class jhplot.stat.Statistics
Returns the Gamma function computed by Stirling's formula.
stirlingS2(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
stirlingS2(int, int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Returns the Stirling number of the second kind, "S(n,k)", the number of ways of partitioning an n-element set into k non-empty subsets.
StObservable() - Constructor for class org.nfunk.jep.SymbolTable.StObservable
 
stop() - Method in class cern.colt.Timer
Stops the timer.
stop() - Method in class jminhep.utils.StopWatch
Stop this StopWatch object.
stop() - Method in class org.apache.commons.io.input.Tailer
Allows the tailer to complete its current loop and return.
stop() - Method in class org.apache.commons.io.monitor.FileAlterationMonitor
Stops monitoring.
stop(long) - Method in class org.apache.commons.io.monitor.FileAlterationMonitor
Stops monitoring.
stop() - Method in class org.apache.commons.math3.ode.events.EventState
Check if the integration should be stopped at the end of the current step.
stop() - Method in class org.apache.commons.math3.ode.events.FieldEventState
Check if the integration should be stopped at the end of the current step.
stopCellEditing() - Method in class jplot.panels.PanelPlot.ButtonEditor
 
StoppingCondition - Interface in org.apache.commons.math3.genetics
Algorithm used to determine when to stop evolution.
StopWatch - Class in jminhep.utils
The StopWatch class represents a very simple stop watch that can be used to time events.
StopWatch() - Constructor for class jminhep.utils.StopWatch
Construct a new StopWatch object.
StorelessCovariance - Class in org.apache.commons.math3.stat.correlation
Covariance implementation that does not require input data to be stored in memory.
StorelessCovariance(int) - Constructor for class org.apache.commons.math3.stat.correlation.StorelessCovariance
Create a bias corrected covariance matrix with a given dimension.
StorelessCovariance(int, boolean) - Constructor for class org.apache.commons.math3.stat.correlation.StorelessCovariance
Create a covariance matrix with a given number of rows and columns and the indicated bias correction.
StorelessUnivariateStatistic - Interface in org.apache.commons.math3.stat.descriptive
Extends the definition of UnivariateStatistic with StorelessUnivariateStatistic.increment(double) and StorelessUnivariateStatistic.incrementAll(double[]) methods for adding values and updating internal state.
storeTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Store the current step time.
STP_Pressure - Static variable in class cern.clhep.PhysicalConstants
 
STP_Temperature - Static variable in class cern.clhep.PhysicalConstants
 
Str - Class in org.nfunk.jep.function
Converts an object into its string representation.
Str() - Constructor for class org.nfunk.jep.function.Str
 
strategy() - Method in class org.freehep.math.minuit.MnApplication
 
strategy() - Method in class org.freehep.math.minuit.MnStrategy
 
StrictFastMath - Class in net.jafama
Strict version of FastMath (and not a fast version of StrictMath, which would rather be called FastStrictMath), through delegation to StrictMath (instead of Math) and use of strictfp.
strictlyNegative() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is strictly less than 0.
strictlyPositive() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is strictly greater than 0.
STRING - Static variable in class graph.ScanWord
Token returned when a string has been found.
STRING_LITERAL - Static variable in interface org.nfunk.jep.ParserConstants
 
StringBuilderWriter - Class in org.apache.commons.io.output
Writer implementation that outputs to a StringBuilder.
StringBuilderWriter() - Constructor for class org.apache.commons.io.output.StringBuilderWriter
Constructs a new StringBuilder instance with default capacity.
StringBuilderWriter(int) - Constructor for class org.apache.commons.io.output.StringBuilderWriter
Constructs a new StringBuilder instance with the specified capacity.
StringBuilderWriter(StringBuilder) - Constructor for class org.apache.commons.io.output.StringBuilderWriter
Constructs a new instance with the specified StringBuilder.
stringDirectoryFromPath(String) - Method in class org.jlab.groot.data.Directory
 
stringObjectFromPath(String) - Method in class org.jlab.groot.data.Directory
 
StringPrintable - Interface in jhplot.math.io
BSD License
stringSize(String, Graphics) - Static method in class jplot.Axis
handy little utility for determining the length in pixels the given string will use if drawn into the given Graphics object.
StringUtil - Class in jminhep.utils
StringUtil - String utility class
StringUtil() - Constructor for class jminhep.utils.StringUtil
 
StrokeMap - Class in org.jfree.chart
A storage structure that maps Comparable instances with Stroke instances.
StrokeMap() - Constructor for class org.jfree.chart.StrokeMap
Creates a new (empty) map.
StudentT - Class in cern.jet.random
StudentT distribution (aka T-distribution); See the math definition and animated definition.
StudentT(double, RandomEngine) - Constructor for class cern.jet.random.StudentT
Constructs a StudentT distribution.
studentT(double, double) - Static method in class cern.jet.stat.Probability
Returns the integral from minus infinity to t of the Student-t distribution with k > 0 degrees of freedom.
studentTInverse(double, int) - Static method in class cern.jet.stat.Probability
Returns the value, t, for which the area under the Student-t probability density function (integrated from minus infinity to t) is equal to 1-alpha/2.
StudioDesktop - Class in org.jlab.groot.studio
 
StudioDesktop() - Constructor for class org.jlab.groot.studio.StudioDesktop
 
StudioToolBar - Class in org.jlab.groot.studio
 
StudioToolBar(ActionListener) - Constructor for class org.jlab.groot.studio.StudioToolBar
 
StudioUI - Class in org.jlab.groot.studio
 
StudioUI() - Constructor for class org.jlab.groot.studio.StudioUI
 
StudioUI(TreeProvider) - Constructor for class org.jlab.groot.studio.StudioUI
 
Style - Static variable in class jminhep.gui.SetEnv
 
styleChooser - Variable in class jplot.JPlot
 
StyleChooser - Class in jplot
StyleChooser is a class which enables the user to set the drawing style.
StyleChooser(Frame, String, LinePars, JPlot, boolean) - Constructor for class jplot.StyleChooser
Principal constructor.
StyleChooser(Frame, String, LinePars) - Constructor for class jplot.StyleChooser
Constructor.
StyleChooser(Frame, String, boolean) - Constructor for class jplot.StyleChooser
Principal constructor.
StyleChooser(Frame, String) - Constructor for class jplot.StyleChooser
Another constructor.
sub(Matrix, Matrix) - Static method in class hep.physics.matrix.MatrixOp
Subtract matrix b from matrix a.
sub(Hep3Vector, Hep3Vector) - Static method in class hep.physics.vec.VecOp
 
sub(HepLorentzVector, HepLorentzVector) - Static method in class hep.physics.vec.VecOp
 
sub(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Subtract
sub(Hep3Vector, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Subtract
sub(HepLorentzVector, HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Subtract 2 vectors
sub(Hep3Vector, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
sub(LorentzVector) - Method in class j4np.physics.LorentzVector
 
sub(double, double, double, double) - Method in class j4np.physics.LorentzVector
 
sub(Vector3) - Method in class j4np.physics.Vector3
 
sub(double, double, double) - Method in class j4np.physics.Vector3
 
sub(Object, Object) - Method in class org.lsmp.djep.groupJep.function.GSubtract
 
sub(Number, Number) - Method in interface org.lsmp.djep.groupJep.GroupI
Get the difference of the numbers.
sub(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.BigReals
 
sub(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
sub(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Integers
 
sub(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.PermutationGroup
 
sub(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Quaternions
 
sub(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
sub(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Reals
 
sub(Number, Number) - Method in class org.lsmp.djep.groupJep.groups.Zn
 
sub(Permutation) - Method in class org.lsmp.djep.groupJep.values.Permutation
 
sub(Polynomial) - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
sub(Rational) - Method in class org.lsmp.djep.groupJep.values.Rational
 
SUB - Static variable in class org.lsmp.djep.rpe.RpEval
 
sub(PNodeI) - Method in class org.lsmp.djep.sjep.AbstractPNode
 
sub(PNodeI) - Method in class org.lsmp.djep.sjep.Monomial
 
sub(PNodeI) - Method in class org.lsmp.djep.sjep.PConstant
 
sub(PNodeI) - Method in interface org.lsmp.djep.sjep.PNodeI
Subtracts the argument from this.
sub(PNodeI) - Method in class org.lsmp.djep.sjep.Polynomial
 
sub(Polynomial) - Method in class org.lsmp.djep.sjep.Polynomial
 
sub(Object, Object) - Method in class org.lsmp.djep.vectorJep.function.MSubtract
Adds two objects.
sub(MVector, MVector) - Method in class org.lsmp.djep.vectorJep.function.MSubtract
Adds two vectors.
sub(Matrix, Matrix) - Method in class org.lsmp.djep.vectorJep.function.MSubtract
Adds two matrices.
sub(Tensor, Tensor) - Method in class org.lsmp.djep.vectorJep.function.MSubtract
Adds two matrices.
sub(Object, Object) - Method in class org.nfunk.jep.function.Subtract
 
sub(Number, Number) - Method in class org.nfunk.jep.function.Subtract
 
sub(Complex, Complex) - Method in class org.nfunk.jep.function.Subtract
 
sub(Complex, Number) - Method in class org.nfunk.jep.function.Subtract
 
sub(Number, Complex) - Method in class org.nfunk.jep.function.Subtract
 
sub(Complex) - Method in class org.nfunk.jep.type.Complex
Adds the complex number with another complex value.
subAndCheck(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Subtract two integers, checking for overflow.
subAndCheck(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Subtract two long integers, checking for overflow.
SubCategoryAxis - Class in org.jfree.chart.axis
A specialised category axis that can display sub-categories.
SubCategoryAxis(String) - Constructor for class org.jfree.chart.axis.SubCategoryAxis
Creates a new axis.
SubCircle - Class in org.apache.commons.math3.geometry.spherical.twod
This class represents a sub-hyperplane for Circle.
SubCircle(Hyperplane<Sphere2D>, Region<Sphere1D>) - Constructor for class org.apache.commons.math3.geometry.spherical.twod.SubCircle
Simple constructor.
SubHyperplane<S extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface represents the remaining parts of an hyperplane after other parts have been chopped off.
SubHyperplane.SplitSubHyperplane<U extends Space> - Class in org.apache.commons.math3.geometry.partitioning
Class holding the results of the split method.
SubLimitAngle - Class in org.apache.commons.math3.geometry.spherical.oned
This class represents sub-hyperplane for LimitAngle.
SubLimitAngle(Hyperplane<Sphere1D>, Region<Sphere1D>) - Constructor for class org.apache.commons.math3.geometry.spherical.oned.SubLimitAngle
Simple constructor.
SubLine - Class in org.apache.commons.math3.geometry.euclidean.threed
This class represents a subset of a Line.
SubLine(Line, IntervalsSet) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubLine
Simple constructor.
SubLine(Vector3D, Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubLine
Create a sub-line from two endpoints.
SubLine(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubLine
Deprecated.
SubLine(Segment) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubLine
Create a sub-line from a segment.
SubLine - Class in org.apache.commons.math3.geometry.euclidean.twod
This class represents a sub-hyperplane for Line.
SubLine(Hyperplane<Euclidean2D>, Region<Euclidean1D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Simple constructor.
SubLine(Vector2D, Vector2D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Create a sub-line from two endpoints.
SubLine(Vector2D, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Deprecated.
SubLine(Segment) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Create a sub-line from a segment.
subMatrix(DoubleMatrix2D, int, int, int, int) - Method in class cern.colt.matrix.linalg.Algebra
Constructs and returns a new sub-range view which is the sub matrix A[fromRow..toRow,fromColumn..toColumn].
SubOrientedPoint - Class in org.apache.commons.math3.geometry.euclidean.oned
This class represents sub-hyperplane for OrientedPoint.
SubOrientedPoint(Hyperplane<Euclidean1D>, Region<Euclidean1D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
Simple constructor.
SubPlane - Class in org.apache.commons.math3.geometry.euclidean.threed
This class represents a sub-hyperplane for Plane.
SubPlane(Hyperplane<Euclidean3D>, Region<Euclidean2D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubPlane
Simple constructor.
SubSeriesDataset - Class in org.jfree.data.general
Deprecated.
As of version 1.0.13. This class will be removed from JFreeChart 1.2.0 onwards. Anyone needing this facility will need to maintain it outside of JFreeChart.
SubSeriesDataset(SeriesDataset, int[]) - Constructor for class org.jfree.data.general.SubSeriesDataset
Deprecated.
Creates a SubSeriesDataset using one or more series from parent.
SubSeriesDataset(SeriesDataset, int) - Constructor for class org.jfree.data.general.SubSeriesDataset
Deprecated.
Creates a SubSeriesDataset using one series from parent.
substitute(Node, String, Node, XJep) - Method in class org.lsmp.djep.xjep.SubstitutionVisitor
Substitutes all occurrences of variable var with replacement.
substitute(Node, String[], Node[], XJep) - Method in class org.lsmp.djep.xjep.SubstitutionVisitor
Substitutes all occurrences of a set of variable var with a set of replacements.
substitute(Node, String, Node) - Method in class org.lsmp.djep.xjep.XJep
Substitute all occurrences of a named variable with an expression tree.
substitute(Node, String[], Node[]) - Method in class org.lsmp.djep.xjep.XJep
Substitute all occurrences of a set of named variable with a set of expression tree.
substituteMostRecentElement(double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Substitutes value for the most recently added value.
substituteText(String, String, String) - Static method in class jhepsim.Util
Renders a string based on text where any occurence of token is replaced by substitute.
substituteText(String, String, String) - Static method in class jhplot.utils.Util
Renders a string based on text where any occurence of token is replaced by substitute.
substituteText(String, String, String) - Static method in class jminhep.utils.Util
Renders a string based on text where any occurence of token is replaced by substitute.
substituteTextS(String, String, String) - Static method in class jhepsim.Util
Renders a string based on text where any occurence of token is replaced by substitute.
substituteTextS(String, String, String) - Static method in class jhplot.utils.Util
Renders a string based on text where any occurence of token is replaced by substitute.
substituteTextS(String, String, String) - Static method in class jminhep.utils.Util
Renders a string based on text where any occurence of token is replaced by substitute.
SubstitutionVisitor - Class in org.lsmp.djep.xjep
Allows substitution of a given variable with an expression tree.
SubstitutionVisitor() - Constructor for class org.lsmp.djep.xjep.SubstitutionVisitor
 
substTokens - Static variable in class jminhep.utils.ResourceLoader
 
subtract(double[], double[]) - Static method in class jhplot.math.ArrayMathUtils
Subtracts the two arrays together (componentwise)
subtract(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Subtracts the two arrays together (componentwise).
subtract(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'-' operator.
subtract(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute this - a.
subtract(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Perform subtraction of two derivative structures.
subtract(SparseGradient) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Compute this - a.
subtract(double) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
'-' operator.
Subtract - Class in org.apache.commons.math3.analysis.function
Subtract the second operand from the first.
Subtract() - Constructor for class org.apache.commons.math3.analysis.function.Subtract
 
subtract(PolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Subtract a polynomial from the instance.
subtract(Complex) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this - subtrahend).
subtract(double) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this - subtrahend).
subtract(Quaternion, Quaternion) - Static method in class org.apache.commons.math3.complex.Quaternion
Subtracts two quaternions.
subtract(Quaternion) - Method in class org.apache.commons.math3.complex.Quaternion
Subtracts a quaternion from the instance.
subtract(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Subtract x from this.
subtract(double) - Method in class org.apache.commons.math3.dfp.Dfp
'-' operator.
subtract(T) - Method in interface org.apache.commons.math3.FieldElement
Compute this - a.
subtract(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
Subtracts the value of an BigInteger from the value of this BigFraction, returning the result in reduced form.
subtract(int) - Method in class org.apache.commons.math3.fraction.BigFraction
Subtracts the value of an integer from the value of this BigFraction, returning the result in reduced form.
subtract(long) - Method in class org.apache.commons.math3.fraction.BigFraction
Subtracts the value of a long from the value of this BigFraction, returning the result in reduced form.
subtract(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
Subtracts the value of another fraction from the value of this one, returning the result in reduced form.
subtract(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
Subtracts the value of another fraction from the value of this one, returning the result in reduced form.
subtract(int) - Method in class org.apache.commons.math3.fraction.Fraction
Subtract an integer from the fraction.
subtract(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Subtract a vector from the instance.
subtract(double, Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Subtract a scaled vector from the instance.
subtract(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a vector from the instance.
subtract(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a vector from the instance.
subtract(T, FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a scaled vector from the instance.
subtract(T, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a scaled vector from the instance.
subtract(double, FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a scaled vector from the instance.
subtract(double, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a scaled vector from the instance.
subtract(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Subtract a vector from the instance.
subtract(double, Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Subtract a scaled vector from the instance.
subtract(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Subtract a vector from the instance.
subtract(double, Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Subtract a scaled vector from the instance.
subtract(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Subtract a vector from the instance.
subtract(double, Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Subtract a scaled vector from the instance.
subtract(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Subtract m from this matrix.
subtract(RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns this minus m.
subtract(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Subtract m from this matrix.
subtract(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns this minus m.
subtract(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute this minus v.
subtract(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute this minus v.
subtract(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Subtract v from this vector.
subtract(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Subtract m from this matrix.
subtract(BlockFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Compute this - m.
subtract(RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns this minus m.
subtract(BlockRealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Subtract m from this matrix.
subtract(DiagonalMatrix) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns this minus m.
subtract(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Subtract m from this matrix.
subtract(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Compute this minus v.
subtract(RealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Returns this minus m.
subtract(OpenMapRealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Subtract m from this matrix.
subtract(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Optimized method to subtract OpenMapRealVectors.
subtract(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Subtract v from this vector.
subtract(RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns this minus m.
subtract(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Subtract v from this vector.
subtract(SparseFieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Optimized method to compute this minus v.
subtract(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Compute this minus v.
subtract(double) - Method in interface org.apache.commons.math3.RealFieldElement
'-' operator.
subtract(BigReal) - Method in class org.apache.commons.math3.util.BigReal
Compute this - a.
subtract(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute this - a.
subtract(double) - Method in class org.apache.commons.math3.util.Decimal64
'-' operator.
subtract(StatNumber) - Method in class org.jlab.groot.math.StatNumber
Subtracts the parameter from the current object
Subtract - Class in org.nfunk.jep.function
 
Subtract() - Constructor for class org.nfunk.jep.function.Subtract
 
SubtractDiffRule - Class in org.lsmp.djep.djep.diffRules
Diffrentiates a subtaction with respect to var.
SubtractDiffRule(String) - Constructor for class org.lsmp.djep.djep.diffRules.SubtractDiffRule
 
subtractExact(int, int) - Static method in class org.apache.commons.math3.util.FastMath
Subtract two numbers, detecting overflows.
subtractExact(long, long) - Static method in class org.apache.commons.math3.util.FastMath
Subtract two numbers, detecting overflows.
SUCCESS - Static variable in interface hep.lcio.event.LCIO
 
SUCCESS - Static variable in class jhplot.math.exp4j.ValidationResult
A static class representing a successful validation result
suffixFileFilter(String) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that returns true if the file name ends with the specified text.
suffixFileFilter(String, IOCase) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that returns true if the file name ends with the specified text.
SuffixFileFilter - Class in org.apache.commons.io.filefilter
Filters files based on the suffix (what the file name ends with).
SuffixFileFilter(String) - Constructor for class org.apache.commons.io.filefilter.SuffixFileFilter
Constructs a new Suffix file filter for a single extension.
SuffixFileFilter(String, IOCase) - Constructor for class org.apache.commons.io.filefilter.SuffixFileFilter
Constructs a new Suffix file filter for a single extension specifying case-sensitivity.
SuffixFileFilter(String...) - Constructor for class org.apache.commons.io.filefilter.SuffixFileFilter
Constructs a new Suffix file filter for an array of suffixes.
SuffixFileFilter(String[], IOCase) - Constructor for class org.apache.commons.io.filefilter.SuffixFileFilter
Constructs a new Suffix file filter for an array of suffixes specifying case-sensitivity.
SuffixFileFilter(List<String>) - Constructor for class org.apache.commons.io.filefilter.SuffixFileFilter
Constructs a new Suffix file filter for a list of suffixes.
SuffixFileFilter(List<String>, IOCase) - Constructor for class org.apache.commons.io.filefilter.SuffixFileFilter
Constructs a new Suffix file filter for a list of suffixes specifying case-sensitivity.
SUFIX - Static variable in class org.lsmp.djep.xjep.XOperator
postfix operators x%, if neiter prefix and postif then infix, if both trifix like x?y:z
suite() - Static method in class org.lsmp.djepJUnit.AllTests
 
suite() - Static method in class org.lsmp.djepJUnit.DJepTest
 
suite() - Static method in class org.lsmp.djepJUnit.GroupJepTest
 
suite() - Static method in class org.lsmp.djepJUnit.JepTest
Create a test suite.
suite() - Static method in class org.lsmp.djepJUnit.MatrixJepTest
Create a test suite.
suite() - Static method in class org.lsmp.djepJUnit.MRpTest
 
suite() - Static method in class org.lsmp.djepJUnit.RewriteTest
 
suite() - Static method in class org.lsmp.djepJUnit.RpTest
 
suite() - Static method in class org.lsmp.djepJUnit.SJepTest
 
suite() - Static method in class org.lsmp.djepJUnit.VectorJepTest
Create a test suite.
suite() - Static method in class org.lsmp.djepJUnit.XJepTest
 
suite() - Static method in class org.nfunk.jeptesting.AllTests
 
sum() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.sum().
sum() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum() - Method in class cern.hep.aida.bin.StaticBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the sum of a data sequence.
sum(double[]) - Static method in class jhplot.math.DoubleArray
Calculate the sum of the values in an array
sum(double[][]) - Static method in class jhplot.math.DoubleArray
Calculates the sum of each column in a matrix.
sum(float[]) - Static method in class jhplot.stat.StatUtils
sum(1) computes summation of all values in vector v.
sum(float[][]) - Static method in class jhplot.stat.StatUtils
sum(1) computes summation of all values in matrix m.
sum(float[], float[]) - Static method in class jhplot.stat.StatUtils
sum(2) computes the sum of the elements of vector v only where the mask value is not 0.
sum(double[]) - Static method in class jhplot.stat.StatUtils
Compute average of all values in vector v.
sum(int[]) - Static method in class jminhep.utils.ArrayOps
#7 Compute and return the sum of all of the elements of nums.
Sum - Class in org.apache.commons.math3.stat.descriptive.summary
Returns the sum of the available values.
Sum() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Sum
Create a Sum instance
Sum(Sum) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Sum
Copy constructor, creates a new Sum identical to the original
sum(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the sum of the values in the input array, or Double.NaN if the array is empty.
sum(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the sum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
Sum - Class in org.lsmp.djep.xjep.function
A sum function Sum(x^2,x,1,10) finds the sum of x^2 with x running from 1 to 10.
Sum(JEP) - Constructor for class org.lsmp.djep.xjep.function.Sum
 
Sum - Class in org.nfunk.jep.function
This class serves mainly as an example of a function that accepts any number of parameters.
Sum() - Constructor for class org.nfunk.jep.function.Sum
Constructor.
sumAllBinHeights() - Method in class cern.hep.aida.ref.Histogram2D
 
sumAllBinHeights() - Method in class cern.hep.aida.ref.Histogram3D
 
sumAllBinHeights() - Method in interface colt.hep.aida.IHistogram
Sum of all (both in-range and under/overflow) bin heights in the histogram.
sumAllBinHeights() - Method in class jhplot.H1D
Sum of all heights
sumAllBinHeights() - Method in class jhplot.H2D
Get the sum of the bin heights for all the entries, in-range and out-range ones.
sumAllBinHeights() - Method in class jhplot.HProf1D
Sum of all heights
sumAllBinHeights() - Method in class jhplot.HProf2D
Get the sum of the bin heights for all the entries, in-range and out-range ones.
sumBinHeights() - Method in interface colt.hep.aida.IHistogram
Sum of in-range bin heights in the histogram.
sumDifference(double[], double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the sum of the (signed) differences between corresponding elements of the input arrays -- i.e., sum(sample1[i] - sample2[i]).
sumExtraBinHeights() - Method in interface colt.hep.aida.IHistogram
Sum of under/overflow bin heights in the histogram.
sumExtraBinHeights() - Method in class jhplot.H2D
Get the sum of the bin heights for all the entries outside the Histogram's range.
sumExtraBinHeights() - Method in class jhplot.HProf2D
Get the sum of the bin heights for all the entries outside the Histogram's range.
sumLog - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.sumOfLogarithms().
sumLog(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the sum of the natural logs of the entries in the input array, or Double.NaN if the array is empty.
sumLog(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the sum of the natural logs of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
summary - Static variable in class jminhep.clcontrol.Global
 
Summary() - Static method in class jminhep.clcontrol.Global
 
SUMMARY_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H2D
 
SummaryPad - Class in jminhep.clcontrol
Editor with summary
SummaryPad() - Constructor for class jminhep.clcontrol.SummaryPad
 
SummaryPad.padPanel - Class in jminhep.clcontrol
 
SummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
Computes summary statistics for a stream of data values added using the addValue method.
SummaryStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Construct a SummaryStatistics instance
SummaryStatistics(SummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.SummaryStatistics
A copy constructor.
SumOfClusterVariances<T extends Clusterable> - Class in org.apache.commons.math3.ml.clustering.evaluation
Computes the sum of intra-cluster distance variances according to the formula:
SumOfClusterVariances(DistanceMeasure) - Constructor for class org.apache.commons.math3.ml.clustering.evaluation.SumOfClusterVariances
 
sumOfInversions() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the sum of inversions, which is Sum( 1 / x[i] ).
sumOfInversions() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the sum of inversions, which is Sum( 1 / x[i] ).
sumOfInversions(DoubleArrayList, int, int) - Static method in class cern.jet.stat.Descriptive
Returns the sum of inversions of a data sequence, which is Sum( 1.0 / data[i]).
sumOfLogarithms() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the sum of logarithms, which is Sum( Log(x[i]) ).
sumOfLogarithms() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the sum of logarithms, which is Sum( Log(x[i]) ).
sumOfLogarithms(DoubleArrayList, int, int) - Static method in class cern.jet.stat.Descriptive
Returns the sum of logarithms of a data sequence, which is Sum( Log(data[i]).
SumOfLogs - Class in org.apache.commons.math3.stat.descriptive.summary
Returns the sum of the natural logs for this collection of values.
SumOfLogs() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Create a SumOfLogs instance
SumOfLogs(SumOfLogs) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Copy constructor, creates a new SumOfLogs identical to the original
sumOfPowerDeviations(DoubleArrayList, int, double) - Static method in class cern.jet.stat.Descriptive
Returns Sum( (data[i]-c)k ); optimized for common parameters like c == 0.0 and/or k == -2 ..
sumOfPowerDeviations(DoubleArrayList, int, double, int, int) - Static method in class cern.jet.stat.Descriptive
Returns Sum( (data[i]-c)k ) for all i = from ..
sumOfPowers(int) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the k-th order sum of powers, which is Sum( x[i]k ).
sumOfPowers(int) - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the k-th order sum of powers, which is Sum( x[i]k ).
sumOfPowers(DoubleArrayList, int) - Static method in class cern.jet.stat.Descriptive
Returns the sum of powers of a data sequence, which is Sum ( data[i]k ).
sumOfSquaredDeviations(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the sum of squared mean deviation of of a data sequence.
sumOfSquares() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
sumOfSquares() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
sumOfSquares() - Method in class cern.hep.aida.bin.StaticBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
sumOfSquares(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the sum of squares of a data sequence.
SumOfSquares - Class in org.apache.commons.math3.stat.descriptive.summary
Returns the sum of the squares of the available values.
SumOfSquares() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Create a SumOfSquares instance
SumOfSquares(SumOfSquares) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Copy constructor, creates a new SumOfSquares identical to the original
sumSq(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the sum of the squares of the entries in the input array, or Double.NaN if the array is empty.
sumSq(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the sum of the squares of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
sumSquares(double[]) - Static method in class jhplot.math.ArrayMathUtils
Sums the squares of all components; also called the energy of the array.
sumSquares(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Sums the squares of all components; also called the energy of the array.
sumSquares(int[]) - Static method in class jhplot.math.ArrayMathUtils
Sums the squares of all components; also called the energy of the array.
sumSquares(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Sums the squares of all components; also called the energy of the array.
SumType - Class in org.lsmp.djep.xjep.function
Base class for functions like Sum(x^2,x,1,10) which finds the sum of x^2 with x running from 1 to 10.
SumType(String) - Constructor for class org.lsmp.djep.xjep.function.SumType
 
SumType() - Constructor for class org.lsmp.djep.xjep.function.SumType
 
SunJPEGEncoderAdapter - Class in org.jfree.chart.encoders
Adapter class for the Sun JPEG Encoder.
SunJPEGEncoderAdapter() - Constructor for class org.jfree.chart.encoders.SunJPEGEncoderAdapter
Creates a new SunJPEGEncoderAdapter instance.
SunPNGEncoderAdapter - Class in org.jfree.chart.encoders
Adapter class for the Sun PNG Encoder.
SunPNGEncoderAdapter() - Constructor for class org.jfree.chart.encoders.SunPNGEncoderAdapter
 
SupportBallGenerator<S extends Space,P extends Point<S>> - Interface in org.apache.commons.math3.geometry.enclosing
Interface for generating balls based on support points.
supportsType(String) - Method in class root.RootStoreFactory
 
supportsType(String) - Method in class root.XrootdStoreFactory
 
SURFACE_VERTEX_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
SurfaceColor - Interface in jplot3d
Interface used by JSurface for every color.
surfaceColor - Variable in class jplot3dp.ModelView.ModelFunction
 
SurfaceModel - Interface in jplot3d
The model used to display any surface in JSurface
SurfaceModel.PlotColor - Enum in jplot3d
 
SurfaceModel.PlotType - Enum in jplot3d
 
SurfaceModelCanvas - Class in jplot3d
 
SurfaceModelCanvas() - Constructor for class jplot3d.SurfaceModelCanvas
 
SurfaceModelCanvas.Plotter - Interface in jplot3d
 
SurfaceModelCanvas.PlotterImpl - Class in jplot3d
Parses defined functions and calculates surface vertices
SurfaceVertex - Class in jplot3d
The class SurfaceVertex represents a vertex in 3D space.
SurfaceVertex(float, float, float) - Constructor for class jplot3d.SurfaceVertex
The constructor of SurfaceVertex.
sval - Variable in class graph.ScanString
 
svd() - Method in class Jama.Matrix
Singular Value Decomposition
SVDBased - Class in jhplot.math.pca.covmatrixevd
SVD-based covariance matrix eigenvalue decomposition
SVDBased() - Constructor for class jhplot.math.pca.covmatrixevd.SVDBased
 
swap(DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleMatrix1D
Swaps each element this[i] with other[i].
swap(DoubleMatrix1D) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Swaps each element this[i] with other[i].
swap(ObjectMatrix1D) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Swaps each element this[i] with other[i].
swap(ObjectMatrix1D) - Method in class cern.colt.matrix.ObjectMatrix1D
Swaps each element this[i] with other[i].
swap(int, int) - Method in interface cern.colt.Swapper
Swaps the generic data g[a] with g[b].
Swap - Class in Jampack
Swap interchanges rows and columns of a matrix.
Swap() - Constructor for class Jampack.Swap
 
swapArgs(DoubleDoubleFunction) - Static method in class cern.jet.math.Functions
Constructs a function that returns function.apply(b,a), i.e.
swapArgs(IntIntFunction) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns function.apply(b,a), i.e.
swapDouble(double) - Static method in class org.apache.commons.io.EndianUtils
Converts a "double" value between endian systems.
swapElements(int[], int, int) - Static method in class jminhep.utils.ArrayOps
#11 Swap the element at index i of nums with the element at index j.
swapFloat(float) - Static method in class org.apache.commons.io.EndianUtils
Converts a "float" value between endian systems.
swapInteger(int) - Static method in class org.apache.commons.io.EndianUtils
Converts a "int" value between endian systems.
swapLong(long) - Static method in class org.apache.commons.io.EndianUtils
Converts a "long" value between endian systems.
SwappedDataInputStream - Class in org.apache.commons.io.input
DataInput for systems relying on little endian data formats.
SwappedDataInputStream(InputStream) - Constructor for class org.apache.commons.io.input.SwappedDataInputStream
Constructs a SwappedDataInputStream.
swappedElements - Static variable in class cern.colt.Partitioning
 
Swapper - Interface in cern.colt
Interface for an object that knows how to swap elements at two positions (a,b).
swapShort(short) - Static method in class org.apache.commons.io.EndianUtils
Converts a "short" value between endian systems.
switchedPow10(double) - Method in class org.jfree.chart.axis.LogarithmicAxis
Returns a power of 10, depending on if values between 0 and 1 are being plotted.
switchGraphType(int) - Method in class jplot.JPlot
Switch from one graph type to another.
SwitchTo(int) - Method in class jplot3dp.MathParser.MathParserTokenManager
 
SwitchTo(int) - Method in class org.nfunk.jep.ParserTokenManager
 
SymbolAxis - Class in org.jfree.chart.axis
A standard linear value axis that replaces integer values with symbols.
SymbolAxis(String, String[]) - Constructor for class org.jfree.chart.axis.SymbolAxis
Constructs a symbol axis, using default attribute values where necessary.
SymbolicXYItemLabelGenerator - Class in org.jfree.chart.labels
A standard item label generator for plots that use data from an XYDataset.
SymbolicXYItemLabelGenerator() - Constructor for class org.jfree.chart.labels.SymbolicXYItemLabelGenerator
 
SymbolTable - Class in org.nfunk.jep
A Hashtable which holds a list of all variables.
SymbolTable(VariableFactory) - Constructor for class org.nfunk.jep.SymbolTable
SymbolTable should always be constructed an associated variable factory.
SymbolTable.StObservable - Class in org.nfunk.jep
 
SYMMETRIC - Static variable in class org.lsmp.djep.xjep.XOperator
Symmetric relation x=y implies y=x.
SymmetricGaussIntegrator - Class in org.apache.commons.math3.analysis.integration.gauss
This class's implements integrate method assuming that the integral is symmetric about 0.
SymmetricGaussIntegrator(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.integration.gauss.SymmetricGaussIntegrator
Creates an integrator from the given points and weights.
SymmetricGaussIntegrator(Pair<double[], double[]>) - Constructor for class org.apache.commons.math3.analysis.integration.gauss.SymmetricGaussIntegrator
Creates an integrator from the given pair of points (first element of the pair) and weights (second element of the pair.
SymmetricMatrix - Class in hep.physics.matrix
A simple implementation of a symmetric matrix.
SymmetricMatrix(int) - Constructor for class hep.physics.matrix.SymmetricMatrix
Creates a new instance of SymmetricMatrix with all elements set to zero.
SymmetricMatrix(Matrix) - Constructor for class hep.physics.matrix.SymmetricMatrix
Construct a SymmetricMatrix by copying an existing matrix.
SymmetricMatrix(int, double[], boolean) - Constructor for class hep.physics.matrix.SymmetricMatrix
Creates a new instance of SymmetricMatrix with the given initial values.
SymmetricMatrix - Class in hephysics.matrix
A simple implementation of a symmetric matrix.
SymmetricMatrix(int) - Constructor for class hephysics.matrix.SymmetricMatrix
Creates a new instance of SymmetricMatrix with all elements set to zero.
SymmetricMatrix(Matrix) - Constructor for class hephysics.matrix.SymmetricMatrix
Construct a SymmetricMatrix by copying an existing matrix.
SymmetricMatrix(int, double[], boolean) - Constructor for class hephysics.matrix.SymmetricMatrix
Creates a new instance of SymmetricMatrix with the given initial values.
SymmLQ - Class in org.apache.commons.math3.linear
Implementation of the SYMMLQ iterative linear solver proposed by Paige and Saunders (1975).
SymmLQ(int, double, boolean) - Constructor for class org.apache.commons.math3.linear.SymmLQ
Creates a new instance of this class, with default stopping criterion.
SymmLQ(IterationManager, double, boolean) - Constructor for class org.apache.commons.math3.linear.SymmLQ
Creates a new instance of this class, with default stopping criterion and custom iteration manager.
SynchronizedDescriptiveStatistics - Class in org.apache.commons.math3.stat.descriptive
Implementation of DescriptiveStatistics that is safe to use in a multithreaded environment.
SynchronizedDescriptiveStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Construct an instance with infinite window
SynchronizedDescriptiveStatistics(int) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Construct an instance with finite window
SynchronizedDescriptiveStatistics(SynchronizedDescriptiveStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
A copy constructor.
SynchronizedMultivariateSummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
Implementation of MultivariateSummaryStatistics that is safe to use in a multithreaded environment.
SynchronizedMultivariateSummaryStatistics(int, boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Construct a SynchronizedMultivariateSummaryStatistics instance
SynchronizedRandomGenerator - Class in org.apache.commons.math3.random
Any RandomGenerator implementation can be thread-safe if it is used through an instance of this class.
SynchronizedRandomGenerator(RandomGenerator) - Constructor for class org.apache.commons.math3.random.SynchronizedRandomGenerator
Creates a synchronized wrapper for the given RandomGenerator instance.
SynchronizedSummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
Implementation of SummaryStatistics that is safe to use in a multithreaded environment.
SynchronizedSummaryStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Construct a SynchronizedSummaryStatistics instance
SynchronizedSummaryStatistics(SynchronizedSummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
A copy constructor.
SYSTEM_ERROR - Static variable in interface jminhep.gui.Constants
 
SYSTEM_FONT - Static variable in interface jminhep.gui.Constants
 

T

t() - Method in class hep.physics.vec.BasicHepLorentzVector
 
t() - Method in interface hep.physics.vec.HepLorentzVector
 
t() - Method in class hephysics.vec.HepLorentzVector
Get time
T - Variable in class Jampack.Schur
The upper triangular matrix.
t(double, double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
t(double, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
t(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
t(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
t(double, double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a t statistic given observed values and a comparison constant.
t(double, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a t statistic to use in comparing the mean of the dataset described by sampleStats to mu.
t(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a 2-sample t statistic, without the hypothesis of equal subpopulation variances.
t(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a 2-sample t statistic , comparing the means of the datasets described by two StatisticalSummary instances, without the assumption of equal subpopulation variances.
T_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
T_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
T_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
table - Variable in class jminhep.clcontrol.TableOptions
 
table - Variable in class jminhep.clcontrol.TableResults
 
table - Variable in class jminhep.clcontrol.TableSettings
 
table - Variable in class jminhep.gui.TableSummary
 
TableOptions - Class in jminhep.clcontrol
TableToolTipsDemo is just like TableDemo except that it sets up tool tips for both cells and column headers.
TableOptions() - Constructor for class jminhep.clcontrol.TableOptions
 
TableResults - Class in jminhep.clcontrol
 
TableResults() - Constructor for class jminhep.clcontrol.TableResults
 
TableSettings - Class in jminhep.clcontrol
Class to create a nice table
TableSettings() - Constructor for class jminhep.clcontrol.TableSettings
 
TableSummary - Class in jminhep.gui
 
TableSummary() - Constructor for class jminhep.gui.TableSummary
 
TableXYDataset - Interface in org.jfree.data.xy
A dataset containing one or more data series containing (x, y) data items, where all series in the dataset share the same set of x-values.
TaggedInputStream - Class in org.apache.commons.io.input
An input stream decorator that tags potential exceptions so that the stream that caused the exception can easily be identified.
TaggedInputStream(InputStream) - Constructor for class org.apache.commons.io.input.TaggedInputStream
Creates a tagging decorator for the given input stream.
TaggedIOException - Exception in org.apache.commons.io
An IOException decorator that adds a serializable tag to the wrapped exception.
TaggedIOException(IOException, Serializable) - Constructor for exception org.apache.commons.io.TaggedIOException
Creates a tagged wrapper for the given exception.
TaggedOutputStream - Class in org.apache.commons.io.output
An output stream decorator that tags potential exceptions so that the stream that caused the exception can easily be identified.
TaggedOutputStream(OutputStream) - Constructor for class org.apache.commons.io.output.TaggedOutputStream
Creates a tagging decorator for the given output stream.
TaggedReader - Class in org.apache.commons.io.input
A reader decorator that tags potential exceptions so that the reader that caused the exception can easily be identified.
TaggedReader(Reader) - Constructor for class org.apache.commons.io.input.TaggedReader
Creates a tagging decorator for the given reader.
TaggedWriter - Class in org.apache.commons.io.output
A writer decorator that tags potential exceptions so that the reader that caused the exception can easily be identified.
TaggedWriter(Writer) - Constructor for class org.apache.commons.io.output.TaggedWriter
Creates a tagging decorator for the given writer.
Tailer - Class in org.apache.commons.io.input
Simple implementation of the unix "tail -f" functionality.
Tailer(File, TailerListener) - Constructor for class org.apache.commons.io.input.Tailer
Creates a Tailer for the given file, starting from the beginning, with the default delay of 1.0s.
Tailer(File, TailerListener, long) - Constructor for class org.apache.commons.io.input.Tailer
Creates a Tailer for the given file, starting from the beginning.
Tailer(File, TailerListener, long, boolean) - Constructor for class org.apache.commons.io.input.Tailer
Creates a Tailer for the given file, with a delay other than the default 1.0s.
Tailer(File, TailerListener, long, boolean, boolean) - Constructor for class org.apache.commons.io.input.Tailer
Creates a Tailer for the given file, with a delay other than the default 1.0s.
Tailer(File, TailerListener, long, boolean, int) - Constructor for class org.apache.commons.io.input.Tailer
Creates a Tailer for the given file, with a specified buffer size.
Tailer(File, TailerListener, long, boolean, boolean, int) - Constructor for class org.apache.commons.io.input.Tailer
Creates a Tailer for the given file, with a specified buffer size.
Tailer(File, Charset, TailerListener, long, boolean, boolean, int) - Constructor for class org.apache.commons.io.input.Tailer
Creates a Tailer for the given file, with a specified buffer size.
TailerListener - Interface in org.apache.commons.io.input
Listener for events from a Tailer.
TailerListenerAdapter - Class in org.apache.commons.io.input
TailerListenerAdapter() - Constructor for class org.apache.commons.io.input.TailerListenerAdapter
 
tan - Static variable in class cern.jet.math.Functions
Function that returns Math.tan(a).
tan() - Method in class jhplot.math.Complex
Tangent of this Complex number (doesn't change this Complex number).
tan(ValueErr) - Method in class jhplot.math.ValueErr
Tangent of a value with error
TAN - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
tan(double) - Static method in class net.jafama.FastMath
Can have very bad relative error near +-PI/2, but of the same magnitude than the relative delta between StrictMath.tan(PI/2) and StrictMath.tan(nextDown(PI/2)).
tan(double) - Static method in class net.jafama.StrictFastMath
Can have very bad relative error near +-PI/2, but of the same magnitude than the relative delta between StrictMath.tan(PI/2) and StrictMath.tan(nextDown(PI/2)).
tan() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Tangent operation.
tan(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute tangent of a derivative structure.
tan() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Tangent operation.
Tan - Class in org.apache.commons.math3.analysis.function
Tangent function.
Tan() - Constructor for class org.apache.commons.math3.analysis.function.Tan
 
tan() - Method in class org.apache.commons.math3.complex.Complex
Compute the tangent of this complex number.
tan() - Method in class org.apache.commons.math3.dfp.Dfp
Tangent operation.
tan(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the tangent of the argument.
tan() - Method in interface org.apache.commons.math3.RealFieldElement
Tangent operation.
tan() - Method in class org.apache.commons.math3.util.Decimal64
Tangent operation.
tan(double) - Static method in class org.apache.commons.math3.util.FastMath
Tangent function.
tan(Object) - Method in class org.nfunk.jep.function.Tangent
 
tan() - Method in class org.nfunk.jep.type.Complex
Returns the tangent of this complex number.
Tangent - Class in org.nfunk.jep.function
 
Tangent() - Constructor for class org.nfunk.jep.function.Tangent
 
tanh(double) - Static method in class graph.SpecialFunction
 
tanh(double) - Static method in class jhplot.math.num.special.Trigonometric
Returns the hyperbolic tangent of x.
tanh(ValueErr) - Method in class jhplot.math.ValueErr
Hyperbolic tangent of value with error
TANH - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
tanh(double) - Static method in class net.jafama.FastMath
Some properties of tanh(x) = sinh(x)/cosh(x) = (exp(2*x)-1)/(exp(2*x)+1): 1) defined on ]-Infinity,+Infinity[ 2) result in ]-1,1[ 3) tanh(x) = -tanh(-x) (implies tanh(0) = 0) 4) tanh(epsilon) ~= epsilon 5) lim(tanh(x),x->+Infinity) = 1 6) reaches 1 (double loss of precision) for x = 19.061547465398498
tanh(double) - Static method in class net.jafama.StrictFastMath
Some properties of tanh(x) = sinh(x)/cosh(x) = (exp(2*x)-1)/(exp(2*x)+1): 1) defined on ]-Infinity,+Infinity[ 2) result in ]-1,1[ 3) tanh(x) = -tanh(-x) (implies tanh(0) = 0) 4) tanh(epsilon) ~= epsilon 5) lim(tanh(x),x->+Infinity) = 1 6) reaches 1 (double loss of precision) for x = 19.061547465398498
tanh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Hyperbolic tangent operation.
tanh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute hyperbolic tangent of a derivative structure.
tanh() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Hyperbolic tangent operation.
Tanh - Class in org.apache.commons.math3.analysis.function
Hyperbolic tangent function.
Tanh() - Constructor for class org.apache.commons.math3.analysis.function.Tanh
 
tanh() - Method in class org.apache.commons.math3.complex.Complex
Compute the hyperbolic tangent of this complex number.
tanh() - Method in class org.apache.commons.math3.dfp.Dfp
Hyperbolic tangent operation.
tanh() - Method in interface org.apache.commons.math3.RealFieldElement
Hyperbolic tangent operation.
tanh() - Method in class org.apache.commons.math3.util.Decimal64
Hyperbolic tangent operation.
tanh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the hyperbolic tangent of a number.
TanH - Class in org.nfunk.jep.function
 
TanH() - Constructor for class org.nfunk.jep.function.TanH
 
tanh(Object) - Method in class org.nfunk.jep.function.TanH
 
tanh() - Method in class org.nfunk.jep.type.Complex
 
TAPER - Static variable in class org.jfree.chart.renderer.AreaRendererEndType
The area tapers from the first or last value down to zero.
target(RealVector) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the observed data.
target(double[]) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the observed data.
Target - Class in org.apache.commons.math3.optim.nonlinear.vector
Deprecated.
All classes and interfaces in this package are deprecated. The optimizers that were provided here were moved to the org.apache.commons.math3.fitting.leastsquares package (cf. MATH-1008).
Target(double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.Target
Deprecated.
 
Target - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
Target(double[]) - Constructor for class org.apache.commons.math3.optimization.Target
Deprecated.
 
Task - Class in org.jfree.data.gantt
A simple representation of a task.
Task(String, TimePeriod) - Constructor for class org.jfree.data.gantt.Task
Creates a new task.
Task(String, Date, Date) - Constructor for class org.jfree.data.gantt.Task
Creates a new task.
TaskSeries - Class in org.jfree.data.gantt
A series that contains zero, one or many Task objects.
TaskSeries(String) - Constructor for class org.jfree.data.gantt.TaskSeries
Constructs a new series with the specified name.
TaskSeriesCollection - Class in org.jfree.data.gantt
A collection of TaskSeries objects.
TaskSeriesCollection() - Constructor for class org.jfree.data.gantt.TaskSeriesCollection
Default constructor.
TAUTAG_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.BLJets
 
TAUTAG_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.GenJets
 
TAUTAG_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Jets
 
taylor(double...) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Evaluate Taylor expansion a derivative structure.
taylor(double[], int, double...) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Evaluate Taylor expansion of a derivative structure.
taylor(double...) - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Evaluate Taylor expansion of a sparse gradient.
TBrowser - Class in org.jlab.groot.ui
 
TBrowser() - Constructor for class org.jlab.groot.ui.TBrowser
 
TBrowser(TDirectory) - Constructor for class org.jlab.groot.ui.TBrowser
 
TCanvas - Class in org.jlab.groot.ui
 
TCanvas(String, int, int) - Constructor for class org.jlab.groot.ui.TCanvas
 
TDirectory - Class in org.jlab.groot.data
 
TDirectory() - Constructor for class org.jlab.groot.data.TDirectory
 
TDirectoryDemo - Class in org.jlab.groot.demo
 
TDirectoryDemo() - Constructor for class org.jlab.groot.demo.TDirectoryDemo
 
TDistribution - Class in jhplot.math.num.pdf
Student's t distribution (1).
TDistribution() - Constructor for class jhplot.math.num.pdf.TDistribution
Default constructor.
TDistribution(double) - Constructor for class jhplot.math.num.pdf.TDistribution
Create a distribution with the given degrees of freedom.
TDistribution - Class in org.apache.commons.math3.distribution
Implementation of Student's t-distribution.
TDistribution(double) - Constructor for class org.apache.commons.math3.distribution.TDistribution
Create a t distribution using the given degrees of freedom.
TDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.TDistribution
Create a t distribution using the given degrees of freedom and the specified inverse cumulative probability absolute accuracy.
TDistribution(RandomGenerator, double) - Constructor for class org.apache.commons.math3.distribution.TDistribution
Creates a t distribution.
TDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.TDistribution
Creates a t distribution.
TeeInputStream - Class in org.apache.commons.io.input
InputStream proxy that transparently writes a copy of all bytes read from the proxied stream to a given OutputStream.
TeeInputStream(InputStream, OutputStream) - Constructor for class org.apache.commons.io.input.TeeInputStream
Creates a TeeInputStream that proxies the given InputStream and copies all read bytes to the given OutputStream.
TeeInputStream(InputStream, OutputStream, boolean) - Constructor for class org.apache.commons.io.input.TeeInputStream
Creates a TeeInputStream that proxies the given InputStream and copies all read bytes to the given OutputStream.
TeeOutputStream - Class in org.apache.commons.io.output
Classic splitter of OutputStream.
TeeOutputStream(OutputStream, OutputStream) - Constructor for class org.apache.commons.io.output.TeeOutputStream
Constructs a TeeOutputStream.
TeeReader - Class in org.apache.commons.io.input
Reader proxy that transparently writes a copy of all characters read from the proxied reader to a given Reader.
TeeReader(Reader, Writer) - Constructor for class org.apache.commons.io.input.TeeReader
Creates a TeeReader that proxies the given Reader and copies all read characters to the given Writer.
TeeReader(Reader, Writer, boolean) - Constructor for class org.apache.commons.io.input.TeeReader
Creates a TeeReader that proxies the given Reader and copies all read characters to the given Writer.
TeeWriter - Class in org.apache.commons.io.output
Classic splitter of Writer.
TeeWriter(Collection<Writer>) - Constructor for class org.apache.commons.io.output.TeeWriter
Creates a new filtered collection writer.
TeeWriter(Writer...) - Constructor for class org.apache.commons.io.output.TeeWriter
Creates a new filtered collection writer.
Tensor - Class in org.lsmp.djep.vectorJep.values
Represents tensor (generalisation of Matrix/Vector).
Tensor(Dimensions) - Constructor for class org.lsmp.djep.vectorJep.values.Tensor
Creates a Tensor with the given dimension.
Tensor(Tensor) - Constructor for class org.lsmp.djep.vectorJep.values.Tensor
Creates a Tensor with same dimension as the arguments.
Tensor(int, Dimensions) - Constructor for class org.lsmp.djep.vectorJep.values.Tensor
Creates a tensor with dimensions [len,dims[0],...,dims[n]]
teraelectronvolt - Static variable in class cern.clhep.Units
 
terminationPerformed(IterationEvent) - Method in interface org.apache.commons.math3.util.IterationListener
Invoked after completion of the operations which occur after breaking out of the main iteration loop.
tesla - Static variable in class cern.clhep.Units
 
test - package test
 
test(int) - Static method in class cern.colt.Timer
Shows how to use a timer in convenient ways.
Test - Class in cern.hep.aida.ref
A very(!) basic test of the reference implementations of AIDA histograms.
Test() - Constructor for class cern.hep.aida.ref.Test
 
test(int, AbstractDistribution) - Static method in class cern.jet.random.Benchmark
Prints the first size random numbers generated by the distribution.
test(int, RandomEngine) - Static method in class cern.jet.random.engine.Benchmark
Prints the first size random numbers generated by the given engine.
test(long, long, long, int, int) - Static method in class cern.jet.random.sampling.RandomSampler
Tests the methods of this class.
test(long, long) - Static method in class cern.jet.random.sampling.RandomSamplingAssistant
Tests the methods of this class.
test(int, int) - Static method in class cern.jet.random.sampling.WeightedRandomSampler
Not yet commented.
test(float) - Static method in class cern.jet.stat.quantile.EquiDepthHistogram
Not yet commented.
test(ASTFunNode, Node[]) - Method in class org.lsmp.djep.rewrite.CollectPowers
 
test(ASTFunNode, Node[]) - Method in class org.lsmp.djep.rewrite.ExpandBrackets
 
test(ASTFunNode, Node[]) - Method in class org.lsmp.djep.rewrite.ExpandPower
 
test(ASTFunNode, Node[]) - Method in interface org.lsmp.djep.rewrite.RewriteRuleI
Returns true if node needs to be rewritten, according to this rule.
test2(int) - Static method in class cern.colt.map.Benchmark
 
Test2 - Class in cern.hep.aida.ref
A very(!) basic test of the reference implementations of AIDA histograms
Test2() - Constructor for class cern.hep.aida.ref.Test2
 
test2(int, AbstractDistribution) - Static method in class cern.jet.random.Benchmark
Prints the first size random numbers generated by the distribution.
test2(int, AbstractDistribution, AbstractDistribution) - Static method in class cern.jet.random.Benchmark
Prints the first size random numbers generated by the distribution.
testArrayAccess() - Method in class org.lsmp.djepJUnit.VectorJepTest
 
testArraySampling(int, int) - Static method in class cern.jet.random.sampling.RandomSamplingAssistant
Tests the methods of this class.
testAssign() - Method in class org.lsmp.djepJUnit.JepTest
 
testAssign() - Method in class org.lsmp.djepJUnit.MRpTest
 
testAssign() - Method in class org.lsmp.djepJUnit.RpTest
 
testAssign2() - Method in class org.lsmp.djepJUnit.JepTest
 
testAssignDiff() - Method in class org.lsmp.djepJUnit.DJepTest
 
testAssignDiff() - Method in class org.lsmp.djepJUnit.MRpTest
 
testBad() - Method in class org.lsmp.djepJUnit.GroupJepTest
 
testBad() - Method in class org.lsmp.djepJUnit.JepTest
 
testBad() - Method in class org.lsmp.djepJUnit.RewriteTest
 
testBad() - Method in class org.lsmp.djepJUnit.SJepTest
 
testBad() - Method in class org.lsmp.djepJUnit.XJepTest
 
testBinom() - Method in class org.lsmp.djepJUnit.JepTest
 
testBug1563324() - Method in class org.nfunk.jeptesting.BugsTest
Tests [ 1563324 ] getValueAsObject always return null after an error JEP 2.4.0 checks the errorList variable before evaluating an expression if there is an error in the list, null is returned.
testChainedVaraibles() - Method in class org.lsmp.djepJUnit.DJepTest
 
testComplex() - Method in class org.lsmp.djepJUnit.JepTest
 
testComplexMatricies() - Method in class org.lsmp.djepJUnit.MatrixJepTest
 
testComplexMatricies() - Method in class org.lsmp.djepJUnit.VectorJepTest
 
testDefine() - Method in class org.lsmp.djepJUnit.XJepTest
 
testDiff() - Method in class org.lsmp.djepJUnit.DJepTest
 
testDotInName() - Method in class org.lsmp.djepJUnit.JepTest
 
testDotInName() - Method in class org.lsmp.djepJUnit.MatrixJepTest
 
testDotInName() - Method in class org.lsmp.djepJUnit.VectorJepTest
 
testElementOperations() - Method in class org.lsmp.djepJUnit.VectorJepTest
 
testFormat() - Method in class org.lsmp.djepJUnit.SJepTest
 
testFormat() - Method in class org.lsmp.djepJUnit.XJepTest
 
testFun() - Method in class org.lsmp.djepJUnit.MRpTest
 
testFun() - Method in class org.lsmp.djepJUnit.RpTest
 
testFunction() - Method in class org.lsmp.djepJUnit.JepTest
 
testGenMatEle() - Method in class org.lsmp.djepJUnit.VectorJepTest
 
testGetComplexValue() - Method in class org.nfunk.jeptesting.JEPTest
Test the getComplexValue() method.
testGetValue() - Method in class org.nfunk.jeptesting.JEPTest
Test the getValue() method.
testGood() - Method in class org.lsmp.djepJUnit.GroupJepTest
just test JUnit working OK
testGood() - Method in class org.lsmp.djepJUnit.JepTest
just test JUnit working OK
testGood() - Method in class org.lsmp.djepJUnit.MRpTest
 
testGood() - Method in class org.lsmp.djepJUnit.RpTest
 
testGood() - Method in class org.lsmp.djepJUnit.SJepTest
just test JUnit working OK
testHasError() - Method in class org.nfunk.jeptesting.BugsTest
Tests [ 1562371 ] ParseException not sets jep.hasError() flag.
testHex() - Method in class org.lsmp.djepJUnit.XJepTest
 
testIf() - Method in class org.lsmp.djepJUnit.JepTest
 
testLength() - Method in class org.lsmp.djepJUnit.MatrixJepTest
 
testLength() - Method in class org.lsmp.djepJUnit.VectorJepTest
 
testLogarithm() - Method in class org.nfunk.jeptesting.LogarithmTest
 
testLogical() - Method in class org.lsmp.djepJUnit.JepTest
 
testLogical() - Method in class org.lsmp.djepJUnit.MRpTest
 
testLogical() - Method in class org.lsmp.djepJUnit.RpTest
 
testLogical() - Method in class org.lsmp.djepJUnit.XJepTest
 
testMacroFun() - Method in class org.lsmp.djepJUnit.XJepTest
 
TestMatrix - Class in Jama.test
TestMatrix tests the functionality of the Jama Matrix class and associated decompositions.
TestMatrix() - Constructor for class Jama.test.TestMatrix
 
testMatrix() - Method in class org.lsmp.djepJUnit.MatrixJepTest
 
testMatrix() - Method in class org.lsmp.djepJUnit.VectorJepTest
 
testMemory() - Method in class org.lsmp.djepJUnit.RewriteTest
 
testMul() - Method in class org.lsmp.djepJUnit.MRpTest
 
testNaN() - Method in class org.lsmp.djepJUnit.JepTest
 
testNaturalLogarithm() - Method in class org.nfunk.jeptesting.NaturalLogarithmTest
 
testNumParam() - Method in class org.lsmp.djepJUnit.JepTest
 
testOperators() - Method in class org.lsmp.djepJUnit.SJepTest
 
testOpSetBug() - Method in class org.nfunk.jeptesting.BugsTest
Tests the uninitialized OperatorSet bug 1061200
testPolynomialCreator() - Method in class org.lsmp.djepJUnit.GroupJepTest
 
testPolynomials() - Method in class org.lsmp.djepJUnit.GroupJepTest
 
testPolynomials2() - Method in class org.lsmp.djepJUnit.GroupJepTest
 
testPolySimp() - Method in class org.lsmp.djepJUnit.SJepTest
 
testPolySimp2() - Method in class org.lsmp.djepJUnit.SJepTest
 
testPower() - Method in class org.nfunk.jeptesting.ComplexTest
Test method for 'org.nfunk.jep.function.Logarithm.run(Stack)' Tests the return value of log(NaN).
testPrint() - Method in class org.lsmp.djepJUnit.SJepTest
 
testPrint() - Method in class org.lsmp.djepJUnit.XJepTest
 
testQ() - Method in class org.lsmp.djepJUnit.GroupJepTest
Tests rationals
testQuartonians() - Method in class org.lsmp.djepJUnit.GroupJepTest
Tests Quaternions
testRead(File, int) - Static method in class hep.lcio.util.Validate
Perform test read of an LCIO file.
testReentrant() - Method in class org.lsmp.djepJUnit.XJepTest
 
testRewrite() - Method in class org.lsmp.djepJUnit.RewriteTest
 
testRp() - Method in class org.lsmp.djepJUnit.MRpTest
 
testRp() - Method in class org.lsmp.djepJUnit.RpTest
 
testRpAllDim() - Method in class org.lsmp.djepJUnit.MRpTest
 
testSetAllowUndeclared() - Method in class org.nfunk.jeptesting.BugsTest
Tests bug [ 1585128 ] setAllowUndeclared does not work!!! setAllowedUndeclared should add variables to the symbol table.
testSimp() - Method in class org.lsmp.djepJUnit.SJepTest
 
testSimp() - Method in class org.lsmp.djepJUnit.XJepTest
 
testSimpleEquals() - Method in class org.lsmp.djepJUnit.SJepTest
 
testSimpleSum() - Method in class org.lsmp.djepJUnit.JepTest
 
testSimpleSum() - Method in class org.lsmp.djepJUnit.SJepTest
 
testSpecialCommands(String) - Method in class org.lsmp.djepExamples.BlockStatments
Catches macros which are not handled by JEP
testSpecialCommands(String) - Method in class org.lsmp.djepExamples.Console
Checks for special commands used by subclasses.
testSpecialCommands(String) - Method in class org.lsmp.djepExamples.GroupConsole
 
testSpecialCommands(String) - Method in class org.lsmp.djepExamples.VectorConsole
 
testSpecialCommands(String) - Method in class org.lsmp.djepExamples.XJepConsole
 
testSum() - Method in class org.lsmp.djepJUnit.XJepTest
 
testSumVector() - Method in class org.lsmp.djepJUnit.VectorJepTest
 
testTaylor() - Method in class org.lsmp.djepJUnit.RewriteTest
 
testTgtDev() - Method in class org.lsmp.djepJUnit.MatrixJepTest
 
testTotalOrder() - Method in class org.lsmp.djepJUnit.SJepTest
 
testUndeclared() - Method in class org.lsmp.djepJUnit.JepTest
 
testUndecVar() - Method in class org.lsmp.djepJUnit.MRpTest
 
testUndecVar() - Method in class org.lsmp.djepJUnit.XJepTest
 
TestUtils - Class in org.apache.commons.math3.stat.inference
A collection of static methods to create inference test instances or to perform inference tests.
testVariableReuse() - Method in class org.lsmp.djepJUnit.XJepTest
 
testVarInEqn() - Method in class org.lsmp.djepJUnit.XJepTest
 
testVecCmp() - Method in class org.lsmp.djepJUnit.MatrixJepTest
 
testVecCmp() - Method in class org.lsmp.djepJUnit.VectorJepTest
 
testVectorSum() - Method in class org.lsmp.djepJUnit.MatrixJepTest
 
testVn() - Method in class org.lsmp.djepJUnit.MRpTest
 
testWithFile() - Method in class org.nfunk.jeptesting.JEPTest
 
testWithFile(String) - Method in class org.nfunk.jeptesting.JEPTest
Loads the file specified in fileName.
testZ() - Method in class org.lsmp.djepJUnit.GroupJepTest
Tests very large numbers, 20!
testZ5thRootUnity() - Method in class org.lsmp.djepJUnit.GroupJepTest
 
testZn() - Method in class org.lsmp.djepJUnit.GroupJepTest
Tests integers mod 5
testZroot2() - Method in class org.lsmp.djepJUnit.GroupJepTest
 
testZRoot2Root5() - Method in class org.lsmp.djepJUnit.GroupJepTest
 
testZtau() - Method in class org.lsmp.djepJUnit.GroupJepTest
 
TeV - Static variable in class cern.clhep.Units
 
TEXT - Static variable in class jhplot.shapes.HShape
 
Text - Class in jhplot.shapes
Draw a TEXT in the USER coordinate system.
Text(String, double, double, Font, Color) - Constructor for class jhplot.shapes.Text
Create a TEXT object
Text(String, double, double) - Constructor for class jhplot.shapes.Text
Create a TEXT object
TextAnnotation - Class in org.jfree.chart.annotations
A base class for text annotations.
textfield - Variable in class jplot.Utils.LabeledTextField
 
TextFileReader - Class in org.jlab.groot.io
 
TextFileReader() - Constructor for class org.jlab.groot.io.TextFileReader
 
TextLine - Class in graph
This class is designed to bundle together all the information required to draw short Strings with subscripts and superscripts
TextLine() - Constructor for class graph.TextLine
Instantiate the class
TextLine(String) - Constructor for class graph.TextLine
Instantiate the class.
TextLine(String, Font) - Constructor for class graph.TextLine
Instantiate the class
TextLine(String, Font, Color, int) - Constructor for class graph.TextLine
Instantiate the class
TextLine(String, Color) - Constructor for class graph.TextLine
Instantiate the class
TextLine(Font, Color, int) - Constructor for class graph.TextLine
Instantiate the class
TextTitle - Class in org.jfree.chart.title
A chart title that displays a text string with automatic wrapping as required.
TextTitle() - Constructor for class org.jfree.chart.title.TextTitle
Creates a new title, using default attributes where necessary.
TextTitle(String) - Constructor for class org.jfree.chart.title.TextTitle
Creates a new title, using default attributes where necessary.
TextTitle(String, Font) - Constructor for class org.jfree.chart.title.TextTitle
Creates a new title, using default attributes where necessary.
TextTitle(String, Font, Paint, RectangleEdge, HorizontalAlignment, VerticalAlignment, RectangleInsets) - Constructor for class org.jfree.chart.title.TextTitle
Creates a new title.
TextUtils - Class in org.jfree.chart.util
Text utility functions.
TextUtils() - Constructor for class org.jfree.chart.util.TextUtils
 
textVariance(char[]) - Static method in class jhepsim.Util
 
textVariance(char[]) - Static method in class jhplot.utils.Util
 
textVariance(char[]) - Static method in class jminhep.utils.Util
 
textX - Static variable in class jminhep.gui.MainFrame
 
textY - Static variable in class jminhep.gui.MainFrame
 
THBIT_BARREL - Static variable in interface hep.lcio.event.LCIO
 
THBIT_ID1 - Static variable in interface hep.lcio.event.LCIO
 
THBIT_MOMENTUM - Static variable in interface hep.lcio.event.LCIO
 
ThermometerPlot - Class in org.jfree.chart.plot
A plot that displays a single value (from a ValueDataset) in a thermometer type display.
ThermometerPlot() - Constructor for class org.jfree.chart.plot.ThermometerPlot
Creates a new thermometer plot.
ThermometerPlot(ValueDataset) - Constructor for class org.jfree.chart.plot.ThermometerPlot
Creates a new thermometer plot, using default attributes where necessary.
theta() - Method in class hep.physics.vec.SpacePoint
Spherical theta
theta() - Method in class hephysics.vec.Hep3Vector
angle theta (=atan2(perp(),z)
theta() - Method in class hephysics.vec.HepLorentzVector
Get theta angle
theta() - Method in class hephysics.vec.SpacePoint
Spherical theta
theta() - Method in class j4np.physics.LorentzVector
 
theta() - Method in class j4np.physics.Vector3
 
ThreadTest - Class in org.nfunk.jepexamples
This class tests the thread safety of the JEP package with a brute force approach.
ThreadTest() - Constructor for class org.nfunk.jepexamples.ThreadTest
 
ThreadTestThread - Class in org.nfunk.jepexamples
The ThreadTestThread waits for 5 seconds before calling the evaluate method of the ThreadTest instance.
ThreadTestThread(ThreadTest) - Constructor for class org.nfunk.jepexamples.ThreadTestThread
 
THREE - Static variable in class org.lsmp.djep.vectorJep.Dimensions
 
THREE_FIFTHS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "3/5".
THREE_FIFTHS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "3/5".
THREE_QUARTERS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "3/4".
THREE_QUARTERS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "3/4".
ThreeEighthesFieldIntegrator<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 3/8 fourth order Runge-Kutta integrator for Ordinary Differential Equations.
ThreeEighthesFieldIntegrator(Field<T>, T) - Constructor for class org.apache.commons.math3.ode.nonstiff.ThreeEighthesFieldIntegrator
Simple constructor.
ThreeEighthesIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 3/8 fourth order Runge-Kutta integrator for Ordinary Differential Equations.
ThreeEighthesIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.ThreeEighthesIntegrator
Simple constructor.
ThresholdingOutputStream - Class in org.apache.commons.io.output
An output stream which triggers an event when a specified number of bytes of data have been written to it.
ThresholdingOutputStream(int) - Constructor for class org.apache.commons.io.output.ThresholdingOutputStream
Constructs an instance of this class which will trigger an event at the specified threshold.
throwCauseIfTaggedWith(Throwable, Object) - Static method in exception org.apache.commons.io.TaggedIOException
Throws the original IOException if the given throwable is a TaggedIOException decorator the given tag.
throwError(String) - Static method in class jhplot.math.DoubleArray
Throws an error exception if an argument is invalid.
throwIfCauseOf(Throwable) - Method in class org.apache.commons.io.input.TaggedInputStream
Re-throws the original exception thrown by this stream.
throwIfCauseOf(Throwable) - Method in class org.apache.commons.io.input.TaggedReader
Re-throws the original exception thrown by this reader.
throwIfCauseOf(Exception) - Method in class org.apache.commons.io.output.TaggedOutputStream
Re-throws the original exception thrown by this stream.
throwIfCauseOf(Exception) - Method in class org.apache.commons.io.output.TaggedWriter
Re-throws the original exception thrown by this writer.
thrust() - Method in class hep.physics.jet.EventShape
Element x = Thrust Element y = Major Thrust Element z = Minor Thrust
thrustAxis() - Method in class hep.physics.jet.EventShape
 
Tick - Class in org.jfree.chart.axis
The base class used to represent labeled ticks along an axis.
Tick(String, TextAnchor, TextAnchor, double) - Constructor for class org.jfree.chart.axis.Tick
Creates a new tick.
tickDensity - Variable in class jplot3dp.ModelView.AxesDefinition
 
TickLabelEntity - Class in org.jfree.chart.entity
A chart entity representing a tick label.
TickLabelEntity(Shape, String, String) - Constructor for class org.jfree.chart.entity.TickLabelEntity
Creates a new entity.
TickType - Class in org.jfree.chart.axis
Used to indicate the tick type (MAJOR or MINOR).
TickUnit - Class in org.jfree.chart.axis
Base class representing a tick unit.
TickUnit(double) - Constructor for class org.jfree.chart.axis.TickUnit
Constructs a new tick unit.
TickUnit(double, int) - Constructor for class org.jfree.chart.axis.TickUnit
Constructs a new tick unit.
TickUnits - Class in org.jfree.chart.axis
A collection of tick units, used by the DateAxis and NumberAxis classes.
TickUnits() - Constructor for class org.jfree.chart.axis.TickUnits
Constructs a new collection of tick units.
TickUnitSource - Interface in org.jfree.chart.axis
An interface used by the DateAxis and NumberAxis classes to obtain a suitable TickUnit.
TiesStrategy - Enum in org.apache.commons.math3.stat.ranking
Strategies for handling tied values in rank transformations.
Timeline - Interface in org.jfree.chart.axis
An interface that defines the contract for a Timeline.
TimePeriod - Interface in org.jfree.data.time
A period of time measured to millisecond precision using two instances of java.util.Date.
TimePeriodAnchor - Class in org.jfree.data.time
Used to indicate one of three positions in a time period: START, MIDDLE and END.
TimePeriodFormatException - Exception in org.jfree.data.time
An exception that indicates an invalid format in a string representing a time period.
TimePeriodFormatException(String) - Constructor for exception org.jfree.data.time.TimePeriodFormatException
Creates a new exception.
TimePeriodValue - Class in org.jfree.data.time
Represents a time period and an associated value.
TimePeriodValue(TimePeriod, Number) - Constructor for class org.jfree.data.time.TimePeriodValue
Constructs a new data item.
TimePeriodValue(TimePeriod, double) - Constructor for class org.jfree.data.time.TimePeriodValue
Constructs a new data item.
TimePeriodValues - Class in org.jfree.data.time
A structure containing zero, one or many TimePeriodValue instances.
TimePeriodValues(String) - Constructor for class org.jfree.data.time.TimePeriodValues
Creates a new (empty) collection of time period values.
TimePeriodValues(String, String, String) - Constructor for class org.jfree.data.time.TimePeriodValues
Creates a new time series that contains no data.
TimePeriodValuesCollection - Class in org.jfree.data.time
A collection of TimePeriodValues objects.
TimePeriodValuesCollection() - Constructor for class org.jfree.data.time.TimePeriodValuesCollection
Constructs an empty dataset.
TimePeriodValuesCollection(TimePeriodValues) - Constructor for class org.jfree.data.time.TimePeriodValuesCollection
Constructs a dataset containing a single series.
timePrint(String) - Static method in class org.lsmp.djepExamples.MRpDiffExample
 
timePrint(String) - Static method in class org.lsmp.djepExamples.MRpSurfExample
 
Timer - Class in cern.colt
A handy stopwatch for benchmarking.
Timer() - Constructor for class cern.colt.Timer
Constructs a new timer, initially not started.
timer - Static variable in class jhplot.JHPlot
 
times(int) - Method in class cern.colt.list.AbstractBooleanList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractByteList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractCharList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractDoubleList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractFloatList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractIntList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractLongList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractShortList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.ObjectArrayList
Returns a list which is a concatenation of times times the receiver.
times(double) - Method in class Jama.Matrix
Multiply a matrix by a scalar, C = s*A
times(Matrix) - Method in class Jama.Matrix
Linear algebraic matrix multiplication, A * B
Times - Class in Jampack
 
Times() - Constructor for class Jampack.Times
 
Times(Z, Z) - Method in class Jampack.Z
Computes the product of two Z's.
Times(double, Z) - Method in class Jampack.Z
Computes the product of a double and a Z.
Times(int, Z) - Method in class Jampack.Z1
Multiplies the ith element of a Z1 by a Z.
times(Complex) - Method in class jhplot.math.Complex
Complex multiplication (doesn't change this Complex number).
times(double) - Method in class jhplot.math.Complex
Returns this complex multiplied by the specified factor.
times(double) - Method in class jhplot.math.kalman.jama.Matrix
Multiply a matrix by a scalar, C = s*A
times(Matrix) - Method in class jhplot.math.kalman.jama.Matrix
Linear algebraic matrix multiplication, A * B
times(double[]...) - Static method in class jhplot.math.LinearAlgebra
Element-wise product of any number of arrays.
times(double[], double) - Static method in class jhplot.math.LinearAlgebra
Multiply each element of an array by a scalar.
times(double[][], double) - Static method in class jhplot.math.LinearAlgebra
Multiply each element in a matrix by a scalar
times(double[][], double[][]) - Static method in class jhplot.math.LinearAlgebra
Matrix multiplication according to the rules of linear algebra.
times(double[][], double[]) - Static method in class jhplot.math.LinearAlgebra
Product of a matrix and a vector (array) according to the rules of linear algebra.
times(ValueErr, double) - Method in class jhplot.math.ValueErr
Multiply two ValueErr numbers with correlation
times(ValueErr) - Method in class jhplot.math.ValueErr
Multiply this ValueErr number by a ValueErr number without correlation
times(double) - Method in class jhplot.math.ValueErr
Multiply this ValueErr number by a double.
times(ValueErr, ValueErr, double) - Method in class jhplot.math.ValueErr
Multiply two ValueErr numbers with correlation
times(ValueErr, ValueErr) - Method in class jhplot.math.ValueErr
Multiply two ValueErr numbers without correlation
times(double, ValueErr) - Method in class jhplot.math.ValueErr
Multiply a double by a ValueErr number
times(double, double) - Method in class jhplot.math.ValueErr
Multiply a double number by a double and return product as ValueErr
timesBounded(int, int) - Static method in class net.jafama.NumbersUtils
 
timesBounded(long, long) - Static method in class net.jafama.NumbersUtils
 
timesEquals(double) - Method in class Jama.Matrix
Multiply a matrix by a scalar in place, A = s*A
timesEquals(double) - Method in class jhplot.math.kalman.jama.Matrix
Multiply a matrix by a scalar in place, A = s*A
timesEquals(ValueErr, double) - Method in class jhplot.math.ValueErr
Multiply this ValueErr number by an ValueErr number and replace this by the product with correlation
timesEquals(ValueErr) - Method in class jhplot.math.ValueErr
Multiply this ValueErr number by an ValueErr number and replace this by the product with no correlation
timesEquals(double) - Method in class jhplot.math.ValueErr
Multiply this ValueErr number by a double and replace it by the product
TimeSeries - Class in org.jfree.data.time
Represents a sequence of zero or more data items in the form (period, value) where 'period' is some instance of a subclass of RegularTimePeriod.
TimeSeries(Comparable) - Constructor for class org.jfree.data.time.TimeSeries
Creates a new (empty) time series.
TimeSeries(Comparable, String, String) - Constructor for class org.jfree.data.time.TimeSeries
Creates a new time series that contains no data.
TimeSeries(Comparable, Class) - Constructor for class org.jfree.data.time.TimeSeries
Deprecated.
As of 1.0.13, it is not necessary to specify the timePeriodClass as this will be inferred when the first data item is added to the dataset.
TimeSeries(Comparable, String, String, Class) - Constructor for class org.jfree.data.time.TimeSeries
Deprecated.
As of 1.0.13, it is not necessary to specify the timePeriodClass as this will be inferred when the first data item is added to the dataset.
TimeSeriesChartDemo1 - Class in org.jfree.chart.demo
An example of a time series chart.
TimeSeriesChartDemo1(String) - Constructor for class org.jfree.chart.demo.TimeSeriesChartDemo1
A demonstration application showing how to create a simple time series chart.
TimeSeriesChartFXDemo1 - Class in org.jfree.chart.fx.demo
A demo showing the display of JFreeChart within a JavaFX application.
TimeSeriesChartFXDemo1() - Constructor for class org.jfree.chart.fx.demo.TimeSeriesChartFXDemo1
 
TimeSeriesCollection - Class in org.jfree.data.time
A collection of time series objects.
TimeSeriesCollection() - Constructor for class org.jfree.data.time.TimeSeriesCollection
Constructs an empty dataset, tied to the default timezone.
TimeSeriesCollection(TimeZone) - Constructor for class org.jfree.data.time.TimeSeriesCollection
Constructs an empty dataset, tied to a specific timezone.
TimeSeriesCollection(TimeSeries) - Constructor for class org.jfree.data.time.TimeSeriesCollection
Constructs a dataset containing a single series (more can be added), tied to the default timezone.
TimeSeriesCollection(TimeSeries, TimeZone) - Constructor for class org.jfree.data.time.TimeSeriesCollection
Constructs a dataset containing a single series (more can be added), tied to a specific timezone.
TimeSeriesDataItem - Class in org.jfree.data.time
Represents one data item in a time series.
TimeSeriesDataItem(RegularTimePeriod, Number) - Constructor for class org.jfree.data.time.TimeSeriesDataItem
Constructs a new data item that associates a value with a time period.
TimeSeriesDataItem(RegularTimePeriod, double) - Constructor for class org.jfree.data.time.TimeSeriesDataItem
Constructs a new data item that associates a value with a time period.
TimeSeriesTableModel - Class in org.jfree.data.time
Wrapper around a time series to convert it to a table model for use in a JTable.
TimeSeriesTableModel() - Constructor for class org.jfree.data.time.TimeSeriesTableModel
Default constructor.
TimeSeriesTableModel(TimeSeries) - Constructor for class org.jfree.data.time.TimeSeriesTableModel
Constructs a table model for a time series.
TimeSeriesTableModel(TimeSeries, boolean) - Constructor for class org.jfree.data.time.TimeSeriesTableModel
Creates a table model based on a time series.
TimeSeriesURLGenerator - Class in org.jfree.chart.urls
A URL generator for time series charts.
TimeSeriesURLGenerator() - Constructor for class org.jfree.chart.urls.TimeSeriesURLGenerator
Default constructor.
TimeSeriesURLGenerator(DateFormat, String, String, String) - Constructor for class org.jfree.chart.urls.TimeSeriesURLGenerator
Construct TimeSeriesURLGenerator overriding defaults.
timesExact(int, int) - Static method in class net.jafama.NumbersUtils
 
timesExact(long, long) - Static method in class net.jafama.NumbersUtils
 
TIMESTAMP_FIELD_NUMBER - Static variable in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
TIMESTAMP_FIELD_NUMBER - Static variable in class promc.io.ProMCDescriptionFile.ProMCDescription
 
TIMESTAMP_FIELD_NUMBER - Static variable in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
TIMESTAMP_FIELD_NUMBER - Static variable in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
TimeTableXYDataset - Class in org.jfree.data.time
A dataset for regular time periods that implements the TableXYDataset interface.
TimeTableXYDataset() - Constructor for class org.jfree.data.time.TimeTableXYDataset
Creates a new dataset.
TimeTableXYDataset(TimeZone) - Constructor for class org.jfree.data.time.TimeTableXYDataset
Creates a new dataset with the given time zone.
TimeTableXYDataset(TimeZone, Locale) - Constructor for class org.jfree.data.time.TimeTableXYDataset
Creates a new dataset with the given time zone and locale.
title() - Method in interface colt.hep.aida.IHistogram
Title of the histogram (will be set only in the constructor).
TITLE - Static variable in class jplot.GraphLabel
 
Title - Class in org.jfree.chart.title
The base class for all chart titles.
titleChanged(TitleChangeEvent) - Method in interface org.jfree.chart.event.TitleChangeListener
Receives notification of a chart title change event.
titleChanged(TitleChangeEvent) - Method in class org.jfree.chart.JFreeChart
Receives notification that a chart title has changed, and passes this on to registered listeners.
TitleChangeEvent - Class in org.jfree.chart.event
A change event that encapsulates information about a change to a chart title.
TitleChangeEvent(Title) - Constructor for class org.jfree.chart.event.TitleChangeEvent
Default constructor.
TitleChangeListener - Interface in org.jfree.chart.event
The interface that must be supported by classes that wish to receive notification of changes to a chart title.
TitleEntity - Class in org.jfree.chart.entity
A class that captures information about a Title of a chart.
TitleEntity(Shape, Title) - Constructor for class org.jfree.chart.entity.TitleEntity
Creates a new chart entity.
TitleEntity(Shape, Title, String) - Constructor for class org.jfree.chart.entity.TitleEntity
Creates a new chart entity.
TitleEntity(Shape, Title, String, String) - Constructor for class org.jfree.chart.entity.TitleEntity
Creates a new entity.
TLeafFolderColumn - Class in root
 
toArray(Object[]) - Method in class cern.colt.list.ObjectArrayList
Returns an array containing all of the elements in the receiver in the correct order.
toArray() - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a 1-dimensional array containing the cell values.
toArray(double[]) - Method in class cern.colt.matrix.DoubleMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a 2-dimensional array containing the cell values.
toArray(double[]) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray(Object[]) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a 1-dimensional array containing the cell values.
toArray(Object[]) - Method in class cern.colt.matrix.ObjectMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in interface hep.lcio.event.LCFloatVec
 
toArray() - Method in interface hep.lcio.event.LCIntVec
 
toArray() - Method in interface hep.lcio.event.LCStrVec
 
toArray() - Method in class hep.lcio.implementation.event.ILCFloatVec
 
toArray() - Method in class hep.lcio.implementation.event.ILCIntVec
 
toArray() - Method in class hep.lcio.implementation.event.ILCStrVec
 
toArray() - Method in class jhplot.math.num.DoubleArray
Convert this array into a native array.
toArray() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the vector coordinates as a dimension 3 array.
toArray() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the vector coordinates as a dimension 3 array.
toArray() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the vector coordinates as a dimension 2 array.
toArray() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Convert the vector to a T array.
toArray() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Convert the vector to an array of doubles.
toArray() - Method in interface org.apache.commons.math3.linear.FieldVector
Convert the vector to a T array.
toArray() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Convert the vector to an array of doubles.
toArray() - Method in class org.apache.commons.math3.linear.RealVector
Convert the vector to an array of doubles.
toArray() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Convert the vector to a T array.
toArray() - Method in class org.jfree.data.xy.XYSeries
Returns a new array containing the x and y values from this series.
toArray() - Method in class org.lsmp.djep.mrpe.MRpRes
Returns an array of doubles with the values filled in.
toASCIIFile(File) - Method in interface jhplot.math.io.FilePrintable
 
ToBase - Class in org.lsmp.djep.xjep.function
Convert a number to a string in a given base.
ToBase() - Constructor for class org.lsmp.djep.xjep.function.ToBase
Constructor where base is specified as a function argument.
ToBase(int) - Constructor for class org.lsmp.djep.xjep.function.ToBase
Constructor with specified base.
ToBase(int, String) - Constructor for class org.lsmp.djep.xjep.function.ToBase
Constructor with specified base and a given prefix.
toBase(long, int) - Method in class org.lsmp.djep.xjep.function.ToBase
Converts a number to a give base.
toBase(double, int, int) - Method in class org.lsmp.djep.xjep.function.ToBase
Converts a number to a give base.
toBitVector() - Method in class cern.colt.bitvector.BitMatrix
Converts the receiver to a bitvector.
toBitVector() - Method in class cern.colt.list.MinMaxNumberList
Returns the receiver seen as bitvector.
toBlocksLayout(T[][]) - Static method in class org.apache.commons.math3.linear.BlockFieldMatrix
Convert a data array from raw layout to blocks layout.
toBlocksLayout(double[][]) - Static method in class org.apache.commons.math3.linear.BlockRealMatrix
Convert a data array from raw layout to blocks layout.
toBufferedInputStream(InputStream) - Static method in class org.apache.commons.io.IOUtils
Fetches entire contents of an InputStream and represent same data as result InputStream.
toBufferedInputStream(InputStream, int) - Static method in class org.apache.commons.io.IOUtils
Fetches entire contents of an InputStream and represent same data as result InputStream.
toBufferedInputStream(InputStream) - Static method in class org.apache.commons.io.output.ByteArrayOutputStream
Fetches entire contents of an InputStream and represent same data as result InputStream.
toBufferedInputStream(InputStream, int) - Static method in class org.apache.commons.io.output.ByteArrayOutputStream
Fetches entire contents of an InputStream and represent same data as result InputStream.
toBufferedInputStream(InputStream) - Static method in class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
Fetches entire contents of an InputStream and represent same data as result InputStream.
toBufferedInputStream(InputStream, int) - Static method in class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
Fetches entire contents of an InputStream and represent same data as result InputStream.
toBufferedReader(Reader) - Static method in class org.apache.commons.io.IOUtils
Returns the given reader if it is a BufferedReader, otherwise creates a BufferedReader from the given reader.
toBufferedReader(Reader, int) - Static method in class org.apache.commons.io.IOUtils
Returns the given reader if it is a BufferedReader, otherwise creates a BufferedReader from the given reader.
toBuilder() - Method in class proeic.io.ProMC.ProMCEvent.Event
 
toBuilder() - Method in class proeic.io.ProMC.ProMCEvent.Particles
 
toBuilder() - Method in class proeic.io.ProMC.ProMCEvent
 
toBuilder() - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
toBuilder() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
toBuilder() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
toBuilder() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
toBuilder() - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
toBuilder() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
toBuilder() - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
toBuilder() - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
toBuilder() - Method in class proeic.io.ProMCStatFile.ProMCStat
 
toBuilder() - Method in class promc.io.PBufFile.Record.F1D
 
toBuilder() - Method in class promc.io.PBufFile.Record.F2D
 
toBuilder() - Method in class promc.io.PBufFile.Record.FND
 
toBuilder() - Method in class promc.io.PBufFile.Record.FPR
 
toBuilder() - Method in class promc.io.PBufFile.Record.H1D
 
toBuilder() - Method in class promc.io.PBufFile.Record.H2D
 
toBuilder() - Method in class promc.io.PBufFile.Record.P0D
 
toBuilder() - Method in class promc.io.PBufFile.Record.P0I
 
toBuilder() - Method in class promc.io.PBufFile.Record.P1D
 
toBuilder() - Method in class promc.io.PBufFile.Record.PND
 
toBuilder() - Method in class promc.io.PBufFile.Record.PNI
 
toBuilder() - Method in class promc.io.PBufFile.Record.PXY
 
toBuilder() - Method in class promc.io.PBufFile.Record.PXYZ
 
toBuilder() - Method in class promc.io.PBufFile.Record
 
toBuilder() - Method in class promc.io.PEventFile.HEvent.Entry
 
toBuilder() - Method in class promc.io.PEventFile.HEvent.Group
 
toBuilder() - Method in class promc.io.PEventFile.HEvent
 
toBuilder() - Method in class promc.io.ProMC.ProMCEvent.Event
 
toBuilder() - Method in class promc.io.ProMC.ProMCEvent.Particles
 
toBuilder() - Method in class promc.io.ProMC.ProMCEvent
 
toBuilder() - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
toBuilder() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
toBuilder() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
toBuilder() - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
toBuilder() - Method in class promc.io.ProMCHeaderFile.ProMCHeader
 
toBuilder() - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
toBuilder() - Method in class promc.io.ProMCStatFile.ProMCStat
 
toBuilder() - Method in class pronlo.io.ProMC.ProMCEvent.Event
 
toBuilder() - Method in class pronlo.io.ProMC.ProMCEvent.Particles
 
toBuilder() - Method in class pronlo.io.ProMC.ProMCEvent
 
toBuilder() - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
toBuilder() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
toBuilder() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
toBuilder() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
toBuilder() - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
toBuilder() - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
toBuilder() - Method in class pronlo.io.ProMCStatFile.ProMCStat
 
toBuilder() - Method in class proreco.io.ProMC.ProMCEvent.BLJets
 
toBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Electrons
 
toBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Event
 
toBuilder() - Method in class proreco.io.ProMC.ProMCEvent.GenJets
 
toBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Jets
 
toBuilder() - Method in class proreco.io.ProMC.ProMCEvent.MissingET
 
toBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Muons
 
toBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Particles
 
toBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Photons
 
toBuilder() - Method in class proreco.io.ProMC.ProMCEvent
 
toBuilder() - Method in class proreco.io.ProMC.ProMCEvent.Tracks
 
toBuilder() - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
toBuilder() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
toBuilder() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
toBuilder() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
toBuilder() - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
toBuilder() - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
toBuilder() - Method in class proreco.io.ProMCStatFile.ProMCStat
 
toByteArray(InputStream) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of an InputStream as a byte[].
toByteArray(InputStream, int) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of an InputStream as a byte[].
toByteArray(InputStream, long) - Static method in class org.apache.commons.io.IOUtils
Gets contents of an InputStream as a byte[].
toByteArray(Reader) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
toByteArray(Reader, Charset) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a Reader as a byte[] using the specified character encoding.
toByteArray(Reader, String) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a Reader as a byte[] using the specified character encoding.
toByteArray(String) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
2.5 Use String.getBytes() instead
toByteArray(URI) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a URI as a byte[].
toByteArray(URL) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a URL as a byte[].
toByteArray(URLConnection) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a URLConnection as a byte[].
toByteArray() - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
Gets the current contents of this byte stream as a byte array.
toByteArray() - Method in class org.apache.commons.io.output.ByteArrayOutputStream
 
toByteArray() - Method in class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
 
toCartesianGradient(double[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SphericalCoordinates
Convert a gradient with respect to spherical coordinates into a gradient with respect to Cartesian coordinates.
toCartesianHessian(double[][], double[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SphericalCoordinates
Convert a Hessian with respect to spherical coordinates into a Hessian with respect to Cartesian coordinates.
toCharArray(InputStream) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
toCharArray(InputStream, Charset) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of an InputStream as a character array using the specified character encoding.
toCharArray(InputStream, String) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of an InputStream as a character array using the specified character encoding.
toCharArray(Reader) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a Reader as a character array.
toCharset(Charset) - Static method in class org.apache.commons.io.Charsets
Returns the given Charset or the default Charset if the given Charset is null.
toCharset(String) - Static method in class org.apache.commons.io.Charsets
Returns a Charset for the named charset.
toClipBoard() - Method in interface jhplot.math.io.ClipBoardPrintable
 
toCommandLine(String) - Method in class jhplot.math.Slicing
 
toDegrees(double) - Static method in class net.jafama.FastMath
Gives same result as Math.toDegrees for some particular values like Math.PI/2, Math.PI or 2*Math.PI, but is faster (no division).
toDegrees(boolean, int, int, double) - Static method in class net.jafama.FastMath
 
toDegrees(double) - Static method in class net.jafama.StrictFastMath
Gives same result as StrictMath.toDegrees for some particular values like Math.PI/2, Math.PI or 2*Math.PI, but is faster (no division).
toDegrees(boolean, int, int, double) - Static method in class net.jafama.StrictFastMath
 
toDegrees() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Convert radians to degrees, with error of less than 0.5 ULP
toDegrees() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Convert radians to degrees, with error of less than 0.5 ULP
toDegrees(double) - Static method in class org.apache.commons.math3.util.FastMath
Convert radians to degrees, with error of less than 0.5 ULP
toDifferentiableMultivariateFunction(MultivariateDifferentiableFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated.
this conversion method is temporary in version 3.1, as the DifferentiableMultivariateFunction interface itself is deprecated
toDifferentiableMultivariateVectorFunction(MultivariateDifferentiableVectorFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated.
this conversion method is temporary in version 3.1, as the DifferentiableMultivariateVectorFunction interface itself is deprecated
toDifferentiableUnivariateFunction(UnivariateDifferentiableFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated.
this conversion method is temporary in version 3.1, as the DifferentiableUnivariateFunction interface itself is deprecated
toDMS(double, IntWrapper, IntWrapper, DoubleWrapper) - Static method in class net.jafama.FastMath
 
toDMS(double, IntWrapper, IntWrapper, DoubleWrapper) - Static method in class net.jafama.StrictFastMath
 
toDouble(float[]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble(long[]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble(int[]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble(float[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble(long[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble(int[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble() - Method in class org.apache.commons.math3.dfp.Dfp
Convert the instance into a double.
toFile(String) - Method in class jhplot.H1D
Write the H1D histogram to a file
toFile(String) - Method in class jhplot.HProf1D
Write the profile histogram to a file
toFile(String) - Method in class jhplot.P0D
Write a P0D to an external file.
toFile(String) - Method in class jhplot.P0I
Write a P0I to an external file.
toFile(String) - Method in class jhplot.P1D
Write a P1D to an external file.
toFile(String) - Method in class jhplot.P2D
Write a P2D to an external file.
toFile(String) - Method in class jhplot.P3D
Write a P3D to an external file.
toFile(String) - Method in class jhplot.PND
Write a PND to an external file.
toFile(String) - Method in class jhplot.PNI
Write a PNI to an external file.
toFile(String, String) - Method in class jplot.DataArray
Write a DataArray to an external file.
toFile(String, String) - Method in class jplot.DataArray2D
Write a DataArray to an external file.
toFile(String, String) - Method in class jplot.DataArray3D
Write a DataArray to an external file.
toFile(URL) - Static method in class org.apache.commons.io.FileUtils
Convert from a URL to a File.
toFileAsLatex(String, DecimalFormat, DecimalFormat) - Method in class jhplot.P1D
Write a File in form of LaTeX table from values in the container P1D
toFiles(URL...) - Static method in class org.apache.commons.io.FileUtils
Converts each of an array of URL to a File.
toFixedHeight(double) - Method in class org.jfree.chart.block.RectangleConstraint
Returns a constraint that matches this one on the width attributes, but has a fixed height constraint.
toFixedWidth(double) - Method in class org.jfree.chart.block.RectangleConstraint
Returns a constraint that matches this one on the height attributes, but has a fixed width constraint.
toFloat(double[]) - Static method in class jhplot.math.ArrayMathUtils
 
toFloat(long[]) - Static method in class jhplot.math.ArrayMathUtils
 
toFloat(int[]) - Static method in class jhplot.math.ArrayMathUtils
 
toFloat(double[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toFloat(long[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toFloat(int[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toFullString() - Method in class org.lsmp.djep.xjep.XOperator
returns a verbose representation of the operator and all its properties.
toggleAutoScaleZ() - Method in class jplot3d.SurfaceModelCanvas
 
toggleAutoTick() - Method in class org.jfree.chart.editor.DefaultLogAxisEditor
Toggles the auto-tick-unit setting.
toggleBoxed() - Method in class jplot3d.SurfaceModelCanvas
 
toggleDisplayGrids() - Method in class jplot3d.SurfaceModelCanvas
 
toggleDisplayXY() - Method in class jplot3d.SurfaceModelCanvas
 
toggleDisplayZ() - Method in class jplot3d.SurfaceModelCanvas
 
toggleExpectDelay() - Method in class jplot3d.SurfaceModelCanvas
 
toggleMesh() - Method in class jplot3d.SurfaceModelCanvas
 
togglePlotFunction1() - Method in class jplot3d.SurfaceModelCanvas
 
togglePlotFunction2() - Method in class jplot3d.SurfaceModelCanvas
 
toggleScaleBox() - Method in class jplot3d.SurfaceModelCanvas
 
toInputStream(CharSequence) - Static method in class org.apache.commons.io.IOUtils
toInputStream(CharSequence, Charset) - Static method in class org.apache.commons.io.IOUtils
Converts the specified CharSequence to an input stream, encoded as bytes using the specified character encoding.
toInputStream(CharSequence, String) - Static method in class org.apache.commons.io.IOUtils
Converts the specified CharSequence to an input stream, encoded as bytes using the specified character encoding.
toInputStream(String) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
toInputStream(String, Charset) - Static method in class org.apache.commons.io.IOUtils
Converts the specified string to an input stream, encoded as bytes using the specified character encoding.
toInputStream(String, String) - Static method in class org.apache.commons.io.IOUtils
Converts the specified string to an input stream, encoded as bytes using the specified character encoding.
toInputStream() - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
Gets the current contents of this byte stream as a Input Stream.
toInputStream() - Method in class org.apache.commons.io.output.ByteArrayOutputStream
 
toInputStream() - Method in class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
 
toInt(double[]) - Static method in class jhplot.math.ArrayMathUtils
 
toInt(float[]) - Static method in class jhplot.math.ArrayMathUtils
 
toInt(long[]) - Static method in class jhplot.math.ArrayMathUtils
 
toInt(float[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toInt(double[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toInt(long[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toInt(long) - Static method in class net.jafama.NumbersUtils
 
toIntExact(long) - Static method in class org.apache.commons.math3.util.FastMath
Convert a long to interger, detecting overflows
toJama(Matrix) - Static method in class org.lsmp.djep.jama.JamaUtil
 
toJamaCol(MVector) - Static method in class org.lsmp.djep.jama.JamaUtil
 
toJamaRow(MVector) - Static method in class org.lsmp.djep.jama.JamaUtil
 
toJava() - Method in class jhplot.F1D
Convert the function into Java code.
toJava() - Method in class jhplot.F2D
Convert the function into Java code.
toJava(String) - Static method in class jminhep.utils.StringUtil
 
Token - Class in jhplot.math.exp4j.tokenizer
Abstract class for tokens used by exp4j to tokenize expressions
token - Variable in class jplot3dp.MathParser.MathParser
 
Token - Class in jplot3dp.MathParser
Describes the input token stream.
Token() - Constructor for class jplot3dp.MathParser.Token
 
token - Variable in class org.nfunk.jep.Parser
 
Token - Class in org.nfunk.jep
Describes the input token stream.
Token() - Constructor for class org.nfunk.jep.Token
 
TOKEN_FUNCTION - Static variable in class jhplot.math.exp4j.tokenizer.Token
 
TOKEN_NUMBER - Static variable in class jhplot.math.exp4j.tokenizer.Token
 
TOKEN_OPERATOR - Static variable in class jhplot.math.exp4j.tokenizer.Token
 
TOKEN_PARENTHESES_CLOSE - Static variable in class jhplot.math.exp4j.tokenizer.Token
 
TOKEN_PARENTHESES_OPEN - Static variable in class jhplot.math.exp4j.tokenizer.Token
 
TOKEN_SEPARATOR - Static variable in class jhplot.math.exp4j.tokenizer.Token
 
token_source - Variable in class jplot3dp.MathParser.MathParser
 
token_source - Variable in class org.nfunk.jep.Parser
 
TOKEN_VARIABLE - Static variable in class jhplot.math.exp4j.tokenizer.Token
 
tokenImage - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
tokenImage - Variable in exception jplot3dp.MathParser.ParseException
This is a reference to the "tokenImage" array of the generated parser within which the parse error occurred.
tokenImage - Variable in exception org.nfunk.jep.ParseException
This is a reference to the "tokenImage" array of the generated parser within which the parse error occurred.
tokenImage - Static variable in interface org.nfunk.jep.ParserConstants
 
Tokenizer - Class in jhplot.math.exp4j.tokenizer
 
Tokenizer(String, Map<String, Function>, Map<String, Operator>, Set<String>) - Constructor for class jhplot.math.exp4j.tokenizer.Tokenizer
 
TokenMgrError - Error in jplot3dp.MathParser
 
TokenMgrError() - Constructor for error jplot3dp.MathParser.TokenMgrError
 
TokenMgrError(String, int) - Constructor for error jplot3dp.MathParser.TokenMgrError
 
TokenMgrError(boolean, int, int, int, String, char, int) - Constructor for error jplot3dp.MathParser.TokenMgrError
 
TokenMgrError - Error in org.nfunk.jep
 
TokenMgrError() - Constructor for error org.nfunk.jep.TokenMgrError
 
TokenMgrError(String, int) - Constructor for error org.nfunk.jep.TokenMgrError
 
TokenMgrError(boolean, int, int, int, String, char, int) - Constructor for error org.nfunk.jep.TokenMgrError
 
toLegalFileName(String, char) - Method in enum org.apache.commons.io.FileSystem
Converts a candidate file name (without a path) like "filename.ext" or "filename" to a legal file name.
tolerance() - Method in class cern.colt.matrix.linalg.Property
Returns the current tolerance.
toList() - Method in class cern.colt.list.AbstractBooleanList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractByteList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractCharList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractCollection
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractDoubleList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractFloatList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractIntList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractLongList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractShortList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.ObjectArrayList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList(DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a list from the given matrix.
toList(ObjectMatrix1D) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a list from the given matrix.
toList(IOFileFilter...) - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Create a List of file filters.
toList() - Method in class org.apache.commons.math3.fitting.WeightedObservedPoints
Gets a snapshot of the observed points.
toLong(double[]) - Static method in class jhplot.math.ArrayMathUtils
 
toLong(float[]) - Static method in class jhplot.math.ArrayMathUtils
 
toLong(int[]) - Static method in class jhplot.math.ArrayMathUtils
 
toLong(float[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toLong(double[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toLong(int[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toMathML() - Method in class jhplot.F1D
Convert the function into MathML form.
toMathML() - Method in class jhplot.F2D
Convert the function into MathML form.
toMillisecond(long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Translates a value relative to the timeline into a millisecond.
toMillisecond(long) - Method in interface org.jfree.chart.axis.Timeline
Translates a value relative to this timeline into a domain value.
toMIME(String) - Static method in class jminhep.utils.StringUtil
 
toMultivariateDifferentiableFunction(DifferentiableMultivariateFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated.
this conversion method is temporary in version 3.1, as the DifferentiableMultivariateFunction interface itself is deprecated
toMultivariateDifferentiableVectorFunction(DifferentiableMultivariateVectorFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated.
this conversion method is temporary in version 3.1, as the DifferentiableMultivariateFunction interface itself is deprecated
toNode() - Method in class org.lsmp.djep.sjep.Monomial
 
toNode() - Method in class org.lsmp.djep.sjep.PConstant
 
toNode() - Method in class org.lsmp.djep.sjep.PFunction
 
toNode() - Method in interface org.lsmp.djep.sjep.PNodeI
Converts the node to standard JEP format.
toNode() - Method in class org.lsmp.djep.sjep.Polynomial
 
toNode() - Method in class org.lsmp.djep.sjep.POperator
 
toNode() - Method in class org.lsmp.djep.sjep.PVariable
 
TooltipHandlerFX - Class in org.jfree.chart.fx.interaction
Handles the updating of tooltips on a ChartCanvas.
TooltipHandlerFX(String) - Constructor for class org.jfree.chart.fx.interaction.TooltipHandlerFX
Creates a new instance with the specified ID.
ToolTipTagFragmentGenerator - Interface in org.jfree.chart.imagemap
Interface for generating the tooltip fragment of an HTML image map area tag.
TooManyEvaluationsException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the maximal number of evaluations is exceeded.
TooManyEvaluationsException(Number) - Constructor for exception org.apache.commons.math3.exception.TooManyEvaluationsException
Construct the exception.
TooManyIterationsException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the maximal number of iterations is exceeded.
TooManyIterationsException(Number) - Constructor for exception org.apache.commons.math3.exception.TooManyIterationsException
Construct the exception.
TOP - Static variable in class graph.Axis
Constant flagging Axis position on the graph.
TOP_OR_LEFT - Static variable in class org.jfree.chart.axis.AxisLocation
Axis at the top or left.
TOP_OR_RIGHT - Static variable in class org.jfree.chart.axis.AxisLocation
Axis at the top or right.
TopographicErrorHistogram - Class in org.apache.commons.math3.ml.neuralnet.twod.util
Computes the topographic error histogram.
TopographicErrorHistogram(boolean, DistanceMeasure) - Constructor for class org.apache.commons.math3.ml.neuralnet.twod.util.TopographicErrorHistogram
 
toRadians(double) - Static method in class net.jafama.FastMath
Gives same result as Math.toRadians for some particular values like 90.0, 180.0 or 360.0, but is faster (no division).
toRadians(boolean, int, int, double) - Static method in class net.jafama.FastMath
 
toRadians(double) - Static method in class net.jafama.StrictFastMath
Gives same result as StrictMath.toRadians for some particular values like 90.0, 180.0 or 360.0, but is faster (no division).
toRadians(boolean, int, int, double) - Static method in class net.jafama.StrictFastMath
 
toRadians() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Convert degrees to radians, with error of less than 0.5 ULP
toRadians() - Method in class org.apache.commons.math3.analysis.differentiation.SparseGradient
Convert degrees to radians, with error of less than 0.5 ULP
toRadians(double) - Static method in class org.apache.commons.math3.util.FastMath
Convert degrees to radians, with error of less than 0.5 ULP
toRange(float, float, float) - Static method in class net.jafama.FastMath
 
toRange(double, double, double) - Static method in class net.jafama.FastMath
 
toRange(int, int, int) - Static method in class net.jafama.NumbersUtils
 
toRange(long, long, long) - Static method in class net.jafama.NumbersUtils
 
toRange(float, float, float) - Static method in class net.jafama.NumbersUtils
 
toRange(double, double, double) - Static method in class net.jafama.NumbersUtils
 
toRange(float, float, float) - Static method in class net.jafama.StrictFastMath
 
toRange(double, double, double) - Static method in class net.jafama.StrictFastMath
 
toRangeHeight(Range) - Method in class org.jfree.chart.block.RectangleConstraint
Returns a constraint that matches this one on the width attributes, but has a range height constraint.
toRangeWidth(Range) - Method in class org.jfree.chart.block.RectangleConstraint
Returns a constraint that matches this one on the height attributes, but has a range width constraint.
toRotation() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Convert to a constant vector without derivatives.
toSourceCode(DoubleMatrix1D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(DoubleMatrix2D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(DoubleMatrix3D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(ObjectMatrix1D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(ObjectMatrix2D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(ObjectMatrix3D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSpace(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Transform a sub-space point into a space point.
toSpace(Point<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Transform a sub-space point into a space point.
toSpace(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Transform a sub-space point into a space point.
toSpace(Point<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Transform an in-plane point into a 3D space point.
toSpace(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Transform a sub-space point into a space point.
toSpace(Point<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Transform a sub-space point into a space point.
toSpace(Point<T>) - Method in interface org.apache.commons.math3.geometry.partitioning.Embedding
Transform a sub-space point into a space point.
toSpace(Point<Sphere1D>) - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Transform a sub-space point into a space point.
toSplitDouble() - Method in class org.apache.commons.math3.dfp.Dfp
Convert the instance into a split double.
toString(byte[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(char[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(double[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(float[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(int[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(long[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(Object[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(short[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(boolean[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString() - Method in class cern.colt.bitvector.BitMatrix
Returns a (very crude) string representation of the receiver.
toString() - Method in class cern.colt.bitvector.BitVector
Returns a string representation of the receiver.
toString() - Method in class cern.colt.list.AbstractBooleanList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractByteList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractCharList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractCollection
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractDoubleList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractFloatList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractIntList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractLongList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractShortList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.ObjectArrayList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.map.AbstractDoubleIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.AbstractIntDoubleMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.AbstractIntIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.AbstractIntObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.AbstractLongObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString(DoubleMatrix1D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string representation of the given matrix.
toString(DoubleMatrix2D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string representation of the given matrix.
toString(DoubleMatrix3D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string representation of the given matrix.
toString() - Method in class cern.colt.matrix.DoubleMatrix1D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.DoubleMatrix2D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.DoubleMatrix3D
Returns a string representation using default formatting.
toString(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.linalg.CholeskyDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.linalg.EigenvalueDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns a String with (propertyName, propertyValue) pairs.
toString(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Returns summary information about the given matrix A.
toString() - Method in class cern.colt.matrix.linalg.QRDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString(ObjectMatrix1D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string representation of the given matrix.
toString(ObjectMatrix2D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string representation of the given matrix.
toString(ObjectMatrix3D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string representation of the given matrix.
toString() - Method in class cern.colt.matrix.ObjectMatrix1D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.ObjectMatrix2D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.ObjectMatrix3D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.Timer
Returns a String representation of the receiver.
toString() - Method in class cern.hep.aida.bin.AbstractBin
Returns a String representation of the receiver.
toString() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns a String representation of the receiver.
toString() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns a String representation of the receiver.
toString() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns a String representation of the receiver.
toString() - Method in class cern.hep.aida.bin.QuantileBin1D
Returns a String representation of the receiver.
toString(IAxis) - Method in class cern.hep.aida.ref.Converter
Returns a string representation of the given argument.
toString(IHistogram1D) - Method in class cern.hep.aida.ref.Converter
Returns a string representation of the given argument.
toString(IHistogram2D) - Method in class cern.hep.aida.ref.Converter
Returns a string representation of the given argument.
toString(IHistogram3D) - Method in class cern.hep.aida.ref.Converter
Returns a string representation of the given argument.
toString() - Method in class cern.jet.random.Beta
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Binomial
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.BreitWigner
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.ChiSquare
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Empirical
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.EmpiricalWalker
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Exponential
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.ExponentialPower
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Gamma
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Hyperbolic
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.HyperGeometric
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Logarithmic
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.NegativeBinomial
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Normal
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Poisson
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.PoissonSlow
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.StudentT
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Uniform
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.VonMises
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Zeta
Returns a String representation of the receiver.
toString() - Method in class fitter.BFunc
 
toString() - Method in class hep.physics.matrix.BasicMatrix
 
toString(Matrix) - Static method in class hep.physics.matrix.MatrixOp
 
toString() - Method in class hep.physics.matrix.SymmetricMatrix
 
toString() - Method in class hep.physics.vec.BasicHep3Matrix
 
toString() - Method in class hep.physics.vec.BasicHep3Vector
 
toString() - Method in class hep.physics.vec.BasicHepLorentzVector
 
toString() - Method in class hep.physics.vec.SpacePoint
Output Stream
toString(Hep3Vector) - Static method in class hep.physics.vec.VecOp
 
toString(HepLorentzVector) - Static method in class hep.physics.vec.VecOp
 
toString(Hep3Matrix) - Static method in class hep.physics.vec.VecOp
 
toString() - Method in class hephysics.jet.JetN2
Print the kT jets for debugging to a string.
toString() - Method in class hephysics.jet.KTjet
Print the kT jets for debugging to a string.
toString() - Method in class hephysics.jet.ParticleD
Convert a particle to a string.
toString() - Method in class hephysics.jet.ParticleF
Convert a particle to a string.
toString() - Method in class hephysics.jet.SCJet
Print the kT jets for debugging to a string.
toString() - Method in class hephysics.matrix.BasicMatrix
 
toString(Matrix) - Static method in class hephysics.matrix.MatrixOp
 
toString() - Method in class hephysics.matrix.SymmetricMatrix
 
toString() - Method in class hephysics.particle.HEParticle
Convert to string
toString() - Method in class hephysics.particle.LParticle
Convert to string
toString() - Method in class hephysics.vec.Hep3Matrix
 
toString() - Method in class hephysics.vec.Hep3Vector
 
toString() - Method in class hephysics.vec.HepLorentzVector
Convert to string
toString() - Method in class hephysics.vec.SpacePoint
Output Stream
toString(Hep3Vector) - Static method in class hephysics.vec.VecOp
 
toString(HepLorentzVector) - Static method in class hephysics.vec.VecOp
 
toString(Hep3Matrix) - Static method in class hephysics.vec.VecOp
 
toString() - Method in class j4np.physics.LorentzVector
 
toString() - Method in class j4np.physics.PDGParticle
 
toString() - Method in class j4np.physics.Vector3
 
toString() - Method in class Jama.Matrix
Convert matrix to a string
toString(Zmat, int, int) - Static method in class Jampack.Print
Prints a Zmat in w.d e format to String.
toString() - Method in class jhplot.F1D
Get this function as a string.
toString() - Method in class jhplot.F2D
Get this function as a string.
toString() - Method in class jhplot.F3D
Get this function as a string.
toString() - Method in class jhplot.FND
Convert to string
toString() - Method in class jhplot.FPR
Get this function as a string.
toString() - Method in class jhplot.H1D
Convert the histogram to a string
toString() - Method in class jhplot.H1DA
 
toString() - Method in class jhplot.HLabelEq
 
toString() - Method in class jhplot.io.FileRoot
Return all root objects in form of a string.
toString(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a comma delimited string representing the value of the array.
toString(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns a comma delimited string representing the value of the array.
toString(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a comma delimited string representing the value of the array.
toString(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns a comma delimited string representing the value of the array.
toString() - Method in class jhplot.math.Complex
String representation of this Complex number.
toString(double[]...) - Static method in class jhplot.math.DoubleArray
Generates a string that holds a nicely organized space-seperated version of a matrix or array.
toString(String, double[]...) - Static method in class jhplot.math.DoubleArray
Generates a string that holds a nicely organized version of a matrix or array.
toString(int[]...) - Static method in class jhplot.math.IntegerArray
 
toString(int, int) - Method in class jhplot.math.kalman.jama.Matrix
Hybrid toString.
toString() - Method in class jhplot.math.kalman.jama.Matrix
Overrides the Object toString() method.
toString() - Method in class jhplot.math.ValueErr
Convert to a string
toString() - Method in class jhplot.P0D
Get a P0D as a string.
toString() - Method in class jhplot.P0I
Get a P0I as a string.
toString() - Method in class jhplot.P1D
Convert to a string
toString() - Method in class jhplot.P2D
Convert to a string
toString() - Method in class jhplot.PND
Get a string representing PND
toString() - Method in class jhplot.PNI
Get a string representing PNI
toString() - Method in class jhplot.shapes.Arrow
Represent it as a string
toString() - Method in class jhplot.shapes.Circle
Show it as a string
toString() - Method in class jhplot.shapes.Ellipse
Show it as a string
toString() - Method in class jhplot.shapes.Line
Show it as a string
toString() - Method in class jhplot.shapes.Picture
 
toString() - Method in class jhplot.shapes.Rectan
 
toString() - Method in class jhplot.shapes.Text
Show this object
toString() - Method in class jminhep.cluster.DataHolder
Convert to string all entries of the data holder
toString() - Method in class jminhep.cluster.DataPoint
Returns a string representation of this DataPoint
toString() - Method in class jplot.DataArray
Print a data container on the screen
toString() - Method in class jplot.GraphLabel
 
toString() - Method in class jplot3dp.MathParser.Token
Returns the image.
toString() - Method in class jplot3dp.ModelView.ModelFunction
 
toString() - Method in class net.jafama.DoubleWrapper
 
toString() - Method in class net.jafama.IntWrapper
 
toString(int) - Static method in class net.jafama.NumbersUtils
This method just delegates to Integer.toString(int), but is defined here to complete the API.
toString(long) - Static method in class net.jafama.NumbersUtils
This method just delegates to Long.toString(long), but is defined here to complete the API.
toString(int, int) - Static method in class net.jafama.NumbersUtils
 
toString(long, int) - Static method in class net.jafama.NumbersUtils
 
toString(int, int, int) - Static method in class net.jafama.NumbersUtils
 
toString(long, int, int) - Static method in class net.jafama.NumbersUtils
 
toString() - Method in class org.apache.commons.io.ByteOrderMark
Provide a String representation of the BOM.
toString() - Method in class org.apache.commons.io.comparator.CompositeFileComparator
String representation of this file comparator.
toString() - Method in class org.apache.commons.io.comparator.ExtensionFileComparator
String representation of this file comparator.
toString() - Method in class org.apache.commons.io.comparator.NameFileComparator
String representation of this file comparator.
toString() - Method in class org.apache.commons.io.comparator.PathFileComparator
String representation of this file comparator.
toString() - Method in class org.apache.commons.io.comparator.SizeFileComparator
String representation of this file comparator.
toString() - Method in class org.apache.commons.io.file.CountingPathVisitor
 
toString() - Method in class org.apache.commons.io.FileDeleteStrategy
Gets a string describing the delete strategy.
toString() - Method in class org.apache.commons.io.filefilter.AbstractFileFilter
Provide a String representation of this file filter.
toString() - Method in class org.apache.commons.io.filefilter.AgeFileFilter
Provide a String representation of this file filter.
toString() - Method in class org.apache.commons.io.filefilter.AndFileFilter
Provide a String representation of this file filter.
toString() - Method in class org.apache.commons.io.filefilter.DelegateFileFilter
Provide a String representation of this file filter.
toString() - Method in class org.apache.commons.io.filefilter.MagicNumberFileFilter
Returns a String representation of the file filter, which includes the magic number bytes and byte offset.
toString() - Method in class org.apache.commons.io.filefilter.NameFileFilter
Provide a String representation of this file filter.
toString() - Method in class org.apache.commons.io.filefilter.NotFileFilter
Provide a String representation of this file filter.
toString() - Method in class org.apache.commons.io.filefilter.OrFileFilter
Provide a String representation of this file filter.
toString() - Method in class org.apache.commons.io.filefilter.PrefixFileFilter
Provide a String representation of this file filter.
toString() - Method in class org.apache.commons.io.filefilter.SizeFileFilter
Provide a String representation of this file filter.
toString() - Method in class org.apache.commons.io.filefilter.SuffixFileFilter
Provide a String representation of this file filter.
toString() - Method in class org.apache.commons.io.filefilter.WildcardFileFilter
Provide a String representation of this file filter.
toString() - Method in class org.apache.commons.io.input.BoundedInputStream
Invokes the delegate's toString() method.
toString() - Method in class org.apache.commons.io.input.CharSequenceReader
Return a String representation of the underlying character sequence.
toString(int) - Method in class org.apache.commons.io.input.ReversedLinesFileReader
Returns the last lineCount lines of the file.
toString() - Method in enum org.apache.commons.io.IOCase
Gets a string describing the sensitivity.
toString(byte[]) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
2.5 Use String.String(byte[]) instead
toString(byte[], String) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a byte[] as a String using the specified character encoding.
toString(InputStream) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
toString(InputStream, Charset) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of an InputStream as a String using the specified character encoding.
toString(InputStream, String) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of an InputStream as a String using the specified character encoding.
toString(Reader) - Static method in class org.apache.commons.io.IOUtils
Gets the contents of a Reader as a String.
toString(URI) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
toString(URI, Charset) - Static method in class org.apache.commons.io.IOUtils
Gets the contents at the given URI.
toString(URI, String) - Static method in class org.apache.commons.io.IOUtils
Gets the contents at the given URI.
toString(URL) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
toString(URL, Charset) - Static method in class org.apache.commons.io.IOUtils
Gets the contents at the given URL.
toString(URL, String) - Static method in class org.apache.commons.io.IOUtils
Gets the contents at the given URL.
toString() - Method in class org.apache.commons.io.monitor.FileAlterationObserver
Returns a String representation of this observer.
toString() - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
toString(String) - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
Gets the current contents of this byte stream as a string using the specified encoding.
toString(Charset) - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
Gets the current contents of this byte stream as a string using the specified encoding.
toString() - Method in class org.apache.commons.io.output.StringBuilderWriter
toString() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Returns a string representation of the polynomial.
toString() - Method in class org.apache.commons.math3.complex.Complex
toString() - Method in class org.apache.commons.math3.complex.Quaternion
toString() - Method in class org.apache.commons.math3.dfp.Dfp
Get a string representation of the instance.
toString() - Method in class org.apache.commons.math3.exception.util.DummyLocalizable
toString() - Method in class org.apache.commons.math3.fitting.leastsquares.GaussNewtonOptimizer
toString() - Method in class org.apache.commons.math3.fraction.BigFraction
Returns the String representing this fraction, ie "num / dem" or just "num" if the denominator is one.
toString() - Method in class org.apache.commons.math3.fraction.Fraction
Returns the String representing this fraction, ie "num / dem" or just "num" if the denominator is one.
toString() - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
toString() - Method in class org.apache.commons.math3.genetics.ChromosomePair
toString() - Method in class org.apache.commons.math3.genetics.ListPopulation
toString() - Method in class org.apache.commons.math3.genetics.RandomKey
toString() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get a string representation of this vector.
toString(NumberFormat) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get a string representation of this vector.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get a string representation of this vector.
toString(NumberFormat) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get a string representation of this vector.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Get a string representation of the instance.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get a string representation of this vector.
toString(NumberFormat) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get a string representation of this vector.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get a string representation of this vector.
toString(NumberFormat) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get a string representation of this vector.
toString(NumberFormat) - Method in interface org.apache.commons.math3.geometry.Vector
Get a string representation of this vector.
toString() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get a string representation for this matrix.
toString() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get a string representation for this matrix.
toString() - Method in class org.apache.commons.math3.linear.ArrayRealVector
toString() - Method in class org.apache.commons.math3.ml.clustering.DoublePoint
toString() - Method in enum org.apache.commons.math3.optim.linear.Relationship
toString() - Method in enum org.apache.commons.math3.optimization.linear.Relationship
Deprecated.
toString() - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
Deprecated.
toString() - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
Deprecated.
toString() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Generates a text report displaying univariate statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile
Returns a string containing the last observation, the current estimate of the quantile and all markers.
toString() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
Generates a text report displaying values of statistics.
toString() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Generates a text report displaying univariate statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.Frequency
Return a string representation of this frequency distribution.
toString() - Method in class org.apache.commons.math3.stat.interval.ConfidenceInterval
 
toString() - Method in class org.apache.commons.math3.util.Decimal64
The returned String is equal to Double.toString(this.doubleValue())
toString() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
toString() - Method in class org.apache.commons.math3.util.Pair
toString() - Method in class org.freehep.math.minuit.ContoursError
 
toString() - Method in class org.freehep.math.minuit.FunctionMinimum
 
toString() - Method in class org.freehep.math.minuit.MinosError
 
toString() - Method in class org.freehep.math.minuit.MnGlobalCorrelationCoeff
 
toString() - Method in class org.freehep.math.minuit.MnUserCovariance
 
toString() - Method in class org.freehep.math.minuit.MnUserParameters
 
toString() - Method in class org.freehep.math.minuit.MnUserParameterState
 
toString() - Method in class org.jfree.chart.axis.AxisLabelLocation
Returns a string representing the object.
toString() - Method in class org.jfree.chart.axis.AxisLocation
Returns a string representing the object.
toString() - Method in class org.jfree.chart.axis.AxisSpace
Returns a string representing the object (for debugging purposes).
toString() - Method in class org.jfree.chart.axis.CategoryAnchor
Returns a string representing the object.
toString() - Method in class org.jfree.chart.axis.CategoryLabelWidthType
Returns a string representing the object.
toString() - Method in class org.jfree.chart.axis.DateTickMarkPosition
Returns a string representing the object.
toString() - Method in class org.jfree.chart.axis.DateTickUnit
Returns a string representation of this instance, primarily used for debugging purposes.
toString() - Method in class org.jfree.chart.axis.DateTickUnitType
Returns a string representing the object.
toString() - Method in class org.jfree.chart.axis.NumberTickUnit
Returns a string representing this unit.
toString() - Method in class org.jfree.chart.axis.Tick
Returns a string representation of the tick.
toString() - Method in class org.jfree.chart.axis.TickType
Returns a string representing the object.
toString() - Method in class org.jfree.chart.block.LengthConstraintType
Returns a string representing the object.
toString() - Method in class org.jfree.chart.block.RectangleConstraint
Returns a string representation of this instance, mostly used for debugging purposes.
toString() - Method in class org.jfree.chart.entity.AxisEntity
Returns a string representation of the chart entity, useful for debugging.
toString() - Method in class org.jfree.chart.entity.CategoryItemEntity
Returns a string representing this object (useful for debugging purposes).
toString() - Method in class org.jfree.chart.entity.CategoryLabelEntity
Returns a string representation of this entity.
toString() - Method in class org.jfree.chart.entity.ChartEntity
Returns a string representation of the chart entity, useful for debugging.
toString() - Method in class org.jfree.chart.entity.JFreeChartEntity
Returns a string representation of the chart entity, useful for debugging.
toString() - Method in class org.jfree.chart.entity.LegendItemEntity
Returns a string representing this object (useful for debugging purposes).
toString() - Method in class org.jfree.chart.entity.PieSectionEntity
Returns a string representing the entity.
toString() - Method in class org.jfree.chart.entity.PlotEntity
Returns a string representation of the plot entity, useful for debugging.
toString() - Method in class org.jfree.chart.entity.TitleEntity
Returns a string representation of the chart entity, useful for debugging.
toString() - Method in class org.jfree.chart.entity.XYItemEntity
Returns a string representation of this instance, useful for debugging purposes.
toString() - Method in class org.jfree.chart.event.ChartChangeEventType
Returns a string representing the object.
toString() - Method in class org.jfree.chart.labels.ItemLabelAnchor
Returns a string representing the object.
toString() - Method in class org.jfree.chart.LegendRenderingOrder
Returns a string representing the object.
toString() - Method in class org.jfree.chart.plot.DatasetRenderingOrder
Returns a string representing the object.
toString() - Method in class org.jfree.chart.plot.DialShape
Returns a string representing the object.
toString() - Method in class org.jfree.chart.plot.PieLabelDistributor
Returns a string containing a description of the object for debugging purposes.
toString() - Method in class org.jfree.chart.plot.PieLabelLinkStyle
Returns a string representing the object.
toString() - Method in class org.jfree.chart.plot.PieLabelRecord
Returns a string describing the object.
toString() - Method in class org.jfree.chart.plot.PlotOrientation
Returns a string representing the object.
toString() - Method in class org.jfree.chart.plot.PolarAxisLocation
Returns a string representing the object.
toString() - Method in class org.jfree.chart.plot.SeriesRenderingOrder
Returns a string representing the object.
toString() - Method in class org.jfree.chart.renderer.AreaRendererEndType
Returns a string representing the object.
toString() - Method in class org.jfree.chart.renderer.Outlier
Returns a textual representation of the outlier.
toString() - Method in class org.jfree.chart.util.XYCoordinateType
Returns a string representing the object.
toString() - Method in class org.jfree.data.DefaultKeyedValue
Returns a string representing this instance, primarily useful for debugging.
toString() - Method in class org.jfree.data.DomainOrder
Returns a string representing the object.
toString() - Method in class org.jfree.data.KeyedValueComparatorType
Returns a string representing the object.
toString() - Method in class org.jfree.data.Range
Returns a string representation of this Range.
toString() - Method in class org.jfree.data.RangeType
Returns a string representing the object.
toString() - Method in class org.jfree.data.statistics.BoxAndWhiskerItem
Returns a string representation of this instance, primarily for debugging purposes.
toString() - Method in class org.jfree.data.statistics.HistogramType
Returns a string representing the object.
toString() - Method in class org.jfree.data.statistics.MeanAndStandardDeviation
Returns a string representing this instance.
toString() - Method in class org.jfree.data.time.DateRange
Returns a string representing the date range (useful for debugging).
toString() - Method in class org.jfree.data.time.Day
Returns a string representing the day.
toString() - Method in class org.jfree.data.time.Hour
Returns a string representation of this instance, for debugging purposes.
toString() - Method in class org.jfree.data.time.Month
Returns a string representing the month (e.g.
toString() - Method in class org.jfree.data.time.Quarter
Returns a string representing the quarter (e.g.
toString() - Method in class org.jfree.data.time.RegularTimePeriod
Returns a string representation of the time period.
toString() - Method in class org.jfree.data.time.TimePeriodAnchor
Returns a string representing the object.
toString() - Method in class org.jfree.data.time.TimePeriodValue
Returns a string representing this instance, primarily for use in debugging.
toString() - Method in class org.jfree.data.time.Week
Returns a string representing the week (e.g.
toString() - Method in class org.jfree.data.time.Year
Returns a string representing the year..
toString() - Method in class org.jfree.data.xy.XYCoordinate
Returns a string representation of this instance, primarily for debugging purposes.
toString() - Method in class org.jfree.data.xy.XYDataItem
Returns a string representing this instance, primarily for debugging use.
toString() - Method in class org.jlab.groot.base.Attributes
 
toString() - Method in class org.jlab.groot.base.PadMargins
 
toString() - Method in class org.jlab.groot.data.H1F
Overrides the toString method of type Object
toString() - Method in class org.jlab.groot.graphics.GraphicsAxis
returns string representation of the axis.
toString() - Method in class org.jlab.groot.group.DataGroupDescriptor
 
toString() - Method in class org.jlab.groot.io.TextFileReader
returns string representation of the array that was read.
toString() - Method in class org.jlab.groot.math.Dimension1D
 
toString() - Method in class org.jlab.groot.math.Dimension2D
 
toString() - Method in class org.jlab.groot.math.Dimension3D
 
toString() - Method in class org.jlab.groot.math.Func1D
 
toString() - Method in class org.jlab.groot.math.UserParameter
 
toString() - Method in class org.jlab.groot.math.UserParameters
 
toString() - Method in class org.jlab.groot.matrix.SparseIndex
 
toString() - Method in class org.jlab.groot.tree.Branch
 
toString() - Method in class org.jlab.groot.tree.Tree
 
toString() - Method in class org.jlab.groot.ui.GraphicsAxis
returns string representation of the axis.
toString() - Method in class org.jlab.groot.ui.GraphicsAxisLabels
 
toString() - Method in class org.lsmp.djep.djep.diffRules.AdditionDiffRule
 
toString() - Method in class org.lsmp.djep.djep.diffRules.ChainRuleDiffRules
 
toString() - Method in class org.lsmp.djep.djep.diffRules.DivideDiffRule
 
toString() - Method in class org.lsmp.djep.djep.diffRules.MultiplyDiffRule
 
toString() - Method in class org.lsmp.djep.djep.diffRules.PassThroughDiffRule
 
toString() - Method in class org.lsmp.djep.djep.diffRules.PowerDiffRule
 
toString() - Method in class org.lsmp.djep.djep.diffRules.SubtractDiffRule
 
toString() - Method in interface org.lsmp.djep.djep.DiffRulesI
Returns a string representation of the rule.
toString(PrintVisitor) - Method in class org.lsmp.djep.djep.DVariable
 
toString() - Method in class org.lsmp.djep.djep.PartialDerivative
 
toString() - Method in class org.lsmp.djep.groupJep.groups.AlgebraicExtension
 
toString() - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
toString() - Method in class org.lsmp.djep.groupJep.groups.Group
 
toString() - Method in class org.lsmp.djep.groupJep.groups.Integers
 
toString() - Method in class org.lsmp.djep.groupJep.groups.Quaternions.Quaternion
 
toString() - Method in class org.lsmp.djep.groupJep.groups.Quaternions
 
toString() - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
toString() - Method in class org.lsmp.djep.groupJep.groups.Reals
 
toString() - Method in class org.lsmp.djep.groupJep.groups.Zn
 
toString() - Method in class org.lsmp.djep.groupJep.values.Permutation
 
toString() - Method in class org.lsmp.djep.groupJep.values.Polynomial
 
toString() - Method in class org.lsmp.djep.groupJep.values.Rational
 
toString() - Method in class org.lsmp.djep.mrpe.MRpCommandList
converts list to a string.
toString() - Method in class org.lsmp.djep.rpe.RpCommand
 
toString() - Method in class org.lsmp.djep.rpe.RpCommandList
 
toString() - Method in class org.lsmp.djep.sjep.Monomial
 
toString() - Method in class org.lsmp.djep.sjep.MutiableMonomial
 
toString() - Method in class org.lsmp.djep.sjep.MutiablePolynomial
 
toString() - Method in class org.lsmp.djep.sjep.PConstant
 
toString() - Method in class org.lsmp.djep.sjep.PFunction
 
toString() - Method in interface org.lsmp.djep.sjep.PNodeI
Produces a string representation of the argument.
toString() - Method in class org.lsmp.djep.sjep.Polynomial
 
toString() - Method in class org.lsmp.djep.sjep.POperator
 
toString() - Method in class org.lsmp.djep.sjep.PVariable
 
toString() - Method in class org.lsmp.djep.vectorJep.Dimensions
A string representation.
toString() - Method in class org.lsmp.djep.vectorJep.values.Matrix
Returns a string representation of matrix.
toString() - Method in class org.lsmp.djep.vectorJep.values.MVector
 
toString() - Method in class org.lsmp.djep.vectorJep.values.Scaler
 
toString() - Method in class org.lsmp.djep.vectorJep.values.Tensor
Returns a string rep of tensor.
toString(Node) - Method in class org.lsmp.djep.xjep.PrintVisitor
returns a String representation of the equation.
toString(Node) - Method in class org.lsmp.djep.xjep.XJep
Returns a string representation of a expression tree.
toString(PrintVisitor) - Method in class org.lsmp.djep.xjep.XVariable
Returns a string rep of variable with its equation and value.
toString() - Method in class org.nfunk.jep.ASTConstant
 
toString() - Method in class org.nfunk.jep.ASTFunNode
Returns a string containing the function name.
toString() - Method in class org.nfunk.jep.ASTVarNode
Creates a string containing the variable's name and value
toString() - Method in class org.nfunk.jep.Operator
returns a verbose representation of the operator.
toString() - Method in class org.nfunk.jep.SimpleNode
 
toString(String) - Method in class org.nfunk.jep.SimpleNode
 
toString() - Method in class org.nfunk.jep.SymbolTable
Returns a list of variables, one per line.
toString() - Method in class org.nfunk.jep.Token
Returns the image.
toString() - Method in class org.nfunk.jep.type.Complex
Returns the value of this complex number as a string in the format:
toString(NumberFormat) - Method in class org.nfunk.jep.type.Complex
 
toString(NumberFormat, boolean) - Method in class org.nfunk.jep.type.Complex
Prints using specified number format in format or "2" or "3 i" or "(2+3 i)" if flag is true or "2+3 i" if flag is false
toString() - Method in class org.nfunk.jep.Variable
Returns a string with the variable name followed by it's value.
toStringBits(byte) - Static method in class net.jafama.NumbersUtils
 
toStringBits(short) - Static method in class net.jafama.NumbersUtils
 
toStringBits(int) - Static method in class net.jafama.NumbersUtils
 
toStringBits(long) - Static method in class net.jafama.NumbersUtils
 
toStringBits(byte, int, int, boolean, boolean) - Static method in class net.jafama.NumbersUtils
 
toStringBits(short, int, int, boolean, boolean) - Static method in class net.jafama.NumbersUtils
 
toStringBits(int, int, int, boolean, boolean) - Static method in class net.jafama.NumbersUtils
 
toStringBits(long, int, int, boolean, boolean) - Static method in class net.jafama.NumbersUtils
 
toStringByValue() - Method in class cern.colt.map.AbstractDoubleIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.AbstractIntDoubleMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.AbstractIntIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.AbstractIntObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value, according to natural ordering.
toStringByValue() - Method in class cern.colt.map.AbstractLongObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value, according to natural ordering.
toStringCSN(double) - Static method in class net.jafama.NumbersUtils
 
toStringNoCSN(double) - Static method in class net.jafama.NumbersUtils
 
toStringShort() - Method in class cern.colt.matrix.impl.AbstractMatrix1D
Returns a string representation of the receiver's shape.
toStringShort() - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Returns a string representation of the receiver's shape.
toStringShort() - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Returns a string representation of the receiver's shape.
toSubSpace(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Transform a space point into a sub-space point.
toSubSpace(Point<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Transform a space point into a sub-space point.
toSubSpace(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Transform a space point into a sub-space point.
toSubSpace(Point<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Transform a 3D space point into an in-plane point.
toSubSpace(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Transform a space point into a sub-space point.
toSubSpace(Point<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Transform a space point into a sub-space point.
toSubSpace(Point<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Embedding
Transform a space point into a sub-space point.
toSubSpace(Point<Sphere2D>) - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Transform a space point into a sub-space point.
toTable() - Method in class jhplot.F1D
Print the F1D function to a Table in a separate Frame.
toTable() - Method in class jhplot.H1D
Print a H1D histogram to a Table in a separate frame.
toTable() - Method in class jhplot.HProf1D
Print the profile histogram to a Table in a separate Frame.
toTable() - Method in class jhplot.P0D
Print the P0D container to a Table in a separate Frame.
toTable() - Method in class jhplot.P0I
Print the P0I container to a Table in a separate Frame.
toTable() - Method in class jhplot.P1D
Show in a Table in a separate Frame.
toTable() - Method in class jhplot.P2D
Print the P2D container to a Table in a separate Frame.
toTable() - Method in class jhplot.P3D
Print the P2D container to a Table in a separate Frame.
toTable() - Method in class jhplot.PND
Show container to a Table in a separate Frame.
toTable() - Method in class jhplot.PNI
Show container to a Table in a separate Frame.
totalMemory() - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Returns the number of elements currently needed to store all contained elements.
toTimelineValue(long) - Method in class org.jfree.chart.axis.SegmentedTimeline
Translates a value relative to the domain value (all Dates) into a value relative to the segmented timeline.
toTimelineValue(Date) - Method in class org.jfree.chart.axis.SegmentedTimeline
Translates a date into a value relative to the segmented timeline.
toTimelineValue(long) - Method in interface org.jfree.chart.axis.Timeline
Translates a millisecond (as defined by java.util.Date) into an index along this timeline.
toTimelineValue(Date) - Method in interface org.jfree.chart.axis.Timeline
Translates a date into a value on this timeline.
toTitleString(DoubleMatrix2D, String[], String[], String, String, String, BinFunction1D[]) - Method in class cern.colt.matrix.doublealgo.Formatter
Same as toTitleString except that additionally statistical aggregates (mean, median, sum, etc.) of rows and columns are printed.
toTitleString(DoubleMatrix3D, String[], String[], String[], String, String, String, String, BinFunction1D[]) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string representation of the given matrix with axis as well as rows and columns labeled.
toTitleString(ObjectMatrix2D, String[], String[], String, String, String) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string representation of the given matrix with axis as well as rows and columns labeled.
toTitleString(ObjectMatrix3D, String[], String[], String[], String, String, String, String) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string representation of the given matrix with axis as well as rows and columns labeled.
touch(File) - Static method in class org.apache.commons.io.FileUtils
Implements the same behavior as the "touch" utility on Unix.
toUnconstrainedHeight() - Method in class org.jfree.chart.block.RectangleConstraint
Returns a constraint that matches this one on the width attributes, but has no height constraint.
toUnconstrainedWidth() - Method in class org.jfree.chart.block.RectangleConstraint
Returns a constraint that matches this one on the height attributes, but has no width constraint.
toUnivariateDifferential(DifferentiableUnivariateFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated.
this conversion method is temporary in version 3.1, as the DifferentiableUnivariateFunction interface itself is deprecated
toURLs(File...) - Static method in class org.apache.commons.io.FileUtils
Converts each of an array of File to a URL.
TournamentSelection - Class in org.apache.commons.math3.genetics
Tournament selection scheme.
TournamentSelection(int) - Constructor for class org.apache.commons.math3.genetics.TournamentSelection
Creates a new TournamentSelection instance.
toUserX(int) - Method in class jplot.GraphGeneral
Returns the X-value scaled to the data-availability.
toUserX(int) - Method in class jplot.GraphXY
Move to User coordinatess
toUserY(int) - Method in class jplot.GraphGeneral
Returns the Y-value scaled to the data-availability.
toUserY(int) - Method in class jplot.GraphXY
Move to User coordinatess
toVecMat() - Method in class org.lsmp.djep.mrpe.MRpRes
Converts to a MatrixValueI object.
toVector3D() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Convert to a constant vector without derivatives.
toVerboseString(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the results of toString(A) and additionally the results of all sorts of decompositions applied to the given matrix.
toX(double) - Method in class jhplot.HPlot
Convert the user coordinate X to the pixel coordinate
toX(double) - Method in class jplot.GraphGeneral
Returns the X-value scaled to the pixel-availability.
toX(double) - Method in class jplot.GraphXY
Returns the X-value scaled to the pixel-availability.
toXML(IHistogram1D) - Method in class cern.hep.aida.ref.Converter
Returns a XML representation of the given argument.
toXML(IHistogram2D) - Method in class cern.hep.aida.ref.Converter
Returns a XML representation of the given argument.
toXML(Object) - Static method in class jhplot.io.Serialized
Convert object to XML using XSream package
toXML(Object) - Static method in class jhplot.IO
Convert object to XML using XSream package
toY(double) - Method in class jhplot.HPlot
Convert the user coordinate Y to the pixel coordinate
toY(double) - Method in class jplot.GraphGeneral
Returns the Y-value scaled to the pixel-availability.
toY(double) - Method in class jplot.GraphXY
Returns the Y-value scaled to the pixel-availability.
TPCBIT_NO_PTR - Static variable in interface hep.lcio.event.LCIO
 
TPCBIT_RAW - Static variable in interface hep.lcio.event.LCIO
 
TPCHIT - Static variable in interface hep.lcio.event.LCIO
 
TPCHit - Interface in hep.lcio.event
Deprecated. 
trace(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the sum of the diagonal elements of matrix A; Sum(A[i,i]).
trace() - Method in class hep.physics.vec.BasicHep3Matrix
Returns the trace of the matrix.
trace() - Method in interface hep.physics.vec.Hep3Matrix
return trace
trace() - Method in class hephysics.vec.Hep3Matrix
Returns the trace of the matrix.
trace() - Method in class Jama.Matrix
Matrix trace.
trace() - Method in class jhplot.math.kalman.jama.Matrix
Matrix trace.
trace(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
Trace - Class in org.lsmp.djep.vectorJep.function
Calculate the trace of a matrix trace([[1,2],[3,4]]) -> 1+4 = 5
Trace() - Constructor for class org.lsmp.djep.vectorJep.function.Trace
 
TRACK - Static variable in interface hep.lcio.event.LCIO
 
Track - Interface in hep.lcio.event
The LCIO track class.
track(File, Object) - Static method in class org.apache.commons.io.FileCleaner
track(File, Object, FileDeleteStrategy) - Static method in class org.apache.commons.io.FileCleaner
track(String, Object) - Static method in class org.apache.commons.io.FileCleaner
track(String, Object, FileDeleteStrategy) - Static method in class org.apache.commons.io.FileCleaner
track(File, Object) - Method in class org.apache.commons.io.FileCleaningTracker
Track the specified file, using the provided marker, deleting the file when the marker instance is garbage collected.
track(File, Object, FileDeleteStrategy) - Method in class org.apache.commons.io.FileCleaningTracker
Track the specified file, using the provided marker, deleting the file when the marker instance is garbage collected.
track(String, Object) - Method in class org.apache.commons.io.FileCleaningTracker
Track the specified file, using the provided marker, deleting the file when the marker instance is garbage collected.
track(String, Object, FileDeleteStrategy) - Method in class org.apache.commons.io.FileCleaningTracker
Track the specified file, using the provided marker, deleting the file when the marker instance is garbage collected.
TRACKERDATA - Static variable in interface hep.lcio.event.LCIO
 
TrackerData - Interface in hep.lcio.event
TrackerData contains the corrected (calibrated) raw tracker data.
TRACKERHIT - Static variable in interface hep.lcio.event.LCIO
 
TrackerHit - Interface in hep.lcio.event
A generic tracker hit to be used by pattern recognition.
TRACKERHITPLANE - Static variable in interface hep.lcio.event.LCIO
 
TrackerHitPlane - Interface in hep.lcio.event
A tracker hit on a planar surface - the hit is stored as:
x,y,z, u(theta, phi), v(theta,phi), du, dv
where (x,y,z) is the position in global cartesian coordinates, u,v are the the meassurement directions (unit vectors, spanning the plane) and du,dv are the measurement errors along these directions.
TRACKERHITZCYLINDER - Static variable in interface hep.lcio.event.LCIO
 
TrackerHitZCylinder - Interface in hep.lcio.event
A tracker hit on a cylindrical surface that runs parallel to the z-axis - the hit is stored as:
x,y,z, center(x,y), dRPhi, dz
where (x,y,z) is the position in global cartesian coordinates, center(x,y) is the center of the cylinder and Rphi and z are the measurement errors.
TRACKERPULSE - Static variable in interface hep.lcio.event.LCIO
 
TrackerPulse - Interface in hep.lcio.event
Tracker pulses as computed from TrackerData objects or as directly measured by a specific subdetector.
TRACKERRAWDATA - Static variable in interface hep.lcio.event.LCIO
 
TrackerRawData - Interface in hep.lcio.event
Generic class for raw tracker data.
TRACKS_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent
 
TRACKSTATE - Static variable in interface hep.lcio.event.LCIO
 
TrackState - Interface in hep.lcio.event
The LCIO TrackState class.
TRandomVariable - Class in jhplot.math.num.random
A random variable generator for Student's t distribution.
TRandomVariable() - Constructor for class jhplot.math.num.random.TRandomVariable
Default constructor.
TRandomVariable(double) - Constructor for class jhplot.math.num.random.TRandomVariable
Create a random variable with the given degrees of freedom.
TRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.TRandomVariable
Create a random variable with the given parameters.
trans(Zmat) - Static method in class Jampack.H
Returns the transpose of a Zmat.
TransferableImage - Class in org.jlab.groot.ui
 
TransferableImage(Image) - Constructor for class org.jlab.groot.ui.TransferableImage
 
Transform - Class in cern.colt.matrix.doublealgo
Deprecated. 
transform - Static variable in class cern.colt.matrix.doublealgo.Transform
Deprecated.
Little trick to allow for "aliasing", that is, renaming this class.
transform(Matrix, PCA.TransformationType) - Method in class jhplot.math.pca.PCA
Execute selected transformation on given data.
transform(Projector) - Method in class jplot3d.SurfaceVertex
Transforms coordinate values to fit the scaling factor of the projector.
Transform<S extends Space,T extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface represents an inversible affine transform in a space.
transform(double[], TransformType) - Method in class org.apache.commons.math3.transform.FastCosineTransformer
Returns the (forward, inverse) transform of the specified real data set.
transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.apache.commons.math3.transform.FastCosineTransformer
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
transform(double[], TransformType) - Method in class org.apache.commons.math3.transform.FastFourierTransformer
Returns the (forward, inverse) transform of the specified real data set.
transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.apache.commons.math3.transform.FastFourierTransformer
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
transform(Complex[], TransformType) - Method in class org.apache.commons.math3.transform.FastFourierTransformer
Returns the (forward, inverse) transform of the specified complex data set.
transform(double[], TransformType) - Method in class org.apache.commons.math3.transform.FastHadamardTransformer
Returns the (forward, inverse) transform of the specified real data set.
transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.apache.commons.math3.transform.FastHadamardTransformer
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
transform(int[]) - Method in class org.apache.commons.math3.transform.FastHadamardTransformer
Returns the forward transform of the specified integer data set.The integer transform cannot be inverted directly, due to a scaling factor which may lead to double results.
transform(double[], TransformType) - Method in class org.apache.commons.math3.transform.FastSineTransformer
Returns the (forward, inverse) transform of the specified real data set.
transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.apache.commons.math3.transform.FastSineTransformer
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
transform(double[], TransformType) - Method in interface org.apache.commons.math3.transform.RealTransformer
Returns the (forward, inverse) transform of the specified real data set.
transform(UnivariateFunction, double, double, int, TransformType) - Method in interface org.apache.commons.math3.transform.RealTransformer
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
transform(Object) - Method in class org.apache.commons.math3.util.DefaultTransformer
 
transform(Object) - Method in interface org.apache.commons.math3.util.NumberTransformer
Implementing this interface provides a facility to transform from Object to Double.
transform(Object) - Method in class org.apache.commons.math3.util.TransformerMap
Attempts to transform the Object against the map of NumberTransformers.
transform(AffineTransform) - Method in class org.jfree.chart.fx.FXGraphics2D
Applies this transform to the existing transform by concatenating it.
transform(GradientPaint, Shape) - Method in class org.jfree.chart.util.DirectionalGradientPaintTransformer
Transforms a GradientPaint instance to fit some target shape.
TransformerMap - Class in org.apache.commons.math3.util
This TansformerMap automates the transformation of mixed object types.
TransformerMap() - Constructor for class org.apache.commons.math3.util.TransformerMap
Build a map containing only the default transformer.
transformers() - Method in class org.apache.commons.math3.util.TransformerMap
Returns the Set of NumberTransformers used as values in the map.
transformInPlace(double[][], DftNormalization, TransformType) - Static method in class org.apache.commons.math3.transform.FastFourierTransformer
Computes the standard transform of the specified complex data.
TransformType - Enum in org.apache.commons.math3.transform
This enumeration defines the type of transform which is to be computed.
TransformUtils - Class in org.apache.commons.math3.transform
Useful functions for the implementation of various transforms.
TRANSITIVE - Static variable in class org.lsmp.djep.xjep.XOperator
Transative relations x=y and y=z implies x=z
Translate - Class in jplot
Translate numeric character references and character entity references to unicode characters.
translate(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Translate the plane by the specified amount.
translate(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Translate the region by the specified amount.
translate(int, int) - Method in class org.jfree.chart.fx.FXGraphics2D
Applies the translation (tx, ty).
translate(double, double) - Method in class org.jfree.chart.fx.FXGraphics2D
Applies the translation (tx, ty).
translateJava2DToScreen(Point2D) - Method in class org.jfree.chart.ChartPanel
Translates a Java2D point on the chart to a screen location.
translateScreenToJava2D(Point) - Method in class org.jfree.chart.ChartPanel
Translates a panel (component) location to a Java2D point.
translateToJava2D(double, double, ValueAxis, Rectangle2D) - Method in class org.jfree.chart.plot.PolarPlot
Translates a (theta, radius) pair into Java2D coordinates.
translateToPoint(Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Translate the line to force it passing by a point.
translateValueThetaRadiusToJava2D(double, double, Rectangle2D) - Method in class org.jfree.chart.plot.PolarPlot
TransMatrix - Class in j4np.physics
 
TransMatrix() - Constructor for class j4np.physics.TransMatrix
 
transpose(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Constructs and returns a new view which is the transposition of the given matrix A.
transpose() - Method in class hep.physics.matrix.BasicMatrix
 
transpose() - Method in interface hep.physics.matrix.MutableMatrix
Tranpose this matrix (into itself)
transpose() - Method in class hep.physics.matrix.SymmetricMatrix
 
transpose() - Method in class hep.physics.vec.BasicHep3Matrix
 
transpose() - Method in class hephysics.matrix.BasicMatrix
 
transpose() - Method in interface hephysics.matrix.MutableMatrix
Tranpose this matrix (into itself)
transpose() - Method in class hephysics.matrix.SymmetricMatrix
 
transpose() - Method in class hephysics.vec.Hep3Matrix
 
transpose() - Method in class Jama.Matrix
Matrix transpose.
transpose(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Takes the transpose of an array (like the matrix operation).
transpose(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Takes the transpose of an array (like the matrix operation).
transpose(double[][]) - Static method in class jhplot.math.DoubleArray
Transposes an mxn matrix into an nxm matrix.
transpose() - Method in class jhplot.math.kalman.jama.Matrix
Matrix transpose.
transpose() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the transpose of this matrix.
transpose() - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the transpose of this matrix.
transpose() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the transpose of this matrix.
Transpose - Class in org.lsmp.djep.vectorJep.function
Transpose a matrix.
Transpose() - Constructor for class org.lsmp.djep.vectorJep.function.Transpose
 
transposed(Matrix, MutableMatrix) - Static method in class hep.physics.matrix.MatrixOp
Traspose matrix mIn and write it to matrix mOut.
transposed(Matrix) - Static method in class hep.physics.matrix.MatrixOp
Returns the transpose of the matrix.
transposed(Matrix, MutableMatrix) - Static method in class hephysics.matrix.MatrixOp
Traspose matrix mIn and write it to matrix mOut.
trapezium(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using the trapezium rule.
Trapezium - Class in org.lsmp.djep.xjep.function
The trapezium rule for approximation to a definite integral.
Trapezium() - Constructor for class org.lsmp.djep.xjep.function.Trapezium
 
Trapezium(String) - Constructor for class org.lsmp.djep.xjep.function.Trapezium
 
trapezium2D(int, F2D, double, double, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using the trapezium rule.
TRAPEZOID_MAX_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.TrapezoidIntegrator
Maximum number of iterations for trapezoid.
TrapezoidalIntegrator - Class in jhplot.math.num.integration
The extended trapezoidal rule for numerically integrating functions.
TrapezoidalIntegrator(Function) - Constructor for class jhplot.math.num.integration.TrapezoidalIntegrator
Create an integrator for the given function.
TrapezoidalIntegrator(Function, int, double) - Constructor for class jhplot.math.num.integration.TrapezoidalIntegrator
Create an integrator for the given function.
TrapezoidIntegrator - Class in org.apache.commons.math3.analysis.integration
Implements the Trapezoid Rule for integration of real univariate functions.
TrapezoidIntegrator(double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.TrapezoidIntegrator
Build a trapezoid integrator with given accuracies and iterations counts.
TrapezoidIntegrator(int, int) - Constructor for class org.apache.commons.math3.analysis.integration.TrapezoidIntegrator
Build a trapezoid integrator with given iteration counts.
TrapezoidIntegrator() - Constructor for class org.apache.commons.math3.analysis.integration.TrapezoidIntegrator
Construct a trapezoid integrator with default settings.
TRAWBIT_CM - Static variable in interface hep.lcio.event.LCIO
 
TRAWBIT_ID1 - Static variable in interface hep.lcio.event.LCIO
 
TRBIT_HITS - Static variable in interface hep.lcio.event.LCIO
 
tree() - Method in class org.jlab.groot.data.Directory
list the tree structure starting with current directory.
Tree - Class in org.jlab.groot.tree
 
Tree(String) - Constructor for class org.jlab.groot.tree.Tree
 
tree() - Method in interface org.jlab.groot.tree.TreeProvider
 
tree() - Method in class org.jlab.groot.tree.TreeTextFile
 
TreeAnalyzer - Class in org.jlab.groot.tree
 
TreeAnalyzer() - Constructor for class org.jlab.groot.tree.TreeAnalyzer
 
treeConfigure() - Method in interface org.jlab.groot.tree.TreeProvider
 
treeConfigure() - Method in class org.jlab.groot.tree.TreeTextFile
 
TreeCut - Class in org.jlab.groot.tree
 
TreeCut(String, String, List<String>) - Constructor for class org.jlab.groot.tree.TreeCut
 
TreeEditor - Class in org.jlab.groot.ui
 
TreeEditor(Tree) - Constructor for class org.jlab.groot.ui.TreeEditor
 
TreeExpression - Class in org.jlab.groot.tree
 
TreeExpression(String, String, List<String>) - Constructor for class org.jlab.groot.tree.TreeExpression
 
TreeExpression(String, List<String>) - Constructor for class org.jlab.groot.tree.TreeExpression
 
treeF() - Method in class jhplot.HPlot
Return TreeFactory associated with the plot
TreeFile - Class in org.jlab.groot.tree
 
TreeFile(String) - Constructor for class org.jlab.groot.tree.TreeFile
 
TreeFile(String, String) - Constructor for class org.jlab.groot.tree.TreeFile
 
TreeProvider - Interface in org.jlab.groot.tree
 
TreeSelector - Class in org.jlab.groot.tree
 
TreeSelector() - Constructor for class org.jlab.groot.tree.TreeSelector
 
TreeTextFile - Class in org.jlab.groot.tree
 
TreeTextFile(String) - Constructor for class org.jlab.groot.tree.TreeTextFile
 
TreeTextFile(String, int) - Constructor for class org.jlab.groot.tree.TreeTextFile
 
TreeTextFile(String, String, int) - Constructor for class org.jlab.groot.tree.TreeTextFile
 
TreeUtils - Class in org.lsmp.djep.xjep
A set of Utility functions for working with JEP expression trees.
TreeUtils() - Constructor for class org.lsmp.djep.xjep.TreeUtils
Default constructor.
triangular(double, double) - Static method in class jhplot.math.Random
Generate a random number from a symetric triangular random variable.
triangular(double, double, double) - Static method in class jhplot.math.Random
Generate a random number from a non-symetric triangular random variable.
TriangularDistribution - Class in org.apache.commons.math3.distribution
Implementation of the triangular real distribution.
TriangularDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.TriangularDistribution
Creates a triangular real distribution using the given lower limit, upper limit, and mode.
TriangularDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.TriangularDistribution
Creates a triangular distribution.
TricubicInterpolatingFunction - Class in org.apache.commons.math3.analysis.interpolation
Function that implements the tricubic spline interpolation, as proposed in Tricubic interpolation in three dimensions, F.
TricubicInterpolatingFunction(double[], double[], double[], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][]) - Constructor for class org.apache.commons.math3.analysis.interpolation.TricubicInterpolatingFunction
 
TricubicInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Generates a tricubic interpolating function.
TricubicInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.TricubicInterpolator
 
TricubicSplineInterpolatingFunction - Class in org.apache.commons.math3.analysis.interpolation
Deprecated.
To be removed in 4.0 (see MATH-1166).
TricubicSplineInterpolatingFunction(double[], double[], double[], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][]) - Constructor for class org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolatingFunction
Deprecated.
 
TricubicSplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Deprecated.
To be removed in 4.0 (see MATH-1166).
TricubicSplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolator
Deprecated.
 
trigamma(double) - Static method in class org.apache.commons.math3.special.Gamma
Computes the trigamma function of x.
trigger(int) - Method in interface org.apache.commons.math3.util.Incrementor.MaxCountExceededCallback
Deprecated.
Function called when the maximal count has been reached.
trigger(int) - Method in interface org.apache.commons.math3.util.IntegerSequence.Incrementor.MaxCountExceededCallback
Function called when the maximal count has been reached.
Trigonometric - Class in jhplot.math.num.special
Utility class that provides methods related to the trigonometric functions.
trim(int, int) - Method in class cern.hep.aida.bin.DynamicBin1D
Removes the s smallest and l largest elements from the receiver.
trimmedMean(int, int) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the trimmed mean.
trimmedMean(DoubleArrayList, double, int, int) - Static method in class cern.jet.stat.Descriptive
Returns the trimmed mean of a sorted data sequence.
trimToCapacity(byte[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(char[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(double[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(float[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(int[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(long[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(Object[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(short[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(boolean[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToSize() - Method in class cern.colt.list.AbstractList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.BooleanArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.ByteArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.CharArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.DistinctNumberList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.DoubleArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.FloatArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.IntArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.LongArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.MinMaxNumberList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.ObjectArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.ShortArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.SimpleLongArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.AbstractMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.OpenDoubleIntHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.OpenIntDoubleHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.OpenIntIntHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.OpenIntObjectHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.OpenLongObjectHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.matrix.impl.AbstractMatrix
Releases any superfluous internal memory.
trimToSize() - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.hep.aida.bin.AbstractBin
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.hep.aida.bin.AbstractBin1D
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.hep.aida.bin.DynamicBin1D
Trims the capacity of the receiver to be the receiver's current size.
triplePartition(double[], double[], double[], int, int, double[], int, int, int[]) - Static method in class cern.colt.Partitioning
Same as Partitioning.triplePartition(int[],int[],int[],int,int,int[],int,int,int[]) except that it synchronously partitions double[] rather than int[] arrays.
triplePartition(double[], double[], double[], int, int, double) - Static method in class cern.colt.Partitioning
Same as Partitioning.triplePartition(int[],int[],int[],int,int,int) except that it synchronously partitions double[] rather than int[] arrays.
triplePartition(int[], int[], int[], int, int, int[], int, int, int[]) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that this method synchronously partitions three arrays at the same time; all three arrays are partially sorted according to the elements of the primary array.
triplePartition(int[], int[], int[], int, int, int) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int) except that this method synchronously partitions three arrays at the same time; all three arrays are partially sorted according to the elements of the primary array.
TrivariateFunction - Interface in org.apache.commons.math3.analysis
An interface representing a trivariate real function.
TrivariateGridInterpolator - Interface in org.apache.commons.math3.analysis.interpolation
Interface representing a trivariate real interpolating function where the sample points must be specified on a regular grid.
TRUE - Static variable in class org.apache.commons.io.filefilter.TrueFileFilter
Singleton instance of true filter.
trueFileFilter() - Static method in class org.apache.commons.io.filefilter.FileFilterUtils
Returns a filter that always returns true.
TrueFileFilter - Class in org.apache.commons.io.filefilter
A file filter that always returns true.
TRUNCATE - Static variable in class org.jfree.chart.renderer.AreaRendererEndType
The area is truncated at the first or last value.
TStyle - Class in org.jlab.groot.base
 
TStyle() - Constructor for class org.jlab.groot.base.TStyle
 
tTest(double, double[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(double, double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(double, StatisticalSummary, double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(double, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(double[], double[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(StatisticalSummary, StatisticalSummary, double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
TTest - Class in org.apache.commons.math3.stat.inference
An implementation for Student's t-tests.
TTest() - Constructor for class org.apache.commons.math3.stat.inference.TTest
 
tTest(double, double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the input array with the constant mu.
tTest(double, double[], double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which sample is drawn equals mu.
tTest(double, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the dataset described by sampleStats with the constant mu.
tTest(double, StatisticalSummary, double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which the dataset described by stats is drawn equals mu.
tTest(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays.
tTest(double[], double[], double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha.
tTest(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances.
tTest(StatisticalSummary, StatisticalSummary, double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sampleStats1 and sampleStats2 describe datasets drawn from populations with the same mean, with significance level alpha.
TWELVE - Static variable in class cern.colt.matrix.linalg.Property
A Property object with tolerance()==1.0E-12.
TWO - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "2 / 1".
TWO - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "2 / 1".
TWO - Static variable in class org.lsmp.djep.vectorJep.Dimensions
 
TWO - Static variable in class org.nfunk.jep.type.DoubleNumberFactory
 
TWO_FIFTHS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "2/5".
TWO_FIFTHS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "2/5".
TWO_PI - Static variable in class org.apache.commons.math3.util.MathUtils
\(2\pi\)
TWO_QUARTERS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "2/4".
TWO_QUARTERS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "2/4".
TWO_THIRDS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "2/3".
TWO_THIRDS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "2/3".
twoBodyDecay(HEParticle, HEParticle, boolean) - Method in class hephysics.particle.HEParticle
Evaluates 4-vector of decay product in the rest frame of parent.
twoBodyDecay(LParticle, LParticle, boolean) - Method in class hephysics.particle.LParticle
Evaluates 4-vector of decay product in the rest frame of parent.
twoBodyDecayMomentum(double, double, double) - Static method in class j4np.physics.DecayKinematics
 
twoDarray(int, int) - Method in class jhplot.math.ValueErr
Create a two dimensional array of ValueErr objects of dimensions n and m with zeros
twopi - Static variable in class cern.clhep.PhysicalConstants
 
twopi_mc2_rcl2 - Static variable in class cern.clhep.PhysicalConstants
 
twoPow(int) - Static method in class net.jafama.NumbersUtils
Returns the exact result, provided it's in double range, i.e.
twoPowAsIntBounded(int) - Static method in class net.jafama.NumbersUtils
 
twoPowAsIntExact(int) - Static method in class net.jafama.NumbersUtils
 
twoPowAsLongBounded(int) - Static method in class net.jafama.NumbersUtils
 
twoPowAsLongExact(int) - Static method in class net.jafama.NumbersUtils
 
type() - Method in class root.TLeafFolderColumn
 
types() - Method in class hep.physics.particle.properties.DefaultParticlePropertyProvider
 
types() - Method in interface hep.physics.particle.properties.ParticlePropertyProvider
Returns a List of all particle types defined by this Particle Property Provider

U

U - Variable in class Jampack.Schur
The unitary matrix.
U - Variable in class Jampack.Zhess
The unitary matrix
U - Variable in class Jampack.Zhqrd
An array containing the generating vectors for the Householder transformations.
U - Variable in class Jampack.Zludpp
The upper triangular matrix U
U - Variable in class Jampack.Zspec
The matrix of eigenvectors
U - Variable in class Jampack.Zsvd
The matrix of left singular vectors
ua(Z1, Zmat, int, int, int, int, Z1) - Static method in class Jampack.House
Premultiplies the Householder transformation contained in a Z1 into a Zmat A[r1:r2,c1:c2] and overwrites Zmat A[r1:r2,c1:c2] with the results.
ua(Z1, Zmat, int, int, int, int) - Static method in class Jampack.House
Premultiplies the Householder transformation contained in a Z1 into a Zmat A[r1:r2,c1:c2] and overwrites Zmat A[r1:r2,c1:c2] with the results.
ud() - Static method in class Jampack.Rand
Generates a random uniform double.
udary(int) - Static method in class Jampack.Rand
Generates a one-dimensional array of uniform random doubles.
udary(int, int) - Static method in class Jampack.Rand
Generates a two-dimensional array of uniform random doubles.
UI_CLASS_ID - Static variable in class net.java.dev.colorchooser.ColorChooser
UI Class ID under which the UI delegate class is stored in UIManager (see UIManager.getUI()).
ulp(float) - Static method in class net.jafama.FastMath
The ULP (Unit in the Last Place) is the distance to the next value larger in magnitude.
ulp(double) - Static method in class net.jafama.FastMath
The ULP (Unit in the Last Place) is the distance to the next value larger in magnitude.
ulp(float) - Static method in class net.jafama.StrictFastMath
The ULP (Unit in the Last Place) is the distance to the next value larger in magnitude.
ulp(double) - Static method in class net.jafama.StrictFastMath
The ULP (Unit in the Last Place) is the distance to the next value larger in magnitude.
Ulp - Class in org.apache.commons.math3.analysis.function
ulp function.
Ulp() - Constructor for class org.apache.commons.math3.analysis.function.Ulp
 
ulp(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute least significant bit (Unit in Last Position) for a number.
ulp(float) - Static method in class org.apache.commons.math3.util.FastMath
Compute least significant bit (Unit in Last Position) for a number.
umin(Object) - Method in class org.lsmp.djep.vectorJep.function.MUMinus
Negate an objects.
umin(MVector) - Method in class org.lsmp.djep.vectorJep.function.MUMinus
negate a vector.
umin(Matrix) - Method in class org.lsmp.djep.vectorJep.function.MUMinus
negate a matrix.
umin(Tensor) - Method in class org.lsmp.djep.vectorJep.function.MUMinus
negate a tensor.
umin(Object) - Method in class org.nfunk.jep.function.UMinus
 
uminus() - Method in class Jama.Matrix
Unary minus
uminus() - Method in class jhplot.math.kalman.jama.Matrix
Unary minus
uminus(Object) - Method in class org.lsmp.djep.groupJep.function.GUMinus
 
UMINUS - Static variable in class org.lsmp.djep.rpe.RpEval
 
UMinus - Class in org.nfunk.jep.function
 
UMinus() - Constructor for class org.nfunk.jep.function.UMinus
 
UNARY - Static variable in class org.lsmp.djep.xjep.XOperator
Unary operators, such as -x !x ~x
UnaryExpression() - Method in class org.nfunk.jep.Parser
 
UnaryExpressionNotPlusMinus() - Method in class org.nfunk.jep.Parser
 
UnaryOperatorI - Interface in org.lsmp.djep.vectorJep.function
A matrix enabled unary operator.
unbounded(int) - Static method in class org.apache.commons.math3.optim.SimpleBounds
Factory method that creates instance of this class that represents unbounded ranges.
UnboundedSolutionException - Exception in org.apache.commons.math3.optim.linear
This class represents exceptions thrown by optimizers when a solution escapes to infinity.
UnboundedSolutionException() - Constructor for exception org.apache.commons.math3.optim.linear.UnboundedSolutionException
Simple constructor using a default message.
UnboundedSolutionException - Exception in org.apache.commons.math3.optimization.linear
Deprecated.
As of 3.1 (to be removed in 4.0).
UnboundedSolutionException() - Constructor for exception org.apache.commons.math3.optimization.linear.UnboundedSolutionException
Deprecated.
Simple constructor using a default message.
unboundedToBounded(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
Maps an array from unbounded to bounded.
unboundedToBounded(double[]) - Method in class org.apache.commons.math3.optimization.direct.MultivariateFunctionMappingAdapter
Deprecated.
Map an array from unbounded to bounded.
UncorrelatedRandomVectorGenerator - Class in org.apache.commons.math3.random
A RandomVectorGenerator that generates vectors with uncorrelated components.
UncorrelatedRandomVectorGenerator(double[], double[], NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.UncorrelatedRandomVectorGenerator
Simple constructor.
UncorrelatedRandomVectorGenerator(int, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.UncorrelatedRandomVectorGenerator
Simple constructor.
UNDERFLOW - Static variable in interface colt.hep.aida.IHistogram
Constant specifying the underflow bin (can be passed to any method expecting a bin number).
UNDERFLOW_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.H1D
 
unequal(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is not equal to x.
unHide() - Method in class jplot.XMLRead
Unsets all the hidden contexts.
UnifiedDistanceMatrix - Class in org.apache.commons.math3.ml.neuralnet.twod.util
U-Matrix visualization of high-dimensional data projection.
UnifiedDistanceMatrix(boolean, DistanceMeasure) - Constructor for class org.apache.commons.math3.ml.neuralnet.twod.util.UnifiedDistanceMatrix
Simple constructor.
Uniform - Class in cern.jet.random
Uniform distribution; Math definition and animated definition.
Uniform(double, double, int) - Constructor for class cern.jet.random.Uniform
Constructs a uniform distribution with the given minimum and maximum, using a MersenneTwister seeded with the given seed.
Uniform(double, double, RandomEngine) - Constructor for class cern.jet.random.Uniform
Constructs a uniform distribution with the given minimum and maximum.
Uniform(RandomEngine) - Constructor for class cern.jet.random.Uniform
Constructs a uniform distribution with min=0.0 and max=1.0.
Uniform - Class in jhplot.math.num.pdf
The Uniform distribution (1).
Uniform() - Constructor for class jhplot.math.num.pdf.Uniform
Default constructor.
Uniform(double, double) - Constructor for class jhplot.math.num.pdf.Uniform
Create a distribution with the given lower bound and upper bound values.
uniform(double, double) - Static method in class jhplot.math.Random
Generate a random number from a uniform random variable.
uniform(RandomGenerator, double, double) - Static method in class org.apache.commons.math3.ml.neuralnet.FeatureInitializerFactory
Uniform sampling of the given range.
uniform(double, double) - Static method in class org.apache.commons.math3.ml.neuralnet.FeatureInitializerFactory
Uniform sampling of the given range.
UNIFORM_BOUNDS - Static variable in class jhplot.math.Slicing
 
UNIFORM_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Uniform random deviates with mean = μ.
UniformCrossover<T> - Class in org.apache.commons.math3.genetics
Perform Uniform Crossover [UX] on the specified chromosomes.
UniformCrossover(double) - Constructor for class org.apache.commons.math3.genetics.UniformCrossover
Creates a new UniformCrossover policy using the given mixing ratio.
UniformIntegerDistribution - Class in org.apache.commons.math3.distribution
Implementation of the uniform integer distribution.
UniformIntegerDistribution(int, int) - Constructor for class org.apache.commons.math3.distribution.UniformIntegerDistribution
Creates a new uniform integer distribution using the given lower and upper bounds (both inclusive).
UniformIntegerDistribution(RandomGenerator, int, int) - Constructor for class org.apache.commons.math3.distribution.UniformIntegerDistribution
Creates a new uniform integer distribution using the given lower and upper bounds (both inclusive).
UniformRandomGenerator - Class in org.apache.commons.math3.random
This class implements a normalized uniform random generator.
UniformRandomGenerator(RandomGenerator) - Constructor for class org.apache.commons.math3.random.UniformRandomGenerator
Create a new generator.
UniformRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Uniform distribution.
UniformRandomVariable() - Constructor for class jhplot.math.num.random.UniformRandomVariable
Default constructor.
UniformRandomVariable(double, double) - Constructor for class jhplot.math.num.random.UniformRandomVariable
Create a random variable with the given lower bound and upper bound values.
UniformRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.UniformRandomVariable
Create a random variable with the given parameters.
UniformRealDistribution - Class in org.apache.commons.math3.distribution
Implementation of the uniform real distribution.
UniformRealDistribution() - Constructor for class org.apache.commons.math3.distribution.UniformRealDistribution
Create a standard uniform real distribution with lower bound (inclusive) equal to zero and upper bound (exclusive) equal to one.
UniformRealDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.UniformRealDistribution
Create a uniform real distribution using the given lower and upper bounds.
UniformRealDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.UniformRealDistribution
Deprecated.
as of 3.2, inverse CDF is now calculated analytically, use UniformRealDistribution.UniformRealDistribution(double, double) instead.
UniformRealDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.UniformRealDistribution
Deprecated.
as of 3.2, inverse CDF is now calculated analytically, use UniformRealDistribution.UniformRealDistribution(RandomGenerator, double, double) instead.
UniformRealDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.UniformRealDistribution
Creates a uniform distribution.
uninstallUI(JComponent) - Method in class net.java.dev.colorchooser.ColorChooserUI
 
union(Region<S>, Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Compute the union of two regions.
unique(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Returns an array consisting of the unique values in data.
unit(Hep3Vector) - Static method in class hep.physics.vec.VecOp
returns (0,0,0) vector if input vector has length 0
unit(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
returns (0,0,0) vector if input vector has length 0
unit(Hep3Vector) - Static method in class hephysics.vec.VecOp
returns (0,0,0) vector if input vector has length 0
unit() - Method in class j4np.physics.TransMatrix
 
unit() - Method in class j4np.physics.Vector3
 
unitize() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Converts this vector into a unit vector.
unitize() - Method in class org.apache.commons.math3.linear.RealVector
Converts this vector into a unit vector.
Units - Class in cern.clhep
High Energy Physics coherent system of Units.
units - Variable in class jplot.Utils.LabeledTextField
 
UNITS_CELCIUS - Static variable in class org.jfree.chart.plot.ThermometerPlot
A constant for unit type 'Celcius'.
UNITS_FAHRENHEIT - Static variable in class org.jfree.chart.plot.ThermometerPlot
A constant for unit type 'Fahrenheit'.
UNITS_KELVIN - Static variable in class org.jfree.chart.plot.ThermometerPlot
A constant for unit type 'Kelvin'.
UNITS_NONE - Static variable in class org.jfree.chart.plot.ThermometerPlot
A constant for unit type 'None'.
UnitSphereRandomVectorGenerator - Class in org.apache.commons.math3.random
Generate random vectors isotropically located on the surface of a sphere.
UnitSphereRandomVectorGenerator(int, RandomGenerator) - Constructor for class org.apache.commons.math3.random.UnitSphereRandomVectorGenerator
 
UnitSphereRandomVectorGenerator(int) - Constructor for class org.apache.commons.math3.random.UnitSphereRandomVectorGenerator
Create an object that will use a default RNG (MersenneTwister), in order to generate the individual components.
unitVector() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Creates a unit vector pointing in the direction of this vector.
unitVector() - Method in class org.apache.commons.math3.linear.RealVector
Creates a unit vector pointing in the direction of this vector.
UnivariateDfpFunction - Interface in org.apache.commons.math3.dfp
Deprecated.
as of 3.6, replaced with RealFieldUnivariateFunction
UnivariateDifferentiableFunction - Interface in org.apache.commons.math3.analysis.differentiation
Interface for univariate functions derivatives.
UnivariateDifferentiableMatrixFunction - Interface in org.apache.commons.math3.analysis.differentiation
Extension of UnivariateMatrixFunction representing a univariate differentiable matrix function.
UnivariateDifferentiableSolver - Interface in org.apache.commons.math3.analysis.solvers
Interface for (univariate real) rootfinding algorithms.
UnivariateDifferentiableVectorFunction - Interface in org.apache.commons.math3.analysis.differentiation
Extension of UnivariateVectorFunction representing a univariate differentiable vectorial function.
UnivariateFunction - Interface in org.apache.commons.math3.analysis
An interface representing a univariate real function.
UnivariateFunctionDifferentiator - Interface in org.apache.commons.math3.analysis.differentiation
Interface defining the function differentiation operation.
UnivariateIntegrator - Interface in org.apache.commons.math3.analysis.integration
Interface for univariate real integration algorithms.
UnivariateInterpolator - Interface in org.apache.commons.math3.analysis.interpolation
Interface representing a univariate real interpolating function.
UnivariateMatrixFunction - Interface in org.apache.commons.math3.analysis
An interface representing a univariate matrix function.
UnivariateMatrixFunctionDifferentiator - Interface in org.apache.commons.math3.analysis.differentiation
Interface defining the function differentiation operation.
UnivariateMultiStartOptimizer<FUNC extends UnivariateFunction> - Class in org.apache.commons.math3.optimization.univariate
Deprecated.
As of 3.1 (to be removed in 4.0).
UnivariateMultiStartOptimizer(BaseUnivariateOptimizer<FUNC>, int, RandomGenerator) - Constructor for class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated.
Create a multi-start optimizer from a single-start optimizer.
UnivariateObjectiveFunction - Class in org.apache.commons.math3.optim.univariate
Scalar function to be optimized.
UnivariateObjectiveFunction(UnivariateFunction) - Constructor for class org.apache.commons.math3.optim.univariate.UnivariateObjectiveFunction
 
UnivariateOptimizer - Class in org.apache.commons.math3.optim.univariate
Base class for a univariate scalar function optimizer.
UnivariateOptimizer - Interface in org.apache.commons.math3.optimization.univariate
Deprecated.
As of 3.1 (to be removed in 4.0).
UnivariatePeriodicInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Adapter for classes implementing the UnivariateInterpolator interface.
UnivariatePeriodicInterpolator(UnivariateInterpolator, double, int) - Constructor for class org.apache.commons.math3.analysis.interpolation.UnivariatePeriodicInterpolator
Builds an interpolator.
UnivariatePeriodicInterpolator(UnivariateInterpolator, double) - Constructor for class org.apache.commons.math3.analysis.interpolation.UnivariatePeriodicInterpolator
Builds an interpolator.
UnivariatePointValuePair - Class in org.apache.commons.math3.optim.univariate
This class holds a point and the value of an objective function at this point.
UnivariatePointValuePair(double, double) - Constructor for class org.apache.commons.math3.optim.univariate.UnivariatePointValuePair
Build a point/objective function value pair.
UnivariatePointValuePair - Class in org.apache.commons.math3.optimization.univariate
Deprecated.
As of 3.1 (to be removed in 4.0).
UnivariatePointValuePair(double, double) - Constructor for class org.apache.commons.math3.optimization.univariate.UnivariatePointValuePair
Deprecated.
Build a point/objective function value pair.
UnivariateSolver - Interface in org.apache.commons.math3.analysis.solvers
Interface for (univariate real) root-finding algorithms.
UnivariateSolverUtils - Class in org.apache.commons.math3.analysis.solvers
Utility routines for UnivariateSolver objects.
UnivariateStatistic - Interface in org.apache.commons.math3.stat.descriptive
Base interface implemented by all statistics.
UnivariateVectorFunction - Interface in org.apache.commons.math3.analysis
An interface representing a univariate vectorial function.
UnivariateVectorFunctionDifferentiator - Interface in org.apache.commons.math3.analysis.differentiation
Interface defining the function differentiation operation.
universe_mean_density - Static variable in class cern.clhep.PhysicalConstants
 
UnixLineEndingInputStream - Class in org.apache.commons.io.input
A filtering input stream that ensures the content will have unix-style line endings, LF.
UnixLineEndingInputStream(InputStream, boolean) - Constructor for class org.apache.commons.io.input.UnixLineEndingInputStream
Create an input stream that filters another stream
UNKNOWN - Static variable in class graph.ScanString
flag an unknown token
UNKNOWN - Static variable in class graph.ScanWord
Token returned when an unknown characters match nothing
UNKNOWN - Static variable in class jplot.GraphLabel
 
UNKNOWN - Static variable in class org.lsmp.djep.vectorJep.Dimensions
 
unknown_N_compute_B_and_K(double, double, int) - Static method in class cern.jet.stat.quantile.QuantileFinderFactory
Computes the number of buffers and number of values per buffer such that quantiles can be determined with an approximation error no more than epsilon with a certain probability.
UnknownKeyException - Exception in org.jfree.data
An exception that indicates an unknown key value.
UnknownKeyException(String) - Constructor for exception org.jfree.data.UnknownKeyException
Creates a new exception.
UnknownParameterException - Exception in org.apache.commons.math3.ode
Exception to be thrown when a parameter is unknown.
UnknownParameterException(String) - Constructor for exception org.apache.commons.math3.ode.UnknownParameterException
Construct an exception from the unknown parameter.
UnknownParticleIDException - Exception in hep.physics.particle.properties
Thrown in response to a request for a particle with an unrecognized PDGID
UnknownParticleIDException(int) - Constructor for exception hep.physics.particle.properties.UnknownParticleIDException
 
UnknownPDG - Static variable in interface hep.lcio.event.ParticleID
Constant to be used if the PDG code is not known or undefined.
unlimited() - Static method in class org.apache.commons.math3.optim.MaxEval
Factory method that creates instance of this class that represents a virtually unlimited number of evaluations.
unlimited() - Static method in class org.apache.commons.math3.optim.MaxIter
Factory method that creates instance of this class that represents a virtually unlimited number of iterations.
unmodifiableRealVector(RealVector) - Static method in class org.apache.commons.math3.linear.RealVector
Returns an unmodifiable view of the specified vector.
unsetBit(int) - Method in interface hep.lcio.event.LCFlag
Sets bit to 0.
unsetHistory() - Static method in class Jampack.Parameters
Unsets the history flag.
UnsynchronizedByteArrayInputStream - Class in org.apache.commons.io.input
This is an alternative to ByteArrayInputStream which removes the synchronization overhead for non-concurrent access; as such this class is not thread-safe.
UnsynchronizedByteArrayInputStream(byte[]) - Constructor for class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
Creates a new byte array input stream.
UnsynchronizedByteArrayInputStream(byte[], int) - Constructor for class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
Creates a new byte array input stream.
UnsynchronizedByteArrayInputStream(byte[], int, int) - Constructor for class org.apache.commons.io.input.UnsynchronizedByteArrayInputStream
Creates a new byte array input stream.
UnsynchronizedByteArrayOutputStream - Class in org.apache.commons.io.output
Implements a version of AbstractByteArrayOutputStream without any concurrent thread safety.
UnsynchronizedByteArrayOutputStream() - Constructor for class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
Creates a new byte array output stream.
UnsynchronizedByteArrayOutputStream(int) - Constructor for class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
Creates a new byte array output stream, with a buffer capacity of the specified size, in bytes.
UP_45 - Static variable in class org.jfree.chart.axis.CategoryLabelPositions
UP_45 category label positions.
UP_90 - Static variable in class org.jfree.chart.axis.CategoryLabelPositions
UP_90 category label positions.
update(Graphics) - Method in class graph.G2Dint
New update method incorporating mouse dragging.
update(Graphics) - Method in class graph.Graph2D
This method is called via the Graph2D.repaint() method.
UPDATE - Static variable in interface hep.lcio.event.LCIO
 
update() - Method in class jhplot.HChart
Update all plots
update(int, int) - Method in class jhplot.HChart
Update the chart
update(int, int) - Method in class jhplot.HPlot
Refresh only a particular pad.
update() - Method in class jhplot.HPlot
Just update the current plot selected using cd() method
update(int, int) - Method in class jhplot.HPlot3D
Refresh only a particular plot
update() - Method in class jhplot.HPlot3D
Update the graphics
update() - Method in class jhplot.HPlot3DP
Just update the current plot selected using cd() method
update() - Method in class jhplot.HPlotJas
Update the current canvas.
update(Object, String) - Method in class jhplot.io.HDataBase
Update the database with a new value
update(String) - Method in class jplot.JPlot
Refreshes the actual graph with new data.
update() - Method in class jplot.panels.PanelPlot
Update the selected table with new data
update(Graphics) - Method in class jplot3d.JSurface
Updates image.
update() - Method in class jplot3dp.MainComponent
 
update(Network, double[]) - Method in class org.apache.commons.math3.ml.neuralnet.sofm.KohonenUpdateAction
Updates the network in response to the sample features.
update(Network, double[]) - Method in interface org.apache.commons.math3.ml.neuralnet.UpdateAction
Updates the network in response to the sample features.
update(int, Number) - Method in class org.jfree.data.time.TimePeriodValues
Updates (changes) the value of a data item and sends a SeriesChangeEvent to all registered listeners.
update(RegularTimePeriod, double) - Method in class org.jfree.data.time.TimeSeries
Updates (changes) the value for a time period.
update(RegularTimePeriod, Number) - Method in class org.jfree.data.time.TimeSeries
Updates (changes) the value for a time period.
update(int, Number) - Method in class org.jfree.data.time.TimeSeries
Updates (changes) the value of a data item.
update(int, int, double) - Method in class org.jfree.data.xy.MatrixSeries
Updates the value of the specified item in this matrix series.
update(int, int, double) - Method in class org.jfree.data.xy.NormalizedMatrixSeries
Updates the value of the specified item in this matrix series.
update(int, Number) - Method in class org.jfree.data.xy.XYSeries
Deprecated.
Renamed XYSeries.updateByIndex(int, Number) to avoid confusion with the XYSeries.update(Number, Number) method.
update(Number, Number) - Method in class org.jfree.data.xy.XYSeries
Updates an item in the series.
update() - Method in class org.jlab.groot.graphics.EmbeddedCanvas
forces repaint method for the entire canvas
update(Graphics2D) - Method in class org.jlab.groot.ui.GraphicsAxisFrame
 
update(double[], String[]) - Method in class org.jlab.groot.ui.GraphicsAxisLabels
 
update(double[]) - Method in class org.jlab.groot.ui.GraphicsAxisLabels
updates the array with given ticks and constructs a LatexText array with strings for axis labels;
update(List<Double>) - Method in class org.jlab.groot.ui.GraphicsAxisLabels
updates the array with given ticks and constructs a LatexText array with strings for axis labels;
update(int, int) - Method in class org.jlab.groot.ui.ProgressBar
 
update(Observable, Object) - Method in class org.lsmp.djep.djep.PartialDerivative
When the value of the root object is changed makes the value of this partial derivative invalid.
update(Observable, Object) - Method in class org.lsmp.djepExamples.ObserverConsole
 
UpdateAction - Interface in org.apache.commons.math3.ml.neuralnet
Describes how to update the network in response to a training sample.
updateAll() - Method in class jhplot.HPlot
Refresh all the plots on the same canvas HPLOT
updateAll() - Method in class jhplot.HPlot3D
Refresh all the plots on the same canvas HPLOT
updateAll() - Method in class jhplot.HPlot3DP
Refresh all the plots on the same canvas HPLOT
updateAveragedOutlier() - Method in class org.jfree.chart.renderer.OutlierList
Updates the averaged outlier.
updateByIndex(int, Number) - Method in class org.jfree.data.xy.XYSeries
Updates the value of an item in the series and sends a SeriesChangeEvent to all registered listeners.
updateCanvas() - Method in class org.jlab.groot.base.AxisAttributes.AxisAttributesPane
 
updateCanvas() - Method in class org.jlab.groot.base.AxisAttributes
 
updateCanvas() - Method in class org.jlab.groot.base.DatasetAttributes.DatasetAttributesPane
 
updateCanvas() - Method in class org.jlab.groot.graphics.EmbeddedCanvasGroup
 
updateChart(JFreeChart) - Method in interface org.jfree.chart.editor.ChartEditor
Applies the changes to the specified chart.
updateCrosshairPoint(Comparable, Comparable, double, int, double, double, PlotOrientation) - Method in class org.jfree.chart.plot.CategoryCrosshairState
Evaluates a data point from a CategoryItemRenderer and if it is the closest to the anchor point it becomes the new crosshair point.
updateCrosshairPoint(double, double, double, double, PlotOrientation) - Method in class org.jfree.chart.plot.CrosshairState
updateCrosshairPoint(double, double, int, int, double, double, PlotOrientation) - Method in class org.jfree.chart.plot.CrosshairState
Evaluates a data point and if it is the closest to the anchor point it becomes the new crosshair point.
updateCrosshairX(Comparable, Comparable, int, double, PlotOrientation) - Method in class org.jfree.chart.plot.CategoryCrosshairState
Updates only the crosshair row and column keys (this is for the case where the range crosshair does NOT lock onto the nearest data value).
updateCrosshairX(double) - Method in class org.jfree.chart.plot.CrosshairState
Deprecated.
updateCrosshairX(double, int) - Method in class org.jfree.chart.plot.CrosshairState
Evaluates an x-value and if it is the closest to the anchor x-value it becomes the new crosshair value.
updateCrosshairY(double) - Method in class org.jfree.chart.plot.CrosshairState
Deprecated.
updateCrosshairY(double, int) - Method in class org.jfree.chart.plot.CrosshairState
Evaluates a y-value and if it is the closest to the anchor y-value it becomes the new crosshair value.
updateData(int, int) - Method in class jhplot.HPlot3D
Update data on the plot
updateData() - Method in class jhplot.HPlot3D
Update data on the plot
updateDescriptor(DatasetDescriptor) - Method in class org.jlab.groot.tree.TreeAnalyzer
 
updateDimensions(Graphics2D) - Method in class org.jlab.groot.ui.PaveText
 
updateFitFunction() - Method in class org.jlab.groot.ui.ParameterPanel
 
updateFont(FontProperties) - Method in class org.jlab.groot.graphics.GraphicsAxis.GraphicsAxisTicks
 
updateFrame() - Method in class jhplot.gui.GHFrame
update frame UI
updateGraphIfShowing() - Method in class jhplot.HPlot
Update the graph if it is showing.
updateGraphIfShowing(boolean) - Method in class jplot.JPlot
Update the graph if the graph is actually showing.
updateGraphIfShowing() - Method in class jplot.JPlot
Update the graph if the graph is actually showing.
updateHighOrderDerivativesPhase1(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsFieldIntegrator
Update the high order scaled derivatives for Adams integrators (phase 1).
updateHighOrderDerivativesPhase1(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
Update the high order scaled derivatives for Adams integrators (phase 1).
updateHighOrderDerivativesPhase1(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckFieldTransformer
Update the high order scaled derivatives for Adams integrators (phase 1).
updateHighOrderDerivativesPhase1(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
Update the high order scaled derivatives for Adams integrators (phase 1).
updateHighOrderDerivativesPhase2(T[], T[], Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsFieldIntegrator
Update the high order scaled derivatives Adams integrators (phase 2).
updateHighOrderDerivativesPhase2(double[], double[], Array2DRowRealMatrix) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
Update the high order scaled derivatives Adams integrators (phase 2).
updateHighOrderDerivativesPhase2(T[], T[], Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckFieldTransformer
Update the high order scaled derivatives Adams integrators (phase 2).
updateHighOrderDerivativesPhase2(double[], double[], Array2DRowRealMatrix) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
Update the high order scaled derivatives Adams integrators (phase 2).
updateLog(List<Double>) - Method in class org.jlab.groot.ui.GraphicsAxisLabels
 
updateLookAndFeel(String) - Method in class jplot.JPlot
Sets the current L&F
updateMargins(Graphics2D) - Method in class org.jlab.groot.graphics.GraphicsAxisFrame
 
updateMean(double, double) - Method in class jplot.DataArray
Updates Mean values.
updateMean(double, double, double) - Method in class jplot.DataArray2D
Updates Mean values.
updateMean(double, double, double) - Method in class jplot.DataArray3D
Updates Mean values.
updateMinMax(double, double) - Method in class jplot.DataArray
Updates maximum and minimum values.
updateMinMax(double, double, double, double, double, double) - Method in class jplot.DataArray
Updates maximum and minimum values.
updateMinMax(double, double, double, double, double, double, double, double, double, double) - Method in class jplot.DataArray
Updates maximum and minimum values.
updateMinMax(double, double, double) - Method in class jplot.DataArray2D
Updates maximum and minimum values.
updateMinMax(double, double, double) - Method in class jplot.DataArray3D
Updates maximum and minimum values.
updateNewFunction(Func1D) - Method in class org.jlab.groot.ui.ParameterPanel
 
updatePlotProperties(Plot) - Method in class org.jfree.chart.editor.DefaultPolarPlotEditor
 
updateRecord(RecordWriter) - Method in class jhplot.io.db.BaseRecordsFile
Updates an existing record.
updateRegion() - Method in class org.jlab.groot.graphics.Histogram2DPlotter
 
updateSettings(XMLRead) - Method in class jhplot.shapes.HShape
Update the current primitive with the settings.
UpdateSettings() - Method in class jminhep.clcontrol.ClControl
Trigger some updates
updateSettings(XMLRead) - Method in class jplot.DataFile
Updates the current settings with new data.
updateSettings(XMLRead) - Method in class jplot.GraphLabel
Update the current label with the settings.
updateSettings(XMLRead) - Method in class jplot.GraphSettings
Update the current settings.
updateSettings(XMLRead) - Method in class jplot.LinePars
Updates the current settings with new data.
updateStyle(int, LinePars) - Method in class jplot.panels.PanelPlot
Update the drawing style.
updateSummary() - Method in class jhplot.P1D
Deprecated.
Debricated!
updateTreeModel(DefaultMutableTreeNode) - Method in class org.jlab.groot.ui.TBrowser
 
updateUI() - Method in class net.java.dev.colorchooser.ColorChooser
 
updateUI() - Method in class org.jfree.chart.ChartPanel
Updates the UI for a LookAndFeel change.
updateUI() - Method in class org.jlab.groot.ui.RangeSlider
Overrides the superclass method to install the UI delegate to draw two thumbs.
updateValue(Number) - Method in class org.jfree.data.general.DefaultKeyedValueDataset
Updates the value.
updateXPoints() - Method in class org.jfree.data.xy.DefaultTableXYDataset
Updates the x-values for all the series in the dataset.
UpdatingMultipleLinearRegression - Interface in org.apache.commons.math3.stat.regression
An interface for regression models allowing for dynamic updating of the data.
upper() - Method in class org.freehep.math.minuit.MinosError
 
upper(int) - Method in class org.freehep.math.minuit.MnMinos
 
upper(int, double) - Method in class org.freehep.math.minuit.MnMinos
 
upper(int, double, int) - Method in class org.freehep.math.minuit.MnMinos
 
upperBandwidth(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
The upper bandwidth of a square matrix A is the maximum j-i for which A[i,j] is nonzero and j > i.
upperCoordinates - Variable in class org.jfree.chart.renderer.xy.DeviationRenderer.State
A list of coordinates for the upper y-values in the current series (after translation into Java2D space).
upperCumulativeProbability(int) - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
For this distribution, X, this method returns P(X >= x).
upperEdge() - Method in class cern.hep.aida.ref.FixedAxis
 
upperEdge() - Method in class cern.hep.aida.ref.VariableAxis
 
upperEdge() - Method in interface colt.hep.aida.IAxis
Upper axis edge.
upperNewMin() - Method in class org.freehep.math.minuit.MinosError
 
upperState() - Method in class org.freehep.math.minuit.MinosError
 
upperValid() - Method in class org.freehep.math.minuit.MinosError
 
UPSIDE_VARIANCE - Static variable in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
The UPSIDE Direction is used to specify that the observations above the cutoff point will be used to calculate SemiVariance.
upval(int) - Method in class org.freehep.math.minuit.MnMinos
 
upval(int, double) - Method in class org.freehep.math.minuit.MnMinos
 
upval(int, double, int) - Method in class org.freehep.math.minuit.MnMinos
 
UrlLicense - Static variable in interface jminhep.gui.Constants
 
UrlReadme - Static variable in interface jminhep.gui.Constants
 
URLTagFragmentGenerator - Interface in org.jfree.chart.imagemap
Interface for generating the URL fragment of an HTML image map area tag.
URLUtilities - Class in org.jfree.chart.urls
General utility methods for URLs.
URLUtilities() - Constructor for class org.jfree.chart.urls.URLUtilities
 
US_ASCII - Static variable in class org.apache.commons.io.Charsets
Deprecated.
Use Java 7's StandardCharsets
usage() - Static method in class hep.lcio.util.LCIOConcat
 
USE_BINDING_FOR_PRINT - Static variable in class org.lsmp.djep.xjep.XOperator
For non commutative operators printing can be determined by the left or right binding.
useAnalyticalDerivaties() - Method in class org.freehep.math.minuit.MnApplication
 
useAxesRatio() - Method in class jplot.GraphSettings
Says whether we should use a fixed ratio between X- and Y-axes lengths.
useBindingForPrint() - Method in class org.lsmp.djep.xjep.XOperator
 
useDataPosition() - Method in class jplot.GraphLabel
 
useLegendPosition() - Method in class jplot.GraphSettings
Returns whether or not we use the legend coordinates.
useLogScale(int) - Method in class jplot.GraphSettings
Returns whether or not to plot using a logarithmic scale.
useNumberOfTics(int) - Method in class jhplot.HPlot
Returns whether or not to use a fixed number of ticks.
useNumberOfTics(int) - Method in class jplot.GraphSettings
Returns whether or not to use a fixed number of tics.
usePosition() - Method in class jplot.GraphLabel
 
userCovariance() - Method in class org.freehep.math.minuit.FunctionMinimum
 
UserParameter - Class in org.jlab.groot.math
 
UserParameter() - Constructor for class org.jlab.groot.math.UserParameter
 
UserParameter(String, double) - Constructor for class org.jlab.groot.math.UserParameter
 
UserParameter(String, double, double, double) - Constructor for class org.jlab.groot.math.UserParameter
 
userParameters() - Method in class org.freehep.math.minuit.FunctionMinimum
 
UserParameters - Class in org.jlab.groot.math
 
UserParameters() - Constructor for class org.jlab.groot.math.UserParameters
 
userState() - Method in class org.freehep.math.minuit.FunctionMinimum
user representation of state at minimum
UTF_16 - Static variable in class org.apache.commons.io.Charsets
Deprecated.
Use Java 7's StandardCharsets
UTF_16BE - Static variable in class org.apache.commons.io.ByteOrderMark
UTF-16BE BOM (Big-Endian)
UTF_16BE - Static variable in class org.apache.commons.io.Charsets
Deprecated.
Use Java 7's StandardCharsets
UTF_16LE - Static variable in class org.apache.commons.io.ByteOrderMark
UTF-16LE BOM (Little-Endian)
UTF_16LE - Static variable in class org.apache.commons.io.Charsets
Deprecated.
Use Java 7's StandardCharsets
UTF_32BE - Static variable in class org.apache.commons.io.ByteOrderMark
UTF-32BE BOM (Big-Endian)
UTF_32LE - Static variable in class org.apache.commons.io.ByteOrderMark
UTF-32LE BOM (Little-Endian)
UTF_8 - Static variable in class org.apache.commons.io.ByteOrderMark
UTF-8 BOM
UTF_8 - Static variable in class org.apache.commons.io.Charsets
Deprecated.
Use Java 7's StandardCharsets
UTF_BOM - Static variable in class org.apache.commons.io.ByteOrderMark
Unicode BOM character; external form depends on the encoding.
Util - Class in jhepsim
Various useful functions of general purpose.
Util - Class in jhplot.utils
Various useful functions of general purpose.
Util - Class in jminhep.utils
Various useful functions of general purpose.
Util() - Constructor for class jminhep.utils.Util
 
Utils - Class in jplot
General utilities.
Utils() - Constructor for class jplot.Utils
 
Utils - Class in jplot3d
 
Utils.CheckBoxWithText - Class in jplot
------------------------------------------------------------------- A checkbox with a line of text added to it as a label --------------------------------------------------------------------
Utils.LabeledComboBox - Class in jplot
 
Utils.LabeledTextField - Class in jplot
 
UVModeller - Class in jplot3dp
 
UVModeller() - Constructor for class jplot3dp.UVModeller
 
uz() - Static method in class Jampack.Rand
Generates a uniform random complex number, i.e., a complex number whose real and imaginary parts are random.
uz1(int) - Static method in class Jampack.Rand
Generates a uniform random Z1.
uzmat(int, int) - Static method in class Jampack.Rand
Generates a uniform random Zmat.

V

v() - Method in class hep.physics.vec.BasicHep3Vector
 
v() - Method in interface hep.physics.vec.Hep3Vector
 
v() - Method in class hep.physics.vec.SpacePoint
Returns the space point as a double array in its internal representation
v() - Method in class hephysics.vec.Hep3Vector
 
v() - Method in class hephysics.vec.SpacePoint
Returns the space point as a double array in its internal representation
V - Variable in class Jampack.Zsvd
The matrix of right singular vectore
v - Variable in class jhplot.math.pca.covmatrixevd.EVD
 
v - Variable in class jhplot.math.pca.covmatrixevd.EVDResult
 
v3() - Method in class hep.physics.vec.BasicHepLorentzVector
 
v3() - Method in interface hep.physics.vec.HepLorentzVector
 
v3() - Method in class hephysics.vec.HepLorentzVector
Get 3-vector
Validate - Class in hep.lcio.util
Several static utility methods for simple validation of LCIO/SIO files.
Validate() - Constructor for class hep.lcio.util.Validate
 
validate(boolean) - Method in class jhplot.math.exp4j.Expression
 
validate() - Method in class jhplot.math.exp4j.Expression
 
validate(RealVector) - Method in interface org.apache.commons.math3.fitting.leastsquares.ParameterValidator
Validates the set of parameters.
validateAngleOffset() - Method in class org.jfree.chart.editor.DefaultPolarPlotEditor
Validates the angle offset entered by the user.
ValidateCommandHandler - Class in hep.lcio.util
Command-line handler for the validate utility.
ValidateCommandHandler() - Constructor for class hep.lcio.util.ValidateCommandHandler
 
validateExpression(String, List<String>) - Static method in class org.jlab.groot.tree.TreeCut
 
validateExpression(String, List<String>) - Static method in class org.jlab.groot.tree.TreeExpression
 
validateObject() - Method in class org.jfree.data.general.AbstractDataset
Validates the object.
validateTickUnit() - Method in class org.jfree.chart.editor.DefaultLogAxisEditor
Validates the tick unit entered.
validateTickUnit() - Method in class org.jfree.chart.editor.DefaultPolarPlotEditor
Validates the tick unit entered by the user.
validateVersion(File, int, int) - Static method in class hep.lcio.util.Validate
Confirm major and minor versions of an LCIO file.
ValidatingObjectInputStream - Class in org.apache.commons.io.serialization
An ObjectInputStream that's restricted to deserialize a limited set of classes.
ValidatingObjectInputStream(InputStream) - Constructor for class org.apache.commons.io.serialization.ValidatingObjectInputStream
Constructs an object to deserialize the specified input stream.
ValidationResult - Class in jhplot.math.exp4j
Contains the validation result for a given Expression
ValidationResult(boolean, List<String>) - Constructor for class jhplot.math.exp4j.ValidationResult
Create a new instance
value() - Method in class cern.hep.aida.bin.AbstractBin
Returns value(0).
value(int) - Method in class cern.hep.aida.bin.AbstractBin
Returns a custom definable "value" measure; override this method if necessary.
value(double[]) - Method in class jhplot.fit.BreitWigner
 
value(double[]) - Method in class jhplot.fit.Exponent
 
value(double[]) - Method in class jhplot.fit.Gauss
 
value(double[]) - Method in class jhplot.fit.Landau
 
value(double[]) - Method in class jhplot.fit.NegativeBinomial
Get value of this function
value(double[]) - Method in class jhplot.fit.P0
 
value(double[]) - Method in class jhplot.fit.P1
 
value(double[]) - Method in class jhplot.fit.P2
 
value(double[]) - Method in class jhplot.fit.P3
 
value(double[]) - Method in class jhplot.fit.P4
 
value(double[]) - Method in class jhplot.fit.P5
 
value(double[]) - Method in class jhplot.fit.P6
 
value(double[]) - Method in class jhplot.fit.Poisson
 
value(double[]) - Method in class jhplot.fit.Pow
 
value(double[]) - Method in class jhplot.fit.PowModified
 
value(double[]) - Method in class jhplot.FNon
Calculated value.
value - Variable in class net.jafama.DoubleWrapper
 
value - Variable in class net.jafama.IntWrapper
 
value(double, double) - Method in interface org.apache.commons.math3.analysis.BivariateFunction
Compute the value for the function.
value(double[]) - Method in class org.apache.commons.math3.analysis.differentiation.GradientFunction
Compute the value for the function at the given point.
value(double[]) - Method in class org.apache.commons.math3.analysis.differentiation.JacobianFunction
Compute the value for the function at the given point.
value(DerivativeStructure[]) - Method in interface org.apache.commons.math3.analysis.differentiation.MultivariateDifferentiableFunction
Compute the value for the function at the given point.
value(DerivativeStructure[]) - Method in interface org.apache.commons.math3.analysis.differentiation.MultivariateDifferentiableVectorFunction
Compute the value for the function at the given point.
value(DerivativeStructure) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateDifferentiableFunction
Simple mathematical function.
value(DerivativeStructure) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateDifferentiableMatrixFunction
Compute the value for the function.
value(DerivativeStructure) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateDifferentiableVectorFunction
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Abs
Compute the value of the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Acos
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Acos
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Acosh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Acosh
Simple mathematical function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Add
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Asin
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Asin
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Asinh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Asinh
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Atan
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Atan
Simple mathematical function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Atan2
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Atanh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Atanh
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Cbrt
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Cbrt
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Ceil
Compute the value of the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Constant
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Constant
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Cos
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Cos
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Cosh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Cosh
Simple mathematical function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Divide
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Exp
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Exp
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Expm1
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Expm1
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Floor
Compute the value of the function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Gaussian.Parametric
Computes the value of the Gaussian at x.
value(double) - Method in class org.apache.commons.math3.analysis.function.Gaussian
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Gaussian
Simple mathematical function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator.Parametric
Computes the value of the harmonic oscillator at x.
value(double) - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Identity
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Identity
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Inverse
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Inverse
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Log
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Log
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Log10
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Log10
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Log1p
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Log1p
Simple mathematical function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logistic.Parametric
Computes the value of the sigmoid at x.
value(double) - Method in class org.apache.commons.math3.analysis.function.Logistic
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Logistic
Simple mathematical function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logit.Parametric
Computes the value of the logit at x.
value(double) - Method in class org.apache.commons.math3.analysis.function.Logit
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Logit
Simple mathematical function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Max
Compute the value for the function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Min
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Minus
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Minus
Simple mathematical function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Multiply
Compute the value for the function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Pow
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Power
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Power
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Rint
Compute the value of the function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Sigmoid.Parametric
Computes the value of the sigmoid at x.
value(double) - Method in class org.apache.commons.math3.analysis.function.Sigmoid
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Sigmoid
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Signum
Compute the value of the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Sin
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Sin
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Sinc
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Sinc
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Sinh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Sinh
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Sqrt
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Sqrt
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.StepFunction
Compute the value of the function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Subtract
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Tan
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Tan
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Tanh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Tanh
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Ulp
Compute the value of the function.
value(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicInterpolatingFunction
Compute the value for the function.
value(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
Deprecated.
Compute the value for the function.
value(T) - Method in class org.apache.commons.math3.analysis.interpolation.FieldHermiteInterpolator
Interpolate value at a specified abscissa.
value(double) - Method in class org.apache.commons.math3.analysis.interpolation.HermiteInterpolator
Interpolate value at a specified abscissa.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.interpolation.HermiteInterpolator
Interpolate value at a specified abscissa.
value(double[], double[][], double[], double, double) - Method in class org.apache.commons.math3.analysis.interpolation.InterpolatingMicrosphere
Estimate the value at the requested location.
value(double[]) - Method in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolatingFunction
Deprecated.
 
value(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.PiecewiseBicubicSplineInterpolatingFunction
Compute the value for the function.
value(double, double, double) - Method in class org.apache.commons.math3.analysis.interpolation.TricubicInterpolatingFunction
Compute the value for the function.
value(double, double, double) - Method in class org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolatingFunction
Deprecated.
Compute the value for the function.
value(double[]) - Method in interface org.apache.commons.math3.analysis.MultivariateFunction
Compute the value for the function at the given point.
value(double[]) - Method in interface org.apache.commons.math3.analysis.MultivariateMatrixFunction
Compute the value for the function at the given point.
value(double[]) - Method in interface org.apache.commons.math3.analysis.MultivariateVectorFunction
Compute the value for the function at the given point.
value(double, double...) - Method in interface org.apache.commons.math3.analysis.ParametricUnivariateFunction
Compute the value of the function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction.Parametric
Compute the value of the function.
value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Compute the value of the function for the given argument.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Calculate the function value at the given point.
value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Calculate the function value at the given point.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Compute the value for the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Simple mathematical function.
value(T) - Method in interface org.apache.commons.math3.analysis.RealFieldUnivariateFunction
Compute the value of the function.
value(double, double, double) - Method in interface org.apache.commons.math3.analysis.TrivariateFunction
Compute the value for the function.
value(double) - Method in interface org.apache.commons.math3.analysis.UnivariateFunction
Compute the value of the function.
value(double) - Method in interface org.apache.commons.math3.analysis.UnivariateMatrixFunction
Compute the value for the function.
value(double) - Method in interface org.apache.commons.math3.analysis.UnivariateVectorFunction
Compute the value for the function.
value(Dfp) - Method in interface org.apache.commons.math3.dfp.UnivariateDfpFunction
Deprecated.
Compute the value of the function.
value(RealVector) - Method in interface org.apache.commons.math3.fitting.leastsquares.MultivariateJacobianFunction
Compute the function value and its Jacobian.
value() - Method in interface org.apache.commons.math3.ml.neuralnet.FeatureInitializer
Selects the initial value.
value(long) - Method in interface org.apache.commons.math3.ml.neuralnet.sofm.LearningFactorFunction
Computes the learning rate at the current call.
value(long) - Method in interface org.apache.commons.math3.ml.neuralnet.sofm.NeighbourhoodSizeFunction
Computes the neighbourhood size at the current call.
value(long) - Method in class org.apache.commons.math3.ml.neuralnet.sofm.util.ExponentialDecayFunction
Computes a e-numCall / b.
value(long) - Method in class org.apache.commons.math3.ml.neuralnet.sofm.util.QuasiSigmoidDecayFunction
Computes the value of the learning factor.
value(double[]) - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
Computes the value of the linear equation at the current point.
value(RealVector) - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
Computes the value of the linear equation at the current point.
value(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.LeastSquaresConverter
Compute the value for the function at the given point.
value(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
Compute the underlying function value from an unbounded point.
value(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionPenaltyAdapter
Computes the underlying function value from an unbounded point.
value(double[]) - Method in class org.apache.commons.math3.optimization.direct.MultivariateFunctionMappingAdapter
Deprecated.
Compute the underlying function value from an unbounded point.
value(double[]) - Method in class org.apache.commons.math3.optimization.direct.MultivariateFunctionPenaltyAdapter
Deprecated.
Compute the underlying function value from an unbounded point.
value(double[]) - Method in class org.apache.commons.math3.optimization.LeastSquaresConverter
Deprecated.
Compute the value for the function at the given point.
value(double) - Method in class org.apache.commons.math3.special.BesselJ
Returns the value of the constructed Bessel function of the first kind, for the passed argument.
value(double, double) - Static method in class org.apache.commons.math3.special.BesselJ
Returns the first Bessel function, \(J_{order}(x)\).
value() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap.Iterator
Get the value of current entry.
value() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap.Iterator
Get the value of current entry.
value(int) - Method in class org.freehep.math.minuit.MnApplication
 
value(String) - Method in class org.freehep.math.minuit.MnApplication
 
value(int) - Method in class org.freehep.math.minuit.MnUserParameters
 
value(String) - Method in class org.freehep.math.minuit.MnUserParameters
 
value(int) - Method in class org.freehep.math.minuit.MnUserParameterState
 
value(String) - Method in class org.freehep.math.minuit.MnUserParameterState
 
Value - Interface in org.jfree.data
A general purpose interface for accessing a value.
value() - Method in class org.jlab.groot.math.UserParameter
 
VALUE_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
VALUE_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
VALUE_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
VALUE_FIELD_NUMBER - Static variable in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
VALUE_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P0D
 
VALUE_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P0I
 
VALUE_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PND
 
VALUE_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PNI
 
VALUE_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
VALUE_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
VALUE_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
VALUE_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
VALUE_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
VALUE_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
VALUE_INDEX - Static variable in class org.jfree.chart.renderer.WaferMapRenderer
The default value index.
VALUE_LABELS - Static variable in class org.jfree.chart.plot.CompassPlot
A constant for the label type.
VALUE_TAG - Static variable in interface org.jfree.data.xml.DatasetTags
The 'Value' element name.
ValueAndJacobianFunction - Interface in org.apache.commons.math3.fitting.leastsquares
A interface for functions that compute a vector of values and can compute their derivatives (Jacobian).
valueArea(double, String, String) - Method in class jhplot.HChart
Set a value to a area chart.
ValueAxis - Class in org.jfree.chart.axis
The base class for axes that display value data, where values are measured using the double primitive.
ValueAxisPlot - Interface in org.jfree.chart.plot
An interface that is implemented by plots that use a ValueAxis, providing a standard method to find the current data range.
valueBar(double, String, String) - Method in class jhplot.HChart
Set a value to a Bar chart.
valueBar3D(double, String, String) - Method in class jhplot.HChart
Set a value to a 3D Bar chart.
valueBound(HttpSessionBindingEvent) - Method in class org.jfree.chart.servlet.ChartDeleter
Binding this object to the session has no additional effects.
ValueDataset - Interface in org.jfree.data.general
An interface for a dataset that returns a single value.
ValueErr - Class in jhplot.math
A value represented with the number (value) and associated error.
ValueErr() - Constructor for class jhplot.math.ValueErr
Initialize error propagations
ValueErr(double) - Constructor for class jhplot.math.ValueErr
Initialize with value and set error=0
ValueErr(double, double) - Constructor for class jhplot.math.ValueErr
Initialize error propagation
valueForPathChanged(TreePath, Object) - Method in class root.RootHistogramTreeModel
 
ValueHandler - Class in org.jfree.data.xml
A handler for reading a 'Value' element.
ValueHandler(RootHandler, ItemHandler) - Constructor for class org.jfree.data.xml.ValueHandler
Creates a new value handler.
valueLine(double, String, String) - Method in class jhplot.HChart
Set a value to a Line chart.
ValueMarker - Class in org.jfree.chart.plot
A marker that represents a single value.
ValueMarker(double) - Constructor for class org.jfree.chart.plot.ValueMarker
Creates a new marker.
ValueMarker(double, Paint, Stroke) - Constructor for class org.jfree.chart.plot.ValueMarker
Creates a new marker.
ValueMarker(double, Paint, Stroke, Paint, Stroke, float) - Constructor for class org.jfree.chart.plot.ValueMarker
Creates a new value marker.
valueOf(String) - Static method in enum hep.physics.vec.SpacePoint.Representation
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum hephysics.vec.SpacePoint.Representation
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum j4np.physics.DecayKinematics.Frame
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum jhplot.io.images.ImageType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum jhplot.math.pca.PCA.TransformationType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum jplot3d.SurfaceModel.PlotColor
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum jplot3d.SurfaceModel.PlotType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.io.file.StandardDeleteOption
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.io.FileSystem
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.io.IOCase
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.analysis.solvers.AllowedSolution
Returns the enum constant of this type with the specified name.
valueOf(double, double) - Static method in class org.apache.commons.math3.complex.Complex
Create a complex number given the real and imaginary parts.
valueOf(double) - Static method in class org.apache.commons.math3.complex.Complex
Create a complex number given only the real part.
valueOf(String) - Static method in enum org.apache.commons.math3.dfp.DfpField.RoundingMode
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.exception.util.LocalizedFormats
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.fitting.leastsquares.GaussNewtonOptimizer.Decomposition
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.geometry.euclidean.threed.RotationConvention
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor.Order
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.geometry.partitioning.Region.Location
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.geometry.partitioning.Side
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ml.neuralnet.SquareNeighbourhood
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D.HorizontalDirection
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D.VerticalDirection
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ode.events.Action
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ode.events.EventHandler.Action
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ode.events.FilterType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerBounds
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerMode
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optim.linear.PivotSelectionRule
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optim.linear.Relationship
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optim.nonlinear.scalar.GoalType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.Formula
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optimization.general.ConjugateGradientFormula
Deprecated.
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optimization.GoalType
Deprecated.
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optimization.linear.Relationship
Deprecated.
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
Deprecated.
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.stat.descriptive.moment.SemiVariance.Direction
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.stat.descriptive.rank.Percentile.EstimationType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.stat.inference.AlternativeHypothesis
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.stat.ranking.NaNStrategy
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.stat.ranking.TiesStrategy
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.transform.DctNormalization
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.transform.DftNormalization
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.transform.DstNormalization
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.transform.TransformType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.util.MathArrays.OrderDirection
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.util.MathArrays.Position
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.util.ResizableDoubleArray.ExpansionMode
Returns the enum constant of this type with the specified name.
valueOf(double[]) - Method in interface org.freehep.math.minuit.FCNBase
Returns the value of the function with the given parameters.
valueOf(String) - Static method in enum org.jfree.chart.plot.CenterTextMode
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.jfree.chart.renderer.xy.XYSplineRenderer.FillType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.jlab.groot.base.AttributeType
Returns the enum constant of this type with the specified name.
valueOf(double[]) - Method in class org.jlab.groot.fitter.FitterFunction
 
valueOf(String) - Method in interface org.lsmp.djep.groupJep.GroupI
returns number given by the string
valueOf(Number[]) - Method in class org.lsmp.djep.groupJep.groups.AlgebraicExtension
 
valueOf(String) - Method in class org.lsmp.djep.groupJep.groups.BigReals
 
valueOf(String) - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
valueOf(Number[]) - Method in class org.lsmp.djep.groupJep.groups.FreeGroup
 
valueOf(String) - Method in class org.lsmp.djep.groupJep.groups.Integers
 
valueOf(String) - Method in class org.lsmp.djep.groupJep.groups.PermutationGroup
 
valueOf(Number[]) - Method in class org.lsmp.djep.groupJep.groups.PermutationGroup
 
valueOf(String) - Method in class org.lsmp.djep.groupJep.groups.Quaternions
 
valueOf(String) - Method in class org.lsmp.djep.groupJep.groups.Rationals
 
valueOf(String) - Method in class org.lsmp.djep.groupJep.groups.Reals
 
valueOf(String) - Method in class org.lsmp.djep.groupJep.groups.Zn
 
valueOf(Integer[]) - Method in class org.lsmp.djep.groupJep.values.Permutation
 
valueOf(Number[]) - Method in class org.lsmp.djep.groupJep.values.Permutation
 
valueOf(String) - Static method in class org.lsmp.djep.groupJep.values.Rational
 
valueOf(int) - Static method in class org.lsmp.djep.vectorJep.Dimensions
Factory method returns a Dimension for vector of given length.
valueOf(int, int) - Static method in class org.lsmp.djep.vectorJep.Dimensions
returns dimensions for a matrix.
valueOf(int, Dimensions) - Static method in class org.lsmp.djep.vectorJep.Dimensions
return a dimension [d,inDim[0],...,inDim[n]]
valueOf(Dimensions, int) - Static method in class org.lsmp.djep.vectorJep.Dimensions
return a dimension [inDim[0],...,inDim[n],d]
valueOf(int[]) - Static method in class org.lsmp.djep.vectorJep.Dimensions
returns a dimensions with given dimensions.
valuePie(String, double) - Method in class jhplot.HChart
Set a value to pie data set
valuePie3D(String, double) - Method in class jhplot.HChart
Set a value to 3D pie data set.
values() - Method in class cern.colt.map.AbstractDoubleIntMap
Returns a list filled with all values contained in the receiver.
values(IntArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.AbstractIntDoubleMap
Returns a list filled with all values contained in the receiver.
values(DoubleArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.AbstractIntIntMap
Returns a list filled with all values contained in the receiver.
values(IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.AbstractIntObjectMap
Returns a list filled with all values contained in the receiver.
values(ObjectArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.AbstractLongObjectMap
Returns a list filled with all values contained in the receiver.
values(ObjectArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all values contained in the receiver into the specified list.
values(IntArrayList) - Method in class cern.colt.map.OpenDoubleIntHashMap
Fills all values contained in the receiver into the specified list.
values(DoubleArrayList) - Method in class cern.colt.map.OpenIntDoubleHashMap
Fills all values contained in the receiver into the specified list.
values(IntArrayList) - Method in class cern.colt.map.OpenIntIntHashMap
Fills all values contained in the receiver into the specified list.
values(ObjectArrayList) - Method in class cern.colt.map.OpenIntObjectHashMap
Fills all values contained in the receiver into the specified list.
values(ObjectArrayList) - Method in class cern.colt.map.OpenLongObjectHashMap
Fills all values contained in the receiver into the specified list.
values() - Static method in enum hep.physics.vec.SpacePoint.Representation
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum hephysics.vec.SpacePoint.Representation
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum j4np.physics.DecayKinematics.Frame
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum jhplot.io.images.ImageType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum jhplot.math.pca.PCA.TransformationType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum jplot3d.SurfaceModel.PlotColor
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum jplot3d.SurfaceModel.PlotType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.io.file.StandardDeleteOption
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.io.FileSystem
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.io.IOCase
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.analysis.solvers.AllowedSolution
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.dfp.DfpField.RoundingMode
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.exception.util.LocalizedFormats
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.fitting.leastsquares.GaussNewtonOptimizer.Decomposition
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.geometry.euclidean.threed.RotationConvention
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor.Order
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.geometry.partitioning.Region.Location
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.geometry.partitioning.Side
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ml.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ml.neuralnet.SquareNeighbourhood
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D.HorizontalDirection
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D.VerticalDirection
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ode.events.Action
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ode.events.EventHandler.Action
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ode.events.FilterType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerBounds
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerMode
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optim.linear.PivotSelectionRule
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optim.linear.Relationship
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optim.nonlinear.scalar.GoalType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.Formula
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optimization.general.ConjugateGradientFormula
Deprecated.
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optimization.GoalType
Deprecated.
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optimization.linear.Relationship
Deprecated.
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
Deprecated.
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.stat.descriptive.moment.SemiVariance.Direction
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.stat.descriptive.rank.Percentile.EstimationType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.stat.inference.AlternativeHypothesis
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.stat.ranking.NaNStrategy
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.stat.ranking.TiesStrategy
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.transform.DctNormalization
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.transform.DftNormalization
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.transform.DstNormalization
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.transform.TransformType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.util.MathArrays.OrderDirection
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.util.MathArrays.Position
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.util.ResizableDoubleArray.ExpansionMode
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.jfree.chart.plot.CenterTextMode
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.jfree.chart.renderer.xy.XYSplineRenderer.FillType
Returns an array containing the constants of this enum type, in the order they are declared.
Values - Interface in org.jfree.data
An interface through which (single-dimension) data values can be accessed.
values() - Static method in enum org.jlab.groot.base.AttributeType
Returns an array containing the constants of this enum type, in the order they are declared.
Values2D - Interface in org.jfree.data
A general purpose interface that can be used to access a table of values.
ValueServer - Class in org.apache.commons.math3.random
Generates values for use in simulation applications.
ValueServer() - Constructor for class org.apache.commons.math3.random.ValueServer
Creates new ValueServer
ValueServer(RandomDataImpl) - Constructor for class org.apache.commons.math3.random.ValueServer
ValueServer(RandomGenerator) - Constructor for class org.apache.commons.math3.random.ValueServer
Construct a ValueServer instance using a RandomGenerator as its source of random data.
valuesIterator() - Method in class org.apache.commons.math3.stat.Frequency
Returns an Iterator over the set of values that have been added.
valueTest(String, Object) - Method in class org.lsmp.djepJUnit.JepTest
Test result j.evaluate(j.parse(expr))
valueTest(String, String) - Method in class org.lsmp.djepJUnit.JepTest
 
valueTest(String, double) - Method in class org.lsmp.djepJUnit.JepTest
Test parse and evaluate with with a Double result.
valueTest(String, double, double) - Method in class org.lsmp.djepJUnit.JepTest
 
valueTest(String, double) - Method in class org.lsmp.djepJUnit.MatrixJepTest
 
valueTest(String, double) - Method in class org.lsmp.djepJUnit.MRpTest
 
valueTest(String, Object) - Method in class org.lsmp.djepJUnit.MRpTest
 
valueTest(String, String) - Method in class org.lsmp.djepJUnit.MRpTest
 
valueTest(String, double) - Method in class org.lsmp.djepJUnit.RpTest
 
valueTest(String, Object) - Method in class org.lsmp.djepJUnit.RpTest
 
valueTest(String, String) - Method in class org.lsmp.djepJUnit.RpTest
 
valueTest(String, double) - Method in class org.lsmp.djepJUnit.SJepTest
 
valueTest(String, Object) - Method in class org.lsmp.djepJUnit.SJepTest
 
valueTestInt(String, int) - Method in class org.lsmp.djepJUnit.JepTest
Test parse and evaluate which should give the result Integer(a).
valueTestNaN(String) - Method in class org.lsmp.djepJUnit.JepTest
 
ValueTick - Class in org.jfree.chart.axis
A value tick.
ValueTick(double, String, TextAnchor, TextAnchor, double) - Constructor for class org.jfree.chart.axis.ValueTick
Creates a new value tick.
ValueTick(TickType, double, String, TextAnchor, TextAnchor, double) - Constructor for class org.jfree.chart.axis.ValueTick
Creates a new value tick.
valueToAngle(double) - Method in interface org.jfree.chart.plot.dial.DialScale
Converts a data value to an angle (in degrees, using the same specification as Java's Arc2D class).
valueToAngle(double) - Method in class org.jfree.chart.plot.dial.StandardDialScale
Converts a data value to an angle against this scale.
valueToAngle(double) - Method in class org.jfree.chart.plot.MeterPlot
Translates a data value to an angle on the dial.
valueToJava2D(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.CyclicNumberAxis
Translates a value from data space to Java 2D space.
valueToJava2D(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.DateAxis
Translates the data value to the display coordinates (Java 2D User Space) of the chart.
valueToJava2D(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.LogarithmicAxis
Converts a data value to a coordinate in Java2D space, assuming that the axis runs along one edge of the specified plotArea.
valueToJava2D(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.LogAxis
Converts a value on the axis scale to a Java2D coordinate relative to the given area, based on the axis running along the specified edge.
valueToJava2D(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.ModuloAxis
Translates a data value to a Java2D coordinate.
valueToJava2D(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.NumberAxis
Converts a data value to a coordinate in Java2D space, assuming that the axis runs along one edge of the specified dataArea.
valueToJava2D(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.PeriodAxis
Converts a data value to a coordinate in Java2D space, assuming that the axis runs along one edge of the specified dataArea.
valueToJava2D(double, Rectangle2D, RectangleEdge) - Method in class org.jfree.chart.axis.ValueAxis
Converts a data value to a coordinate in Java2D space, assuming that the axis runs along one edge of the specified dataArea.
valueToString(double) - Method in class org.jfree.chart.axis.DateTickUnit
Formats a value.
valueToString(double) - Method in class org.jfree.chart.axis.NumberTickUnit
Converts a value to a string.
valueToString(double) - Method in class org.jfree.chart.axis.SymbolAxis
Converts a value to a string, using the list of symbols.
valueToString(double) - Method in class org.jfree.chart.axis.TickUnit
Converts the supplied value to a string.
valueToStringTest(String, String) - Method in class org.lsmp.djepJUnit.GroupJepTest
 
valueUnbound(HttpSessionBindingEvent) - Method in class org.jfree.chart.servlet.ChartDeleter
When this object is unbound from the session (including upon session expiry) the files that have been added to the ArrayList are iterated and deleted.
var(double[]) - Static method in class jhplot.stat.StatUtils
Compute variance of all elements in vector v.
VAR - Static variable in class org.lsmp.djep.rpe.RpEval
 
VAR - Static variable in class org.nfunk.jep.evaluation.CommandElement
 
variable(String) - Method in class jhplot.math.exp4j.ExpressionBuilder
 
Variable() - Method in class org.nfunk.jep.Parser
 
Variable - Class in org.nfunk.jep
Information about a variable.
VariableAxis - Class in cern.hep.aida.ref
Variable-width axis; A reference implementation of hep.aida.IAxis.
VariableAxis(double[]) - Constructor for class cern.hep.aida.ref.VariableAxis
Constructs and returns an axis with the given bin edges.
VariableFactory - Class in org.nfunk.jep
A factory class which is used to create variables.
VariableFactory() - Constructor for class org.nfunk.jep.VariableFactory
 
variableParameters() - Method in class org.freehep.math.minuit.MnApplication
 
variableParameters() - Method in class org.freehep.math.minuit.MnUserParameters
 
variableParameters() - Method in class org.freehep.math.minuit.MnUserParameterState
 
variables(Set<String>) - Method in class jhplot.math.exp4j.ExpressionBuilder
 
variables(String...) - Method in class jhplot.math.exp4j.ExpressionBuilder
 
VariableSizeGridLayout - Class in jhplot.gui
 
VariableSizeGridLayout() - Constructor for class jhplot.gui.VariableSizeGridLayout
 
VariableSizeGridLayout(int, int) - Constructor for class jhplot.gui.VariableSizeGridLayout
 
VariableSizeGridLayout(int, int, int, int) - Constructor for class jhplot.gui.VariableSizeGridLayout
 
VariableToken - Class in jhplot.math.exp4j.tokenizer
represents a setVariable used in an expression
VariableToken(String) - Constructor for class jhplot.math.exp4j.tokenizer.VariableToken
Create a new instance
variance() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the sample variance, which is Sum( (x[i]-mean())2 ) / (size()-1).
variance(double) - Static method in class cern.jet.stat.Descriptive
Returns the variance from a standard deviation.
variance(int, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the variance of a data sequence.
variance(double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the (bias-corrected sample) variance.
variance(int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the (bias-corrected sample) variance.
variance(double[]) - Static method in class jhplot.math.StatisticSample
Variance
variance(double[][]) - Static method in class jhplot.math.StatisticSample
Variance
variance() - Method in class jhplot.P0D
Returns the variance.
variance() - Method in class jhplot.P0I
Returns the variance.
variance(double[]) - Static method in class jhplot.stat.Statistics
Variance
variance(double[][]) - Static method in class jhplot.stat.Statistics
Variance
Variance - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the variance of the available values.
Variance() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
Constructs a Variance with default (true) isBiasCorrected property.
Variance(SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
Constructs a Variance based on an external second moment.
Variance(boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
Constructs a Variance with the specified isBiasCorrected property
Variance(boolean, SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
Constructs a Variance with the specified isBiasCorrected property and the supplied external second moment.
Variance(Variance) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
Copy constructor, creates a new Variance identical to the original
variance(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the variance of the entries in the input array, or Double.NaN if the array is empty.
variance(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
variance(double[], double, int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.
variance(double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the variance of the entries in the input array, using the precomputed mean value.
varianceDifference(double[], double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the variance of the (signed) differences between corresponding elements of the input arrays -- i.e., var(sample1[i] - sample2[i]).
varianceX() - Method in class jhplot.P1D
Returns variance for X-values.
varianceY() - Method in class jhplot.P1D
Returns variance for Y-values.
VARNAME - Static variable in interface jplot3dp.MathParser.MathParserConstants
 
VARS_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.FND
 
VEC - Class in jminhep.utils
 
VEC() - Constructor for class jminhep.utils.VEC
 
vecEquationChanged(String[]) - Method in class org.lsmp.djepExamples.MRpSurfExample
 
VecOp - Class in hep.physics.vec
Utility methods for dealing with 3 and 4 vectors.
VecOp - Class in hephysics.vec
Utility methods for dealing with 3 and 4 vectors.
vect() - Method in class j4np.physics.LorentzVector
 
Vector<S extends Space> - Interface in org.apache.commons.math3.geometry
This interface represents a generic vector in a vectorial space or a point in an affine space.
VECTOR - Static variable in class org.apache.commons.math3.linear.ConjugateGradient
Key for the exception context.
Vector - Class in org.jfree.data.xy
A vector.
Vector(double, double) - Constructor for class org.jfree.data.xy.Vector
Creates a new instance of Vector.
Vector1D - Class in org.apache.commons.math3.geometry.euclidean.oned
This class represents a 1D vector.
Vector1D(double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Simple constructor.
Vector1D(double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Multiplicative constructor Build a vector from another one and a scale factor.
Vector1D(double, Vector1D, double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Linear constructor Build a vector from two other ones and corresponding scale factors.
Vector1D(double, Vector1D, double, Vector1D, double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Linear constructor Build a vector from three other ones and corresponding scale factors.
Vector1D(double, Vector1D, double, Vector1D, double, Vector1D, double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Linear constructor Build a vector from four other ones and corresponding scale factors.
Vector1DFormat - Class in org.apache.commons.math3.geometry.euclidean.oned
Formats a 1D vector in components list format "{x}".
Vector1DFormat() - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Create an instance with default settings.
Vector1DFormat(NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Create an instance with a custom number format for components.
Vector1DFormat(String, String) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Create an instance with custom prefix, suffix and separator.
Vector1DFormat(String, String, NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Create an instance with custom prefix, suffix, separator and format for components.
Vector2D - Class in org.apache.commons.math3.geometry.euclidean.twod
This class represents a 2D vector.
Vector2D(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Simple constructor.
Vector2D(double[]) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Simple constructor.
Vector2D(double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Multiplicative constructor Build a vector from another one and a scale factor.
Vector2D(double, Vector2D, double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Linear constructor Build a vector from two other ones and corresponding scale factors.
Vector2D(double, Vector2D, double, Vector2D, double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Linear constructor Build a vector from three other ones and corresponding scale factors.
Vector2D(double, Vector2D, double, Vector2D, double, Vector2D, double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Linear constructor Build a vector from four other ones and corresponding scale factors.
Vector2DFormat - Class in org.apache.commons.math3.geometry.euclidean.twod
Formats a 2D vector in components list format "{x; y}".
Vector2DFormat() - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Create an instance with default settings.
Vector2DFormat(NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Create an instance with a custom number format for components.
Vector2DFormat(String, String, String) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Create an instance with custom prefix, suffix and separator.
Vector2DFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Create an instance with custom prefix, suffix, separator and format for components.
Vector3 - Class in j4np.physics
 
Vector3(Vector3) - Constructor for class j4np.physics.Vector3
 
Vector3() - Constructor for class j4np.physics.Vector3
 
Vector3(double, double, double) - Constructor for class j4np.physics.Vector3
 
Vector3D - Class in org.apache.commons.math3.geometry.euclidean.threed
This class implements vectors in a three-dimensional space.
Vector3D(double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Simple constructor.
Vector3D(double[]) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Simple constructor.
Vector3D(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Simple constructor.
Vector3D(double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Multiplicative constructor Build a vector from another one and a scale factor.
Vector3D(double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Linear constructor Build a vector from two other ones and corresponding scale factors.
Vector3D(double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Linear constructor Build a vector from three other ones and corresponding scale factors.
Vector3D(double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Linear constructor Build a vector from four other ones and corresponding scale factors.
Vector3DFormat - Class in org.apache.commons.math3.geometry.euclidean.threed
Formats a 3D vector in components list format "{x; y; z}".
Vector3DFormat() - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Create an instance with default settings.
Vector3DFormat(NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Create an instance with a custom number format for components.
Vector3DFormat(String, String, String) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Create an instance with custom prefix, suffix and separator.
Vector3DFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Create an instance with custom prefix, suffix, separator and format for components.
VectorConsole - Class in org.lsmp.djepExamples
 
VectorConsole() - Constructor for class org.lsmp.djepExamples.VectorConsole
 
VectorDataItem - Class in org.jfree.data.xy
A data item representing data in the form (x, y, deltaX, deltaY), intended for use by the VectorSeries class.
VectorDataItem(double, double, double, double) - Constructor for class org.jfree.data.xy.VectorDataItem
Creates a new instance of VectorDataItem.
VectorEvaluator - Class in org.lsmp.djep.vectorJep
 
VectorEvaluator() - Constructor for class org.lsmp.djep.vectorJep.VectorEvaluator
 
VectorExample - Class in org.lsmp.djepExamples
Examples using vectors and matricies
VectorExample() - Constructor for class org.lsmp.djepExamples.VectorExample
 
VectorFormat<S extends Space> - Class in org.apache.commons.math3.geometry
Formats a vector in components list format "{x; y; ...}".
VectorialCovariance - Class in org.apache.commons.math3.stat.descriptive.moment
Returns the covariance matrix of the available vectors.
VectorialCovariance(int, boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
Constructs a VectorialCovariance.
VectorialMean - Class in org.apache.commons.math3.stat.descriptive.moment
Returns the arithmetic mean of the available vectors.
VectorialMean(int) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
Constructs a VectorialMean.
VectorJep - Class in org.lsmp.djep.vectorJep
An extension of JEP with support for basic vectors and matrices.
VectorJep() - Constructor for class org.lsmp.djep.vectorJep.VectorJep
 
VectorJep(JEP) - Constructor for class org.lsmp.djep.vectorJep.VectorJep
 
VectorJepTest - Class in org.lsmp.djepJUnit
 
VectorJepTest(String) - Constructor for class org.lsmp.djepJUnit.VectorJepTest
 
VectorPrint - Class in org.lsmp.djepExamples
Examples using vectors and matrices
VectorPrint() - Constructor for class org.lsmp.djepExamples.VectorPrint
 
VectorRenderer - Class in org.jfree.chart.renderer.xy
A renderer that represents data from an VectorXYDataset by drawing a line with an arrow at each (x, y) point.
VectorRenderer() - Constructor for class org.jfree.chart.renderer.xy.VectorRenderer
Creates a new XYBlockRenderer instance with default attributes.
VectorSeries - Class in org.jfree.data.xy
A list of (x,y, deltaX, deltaY) data items.
VectorSeries(Comparable) - Constructor for class org.jfree.data.xy.VectorSeries
Creates a new empty series.
VectorSeries(Comparable, boolean, boolean) - Constructor for class org.jfree.data.xy.VectorSeries
Constructs a new series that contains no data.
VectorSeriesCollection - Class in org.jfree.data.xy
A collection of VectorSeries objects.
VectorSeriesCollection() - Constructor for class org.jfree.data.xy.VectorSeriesCollection
Creates a new instance of VectorSeriesCollection.
VectorSet - Class in graph
This class is designed to hold vectors to be plotted.
VectorSet() - Constructor for class graph.VectorSet
Instantiate an empty data set.
VectorSet(double[], int) - Constructor for class graph.VectorSet
Instantiate a DataSet with the parsed data.
VectorSet(double) - Constructor for class graph.VectorSet
Instantiate an empty data set.
VectorSet(double[], int, double) - Constructor for class graph.VectorSet
Instantiate a DataSet with the parsed data.
vectorSize(int) - Method in class org.jlab.groot.matrix.SparseGridBuilder
 
vectorToFrame(Vector3, Vector3) - Static method in class j4np.physics.DecayKinematics
 
VectorXYDataset - Interface in org.jfree.data.xy
An extension of the XYDataset interface that allows a vector to be defined at a specific (x, y) location.
VEle - Class in org.lsmp.djep.vectorJep.function
ele(x,i) returns the i-th element of a vector x.
VEle() - Constructor for class org.lsmp.djep.vectorJep.function.VEle
 
verifyBracketing(UnivariateFunction, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Check that the endpoints specify an interval and the end points bracket a root.
verifyInterpolationArray(double[], double[], boolean) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Check that the interpolation arrays are valid.
verifyInterval(double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Check that the endpoints specify an interval.
verifySequence(double, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Check that lower < initial < upper.
verifyValues(double[], int, int) - Static method in class org.apache.commons.math3.util.MathArrays
This method is used to verify that the input parameters designate a subarray of positive length.
verifyValues(double[], int, int, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
This method is used to verify that the input parameters designate a subarray of positive length.
verifyValues(double[], double[], int, int) - Static method in class org.apache.commons.math3.util.MathArrays
This method is used to verify that the begin and length parameters designate a subarray of positive length and the weights are all non-negative, non-NaN, finite, and not all zero.
verifyValues(double[], double[], int, int, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
This method is used to verify that the begin and length parameters designate a subarray of positive length and the weights are all non-negative, non-NaN, finite, and not all zero.
Version - Class in cern.colt
Information about the current release.
VERSION_FIELD_NUMBER - Static variable in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
VERSION_FIELD_NUMBER - Static variable in class promc.io.ProMCDescriptionFile.ProMCDescription
 
VERSION_FIELD_NUMBER - Static variable in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
VERSION_FIELD_NUMBER - Static variable in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
VERTEX - Static variable in interface hep.lcio.event.LCIO
 
Vertex - Interface in hep.lcio.event
The Vertex class for LCIO.
vertex - Variable in class jplot3d.JSurface
 
Vertex - Class in org.apache.commons.math3.geometry.spherical.twod
Spherical polygons boundary vertex.
vertexIsNotEndpointOfParent() - Method in interface hep.lcio.event.MCParticle
True if the particle was created as a result of a continuous process where the parent particle continues, i.e.
vertexIsNotEndpointOfParent() - Method in class hep.lcio.implementation.event.IMCParticle
 
VERTICAL - Static variable in class org.jfree.chart.plot.PlotOrientation
For a plot where the range axis is vertical.
VERY_DARK_BLUE - Static variable in class org.jfree.chart.ChartColor
A very dark blue color.
VERY_DARK_CYAN - Static variable in class org.jfree.chart.ChartColor
A very dark cyan color.
VERY_DARK_GREEN - Static variable in class org.jfree.chart.ChartColor
A very dark green color.
VERY_DARK_MAGENTA - Static variable in class org.jfree.chart.ChartColor
A very dark magenta/purple color.
VERY_DARK_RED - Static variable in class org.jfree.chart.ChartColor
A very dark red color.
VERY_DARK_YELLOW - Static variable in class org.jfree.chart.ChartColor
A very dark yellow color.
VERY_LIGHT_BLUE - Static variable in class org.jfree.chart.ChartColor
A very light blue color.
VERY_LIGHT_CYAN - Static variable in class org.jfree.chart.ChartColor
Aa very light cyan color.
VERY_LIGHT_GREEN - Static variable in class org.jfree.chart.ChartColor
A very light green color.
VERY_LIGHT_MAGENTA - Static variable in class org.jfree.chart.ChartColor
A very light magenta color.
VERY_LIGHT_RED - Static variable in class org.jfree.chart.ChartColor
A very light red color.
VERY_LIGHT_YELLOW - Static variable in class org.jfree.chart.ChartColor
A very light yellow color.
vetoableChange(PropertyChangeEvent) - Method in class org.jfree.data.time.TimeSeriesCollection
Receives notification that the key for one of the series in the collection has changed, and vetos it if the key is already present in the collection.
vetoableChange(PropertyChangeEvent) - Method in class org.jfree.data.xy.XYSeriesCollection
Receives notification that the key for one of the series in the collection has changed, and vetos it if the key is already present in the collection.
VHolder - Class in jhplot
A class to transform any HPlot container (H1D,H2D,P1D..) to a vector for further manipulations
VHolder() - Constructor for class jhplot.VHolder
Dummy initialisator
VHolder(H1D) - Constructor for class jhplot.VHolder
Create a VHolder object with H1D histogram
VHolder(F1D) - Constructor for class jhplot.VHolder
Create a VHolder object with F1D function
VHolder(DataHolder) - Constructor for class jhplot.VHolder
Get Vectors from multidimensional data container
VHolder(PND) - Constructor for class jhplot.VHolder
Show PND
VHolder(PNI) - Constructor for class jhplot.VHolder
Show PNI
VHolder(P1D) - Constructor for class jhplot.VHolder
Create a VHolder object from P1D container.
VHolder(P2D) - Constructor for class jhplot.VHolder
Create a VHolder object from P2D container.
VHolder(P0D) - Constructor for class jhplot.VHolder
Create a VHolder object from P0D container.
VHolder(P0I) - Constructor for class jhplot.VHolder
Create a VHolder object from P0I container.
VHolder(P3D) - Constructor for class jhplot.VHolder
Create a VHolder object from P3D container.
viewColumn(int) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new slice view representing the rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new slice view representing the rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and rows of the given column.
viewColumnFlip() - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new flip view along the column axis.
viewData() - Method in class jplot.panels.PanelPlot
Reloads the datafile and resets the selection to default.
viewDice() - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new dice (transposition) view; Swaps axes; example: 3 x 4 matrix --> 4 x 3 matrix.
viewDice(int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new dice view; Swaps dimensions (axes); Example: 3 x 4 x 5 matrix --> 4 x 3 x 5 matrix.
viewDice() - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new dice (transposition) view; Swaps axes; example: 3 x 4 matrix --> 4 x 3 matrix.
viewDice(int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new dice view; Swaps dimensions (axes); Example: 3 x 4 x 5 matrix --> 4 x 3 x 5 matrix.
viewFlip() - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a new flip view.
viewHisto(boolean) - Method in class jhplot.HPlot
If true, then this suppresses all negative values in Y, i.e.
viewPart(int, int) - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new sub-range view that is a height x width sub matrix starting at [row,column].
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new sub-range view that is a depth x height x width sub matrix starting at [slice,row,column]; Equivalent to view().part(slice,row,column,depth,height,width); Provided for convenience only.
viewPart(int, int) - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new sub-range view that is a height x width sub matrix starting at [row,column].
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new sub-range view that is a depth x height x width sub matrix starting at [slice,row,column]; Equivalent to view().part(slice,row,column,depth,height,width); Provided for convenience only.
viewRow(int) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new slice view representing the columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new slice view representing the columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and columns of the given row.
viewRowFlip() - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new flip view along the row axis.
viewSample(DoubleMatrix1D, double, RandomEngine) - Static method in class cern.colt.matrix.doublealgo.Statistic
Constructs and returns a sampling view with a size of round(matrix.size() * fraction).
viewSample(DoubleMatrix2D, double, double, RandomEngine) - Static method in class cern.colt.matrix.doublealgo.Statistic
Constructs and returns a sampling view with round(matrix.rows() * rowFraction) rows and round(matrix.columns() * columnFraction) columns.
viewSample(DoubleMatrix3D, double, double, double, RandomEngine) - Static method in class cern.colt.matrix.doublealgo.Statistic
Constructs and returns a sampling view with round(matrix.slices() * sliceFraction) slices and round(matrix.rows() * rowFraction) rows and round(matrix.columns() * columnFraction) columns.
viewSelection(int[]) - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(DoubleProcedure) - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a new selection view that is a matrix holding the cells matching the given condition.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(DoubleMatrix1DProcedure) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new selection view that is a matrix holding all rows matching the given condition.
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(DoubleMatrix2DProcedure) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new selection view that is a matrix holding all slices matching the given condition.
viewSelection(int[]) - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(ObjectProcedure) - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a new selection view that is a matrix holding the cells matching the given condition.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(ObjectMatrix1DProcedure) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new selection view that is a matrix holding all rows matching the given condition.
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(ObjectMatrix2DProcedure) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new selection view that is a matrix holding all slices matching the given condition.
viewSlice(int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new 2-dimensional slice view representing the rows and columns of the given slice.
viewSlice(int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new 2-dimensional slice view representing the rows and columns of the given slice.
viewSliceFlip() - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new flip view along the slice axis.
viewSliceFlip() - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new flip view along the slice axis.
viewSorted() - Method in class cern.colt.matrix.DoubleMatrix1D
Sorts the vector into ascending order, according to the natural ordering.
viewSorted(int) - Method in class cern.colt.matrix.DoubleMatrix2D
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
viewSorted(int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
viewSorted() - Method in class cern.colt.matrix.ObjectMatrix1D
Sorts the vector into ascending order, according to the natural ordering.
viewSorted(int) - Method in class cern.colt.matrix.ObjectMatrix2D
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
viewSorted(int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
viewStrides(int) - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int) - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
visible(boolean) - Method in class jhplot.HChart
Set the canvas frame visible or not
visible() - Method in class jhplot.HChart
Set the canvas frame visible
visible(int, int) - Method in class jhplot.HChart
Set the canvas frame visible.
visible(boolean) - Method in class jhplot.HPlot
Set the canvas frame visible or not
visible() - Method in class jhplot.HPlot
Set the canvas frame visible
visible(int, int) - Method in class jhplot.HPlot
Set the canvas frame visible.
visible(boolean) - Method in class jhplot.HPlot3D
Set the canvas frame visible or not
visible(int, int) - Method in class jhplot.HPlot3D
Set the canvas frame visible.
visible() - Method in class jhplot.HPlot3D
Show the canvas
visible(boolean) - Method in class jhplot.HPlot3DP
Set the canvas frame visible or not
visible(int, int) - Method in class jhplot.HPlot3DP
Set the canvas frame visible.
visible() - Method in class jhplot.HPlot3DP
Set the canvas frame visible
visible(boolean) - Method in class jhplot.HPlotJas
Set the canvas frame visible or not
visible() - Method in class jhplot.HPlotJas
Set the canvas frame visible
visible - Variable in class jplot3dp.ModelView.ModelFunction
 
VISIBLE - Static variable in class org.apache.commons.io.filefilter.HiddenFileFilter
Singleton instance of visible filter
visible - Variable in class org.jfree.chart.title.Title
A flag that controls whether or not the title is visible.
visibleRange(ContourDataset, Range, Range) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Returns the visible z-range.
visibleRange(ContourDataset, Range, Range) - Static method in class org.jfree.chart.plot.ContourPlotUtilities
Deprecated.
Returns the visible z-range.
visit(BSPTreeVisitor<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Visit the BSP tree nodes.
visit(int, int, T) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, T) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor
Visit one matrix entry.
visit(int, int, double) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, double) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor
Visit one matrix entry.
visit(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrixPreservingVisitor
Visit one matrix entry.
visit(int, T) - Method in interface org.apache.commons.math3.linear.FieldVectorChangingVisitor
Visit one entry of the vector.
visit(int, T) - Method in interface org.apache.commons.math3.linear.FieldVectorPreservingVisitor
Visit one entry of the vector.
visit(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrixPreservingVisitor
Visit one matrix entry.
visit(int, double) - Method in interface org.apache.commons.math3.linear.RealVectorChangingVisitor
Visit one entry of the vector.
visit(int, double) - Method in interface org.apache.commons.math3.linear.RealVectorPreservingVisitor
Visit one entry of the vector.
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.djep.DifferentiationVisitor
Applies differentiation to a function.
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.djep.DifferentiationVisitor
Differentiates a variable.
visit(ASTConstant, Object) - Method in class org.lsmp.djep.djep.DifferentiationVisitor
Differentiates a constant.
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.djep.DPrintVisitor
Prints the variable or its equation.
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.groupJep.PolynomialVisitor
 
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.groupJep.PolynomialVisitor
 
visit(ASTConstant, Object) - Method in class org.lsmp.djep.groupJep.PolynomialVisitor
 
visit(SimpleNode, Object) - Method in class org.lsmp.djep.matrixJep.MatrixEvaluator
 
visit(ASTStart, Object) - Method in class org.lsmp.djep.matrixJep.MatrixEvaluator
 
visit(ASTConstant, Object) - Method in class org.lsmp.djep.matrixJep.MatrixEvaluator
constants
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.matrixJep.MatrixEvaluator
multi dimensional differentiable variables
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.matrixJep.MatrixEvaluator
other functions
visit(SimpleNode, Object) - Method in class org.lsmp.djep.matrixJep.MatrixPreprocessor
 
visit(ASTStart, Object) - Method in class org.lsmp.djep.matrixJep.MatrixPreprocessor
 
visit(ASTConstant, Object) - Method in class org.lsmp.djep.matrixJep.MatrixPreprocessor
constants
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.matrixJep.MatrixPreprocessor
multi-dimensional differentiable variables
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.matrixJep.MatrixPreprocessor
visit functions and operators
visit(ASTStart, Object) - Method in class org.lsmp.djep.mrpe.MRpEval
 
visit(SimpleNode, Object) - Method in class org.lsmp.djep.mrpe.MRpEval
 
visit(ASTConstant, Object) - Method in class org.lsmp.djep.mrpe.MRpEval
 
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.mrpe.MRpEval
 
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.mrpe.MRpEval
 
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.rewrite.RewriteVisitor
 
visit(ASTStart, Object) - Method in class org.lsmp.djep.rpe.RpEval
 
visit(SimpleNode, Object) - Method in class org.lsmp.djep.rpe.RpEval
 
visit(ASTConstant, Object) - Method in class org.lsmp.djep.rpe.RpEval
 
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.rpe.RpEval
 
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.rpe.RpEval
 
visit(ASTConstant, Object) - Method in class org.lsmp.djep.sjep.PolynomialCreator
 
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.sjep.PolynomialCreator
 
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.sjep.PolynomialCreator
 
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.vectorJep.VectorEvaluator
Visit a function node.
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.xjep.CommandVisitor
 
visit(ASTConstant, Object) - Method in class org.lsmp.djep.xjep.DeepCopyVisitor
 
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.xjep.DeepCopyVisitor
 
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.xjep.DeepCopyVisitor
 
visit(SimpleNode, Object) - Method in class org.lsmp.djep.xjep.DoNothingVisitor
 
visit(ASTStart, Object) - Method in class org.lsmp.djep.xjep.DoNothingVisitor
 
visit(ASTConstant, Object) - Method in class org.lsmp.djep.xjep.DoNothingVisitor
 
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.xjep.DoNothingVisitor
 
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.xjep.DoNothingVisitor
 
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.xjep.PrintVisitor
 
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.xjep.PrintVisitor
 
visit(ASTConstant, Object) - Method in class org.lsmp.djep.xjep.PrintVisitor
 
visit(ASTFunNode, Object) - Method in class org.lsmp.djep.xjep.SimplificationVisitor
 
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.xjep.SubstitutionVisitor
 
visit(ASTVarNode, Object) - Method in class org.lsmp.djep.xjep.XEvaluatorVisitor
Visit a variable node.
visit(ASTFunNode, Object) - Method in class org.nfunk.jep.evaluation.ExpressionCompiler
 
visit(ASTVarNode, Object) - Method in class org.nfunk.jep.evaluation.ExpressionCompiler
 
visit(ASTConstant, Object) - Method in class org.nfunk.jep.evaluation.ExpressionCompiler
 
visit(SimpleNode, Object) - Method in class org.nfunk.jep.evaluation.ExpressionCompiler
 
visit(ASTStart, Object) - Method in class org.nfunk.jep.evaluation.ExpressionCompiler
 
visit(SimpleNode, Object) - Method in class org.nfunk.jep.EvaluatorVisitor
This method should never be called when evaluation a normal expression.
visit(ASTStart, Object) - Method in class org.nfunk.jep.EvaluatorVisitor
This method should never be called when evaluating a normal expression.
visit(ASTFunNode, Object) - Method in class org.nfunk.jep.EvaluatorVisitor
Visit a function node.
visit(ASTVarNode, Object) - Method in class org.nfunk.jep.EvaluatorVisitor
Visit a variable node.
visit(ASTConstant, Object) - Method in class org.nfunk.jep.EvaluatorVisitor
Visit a constant node.
visit(SimpleNode, Object) - Method in class org.nfunk.jep.ParserDumpVisitor
 
visit(ASTStart, Object) - Method in class org.nfunk.jep.ParserDumpVisitor
 
visit(ASTFunNode, Object) - Method in class org.nfunk.jep.ParserDumpVisitor
 
visit(ASTVarNode, Object) - Method in class org.nfunk.jep.ParserDumpVisitor
 
visit(ASTConstant, Object) - Method in class org.nfunk.jep.ParserDumpVisitor
 
visit(SimpleNode, Object) - Method in interface org.nfunk.jep.ParserVisitor
 
visit(ASTStart, Object) - Method in interface org.nfunk.jep.ParserVisitor
 
visit(ASTFunNode, Object) - Method in interface org.nfunk.jep.ParserVisitor
 
visit(ASTVarNode, Object) - Method in interface org.nfunk.jep.ParserVisitor
 
visit(ASTConstant, Object) - Method in interface org.nfunk.jep.ParserVisitor
 
visitChildrenAsArray(Node, Object) - Method in class org.lsmp.djep.matrixJep.MatrixPreprocessor
Returns an array of matrix nodes which are the results of visiting each child.
visitFile(Path, BasicFileAttributes) - Method in class org.apache.commons.io.file.AccumulatorPathVisitor
 
visitFile(Path, BasicFileAttributes) - Method in class org.apache.commons.io.file.CleaningPathVisitor
 
visitFile(Path, BasicFileAttributes) - Method in class org.apache.commons.io.file.CopyDirectoryVisitor
 
visitFile(Path, BasicFileAttributes) - Method in class org.apache.commons.io.file.CountingPathVisitor
 
visitFile(Path, BasicFileAttributes) - Method in class org.apache.commons.io.file.DeletingPathVisitor
 
visitFileTree(T, Path) - Static method in class org.apache.commons.io.file.PathUtils
Performs Files.walkFileTree(Path,FileVisitor) and returns the given visitor.
visitFileTree(T, Path, Set<FileVisitOption>, int) - Static method in class org.apache.commons.io.file.PathUtils
Performs Files.walkFileTree(Path,FileVisitor) and returns the given visitor.
visitFileTree(T, String, String...) - Static method in class org.apache.commons.io.file.PathUtils
Performs Files.walkFileTree(Path,FileVisitor) and returns the given visitor.
visitFileTree(T, URI) - Static method in class org.apache.commons.io.file.PathUtils
Performs Files.walkFileTree(Path,FileVisitor) and returns the given visitor.
visitInternalNode(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor
Visit a BSP tree node node having a non-null sub-hyperplane.
visitLeafNode(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor
Visit a leaf BSP tree node node having a null sub-hyperplane.
visitOp(ASTFunNode, Object) - Method in class org.lsmp.djep.matrixJep.MatrixPreprocessor
operators +,-,*,/
visitOrder(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor
Determine the visit order for this node.
VLIST - Static variable in class org.lsmp.djep.rpe.RpEval
 
VList - Class in org.lsmp.djep.vectorJep.function
A enhanced version of List, allows matrices and tensors.
VList() - Constructor for class org.lsmp.djep.vectorJep.function.VList
 
VMap - Class in org.lsmp.djep.vectorJep.function
evaluates a function on every element of a vector or matrix.
VMap() - Constructor for class org.lsmp.djep.vectorJep.function.VMap
 
volt - Static variable in class cern.clhep.Units
 
VonMises - Class in cern.jet.random
Von Mises distribution.
VonMises(double, RandomEngine) - Constructor for class cern.jet.random.VonMises
Constructs a Von Mises distribution.
VOperatorSet - Class in org.lsmp.djep.vectorJep
 
VOperatorSet() - Constructor for class org.lsmp.djep.vectorJep.VOperatorSet
 
VPower - Class in org.lsmp.djep.vectorJep.function
An overloaded power function, if both arguments are vectors returns the exteriour product, else return standard power.
VPower() - Constructor for class org.lsmp.djep.vectorJep.function.VPower
 
VRange - Class in org.lsmp.djep.vectorJep.function
A enhanced version of List, allows matrices and tensors.
VRange() - Constructor for class org.lsmp.djep.vectorJep.function.VRange
 
VSum - Class in org.lsmp.djep.vectorJep.function
Adds the elements of a vector or matrix.
VSum() - Constructor for class org.lsmp.djep.vectorJep.function.VSum
 

W

WaferMapDataset - Class in org.jfree.data.general
A dataset that can be used with the WaferMapPlot class.
WaferMapDataset(int, int) - Constructor for class org.jfree.data.general.WaferMapDataset
Creates a new dataset using the default chipspace.
WaferMapDataset(int, int, Number) - Constructor for class org.jfree.data.general.WaferMapDataset
Creates a new dataset.
WaferMapPlot - Class in org.jfree.chart.plot
A wafer map plot.
WaferMapPlot() - Constructor for class org.jfree.chart.plot.WaferMapPlot
Creates a new plot with no dataset.
WaferMapPlot(WaferMapDataset) - Constructor for class org.jfree.chart.plot.WaferMapPlot
Creates a new plot.
WaferMapPlot(WaferMapDataset, WaferMapRenderer) - Constructor for class org.jfree.chart.plot.WaferMapPlot
Creates a new plot.
WaferMapRenderer - Class in org.jfree.chart.renderer
A renderer for wafer map plots.
WaferMapRenderer() - Constructor for class org.jfree.chart.renderer.WaferMapRenderer
Creates a new renderer.
WaferMapRenderer(int, int) - Constructor for class org.jfree.chart.renderer.WaferMapRenderer
Creates a new renderer.
WaferMapRenderer(Integer, Integer) - Constructor for class org.jfree.chart.renderer.WaferMapRenderer
Creates a new renderer.
waitFor(File, int) - Static method in class org.apache.commons.io.FileUtils
Waits for NFS to propagate a file creation, imposing a timeout.
walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) some matrix entries in column order.
walkInDefaultOrder(FieldVectorPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Visits (but does not alter) all entries of this vector in default order (increasing index).
walkInDefaultOrder(FieldVectorPreservingVisitor<T>, int, int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Visits (but does not alter) some entries of this vector in default order (increasing index).
walkInDefaultOrder(FieldVectorChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Visits (and possibly alters) all entries of this vector in default order (increasing index).
walkInDefaultOrder(FieldVectorChangingVisitor<T>, int, int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Visits (and possibly alters) some entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorPreservingVisitor) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (but does not alter) all entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorPreservingVisitor, int, int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (but does not alter) some entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorChangingVisitor) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (and possibly alters) all entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorChangingVisitor, int, int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (and possibly alters) some entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorPreservingVisitor) - Method in class org.apache.commons.math3.linear.RealVector
Visits (but does not alter) all entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorPreservingVisitor, int, int) - Method in class org.apache.commons.math3.linear.RealVector
Visits (but does not alter) some entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorChangingVisitor) - Method in class org.apache.commons.math3.linear.RealVector
Visits (and possibly alters) all entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorChangingVisitor, int, int) - Method in class org.apache.commons.math3.linear.RealVector
Visits (and possibly alters) some entries of this vector in default order (increasing index).
walkInDefaultOrder(FieldVectorPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Visits (but does not alter) all entries of this vector in default order (increasing index).
walkInDefaultOrder(FieldVectorPreservingVisitor<T>, int, int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Visits (but does not alter) some entries of this vector in default order (increasing index).
walkInDefaultOrder(FieldVectorChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Visits (and possibly alters) all entries of this vector in default order (increasing index).
walkInDefaultOrder(FieldVectorChangingVisitor<T>, int, int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Visits (and possibly alters) some entries of this vector in default order (increasing index).
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldVectorPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Visits (but does not alter) all entries of this vector in optimized order.
walkInOptimizedOrder(FieldVectorPreservingVisitor<T>, int, int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Visits (but does not alter) some entries of this vector in optimized order.
walkInOptimizedOrder(FieldVectorChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Visits (and possibly alters) all entries of this vector in optimized order.
walkInOptimizedOrder(FieldVectorChangingVisitor<T>, int, int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Visits (and possibly change) some entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorPreservingVisitor) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (but does not alter) all entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorPreservingVisitor, int, int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (but does not alter) some entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorChangingVisitor) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (and possibly alters) all entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorChangingVisitor, int, int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (and possibly change) some entries of this vector in optimized order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealVectorPreservingVisitor) - Method in class org.apache.commons.math3.linear.RealVector
Visits (but does not alter) all entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorPreservingVisitor, int, int) - Method in class org.apache.commons.math3.linear.RealVector
Visits (but does not alter) some entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorChangingVisitor) - Method in class org.apache.commons.math3.linear.RealVector
Visits (and possibly alters) all entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorChangingVisitor, int, int) - Method in class org.apache.commons.math3.linear.RealVector
Visits (and possibly change) some entries of this vector in optimized order.
walkInOptimizedOrder(FieldVectorPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Visits (but does not alter) all entries of this vector in optimized order.
walkInOptimizedOrder(FieldVectorPreservingVisitor<T>, int, int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Visits (but does not alter) some entries of this vector in optimized order.
walkInOptimizedOrder(FieldVectorChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Visits (and possibly alters) all entries of this vector in optimized order.
walkInOptimizedOrder(FieldVectorChangingVisitor<T>, int, int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Visits (and possibly change) some entries of this vector in optimized order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) some matrix entries in row order.
WARNING - Static variable in class org.jfree.chart.plot.ThermometerPlot
A constant for the 'warning' range.
WaterfallBarRenderer - Class in org.jfree.chart.renderer.category
A renderer that handles the drawing of waterfall bar charts, for use with the CategoryPlot class.
WaterfallBarRenderer() - Constructor for class org.jfree.chart.renderer.category.WaterfallBarRenderer
Constructs a new renderer with default values for the bar colors.
WaterfallBarRenderer(Paint, Paint, Paint, Paint) - Constructor for class org.jfree.chart.renderer.category.WaterfallBarRenderer
Constructs a new waterfall renderer.
watt - Static variable in class cern.clhep.Units
 
Web - Class in jhplot
Simple file downloader similar to Unix WGET.
Web() - Constructor for class jhplot.Web
 
weber - Static variable in class cern.clhep.Units
 
Week - Class in org.jfree.data.time
A calendar week.
Week() - Constructor for class org.jfree.data.time.Week
Creates a new time period for the week in which the current system date/time falls.
Week(int, int) - Constructor for class org.jfree.data.time.Week
Creates a time period representing the week in the specified year.
Week(int, Year) - Constructor for class org.jfree.data.time.Week
Creates a time period representing the week in the specified year.
Week(Date) - Constructor for class org.jfree.data.time.Week
Creates a time period for the week in which the specified date/time falls, using the default time zone and locale (the locale can affect the day-of-the-week that marks the beginning of the week, as well as the minimal number of days in the first week of the year).
Week(Date, TimeZone) - Constructor for class org.jfree.data.time.Week
Deprecated.
Week(Date, TimeZone, Locale) - Constructor for class org.jfree.data.time.Week
Creates a time period for the week in which the specified date/time falls, calculated relative to the specified time zone.
Weibull - Class in jhplot.math.num.pdf
The Weibull distribution.
Weibull() - Constructor for class jhplot.math.num.pdf.Weibull
Default constructor.
Weibull(double, double) - Constructor for class jhplot.math.num.pdf.Weibull
Create a distribution with the given parameters.
Weibull(double, double, double) - Constructor for class jhplot.math.num.pdf.Weibull
Create a distribution with the given parameters.
weibull(double, double) - Static method in class jhplot.math.Random
Generate a random number from a Weibull random variable.
WeibullDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Weibull distribution.
WeibullDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.WeibullDistribution
Create a Weibull distribution with the given shape and scale and a location equal to zero.
WeibullDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.WeibullDistribution
Create a Weibull distribution with the given shape, scale and inverse cumulative probability accuracy and a location equal to zero.
WeibullDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.WeibullDistribution
Creates a Weibull distribution.
WeibullDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.WeibullDistribution
Creates a Weibull distribution.
WeibullRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Weibull distribution.
WeibullRandomVariable() - Constructor for class jhplot.math.num.random.WeibullRandomVariable
Default constructor.
WeibullRandomVariable(double, double) - Constructor for class jhplot.math.num.random.WeibullRandomVariable
Create a rnadom variable with the given shape and scale values.
WeibullRandomVariable(double, double, double) - Constructor for class jhplot.math.num.random.WeibullRandomVariable
Create a random variable with the given parameters.
WeibullRandomVariable(double, double, double, RNG) - Constructor for class jhplot.math.num.random.WeibullRandomVariable
Create a random variable with the given parameters.
WeibullRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.WeibullRandomVariable
Create a random variable with the given shape and scale values.
weight(RealMatrix) - Method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresBuilder
Configure the weight matrix.
Weight - Class in org.apache.commons.math3.optim.nonlinear.vector
Deprecated.
All classes and interfaces in this package are deprecated. The optimizers that were provided here were moved to the org.apache.commons.math3.fitting.leastsquares package (cf. MATH-1008).
Weight(double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.Weight
Deprecated.
Creates a diagonal weight matrix.
Weight(RealMatrix) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.Weight
Deprecated.
 
Weight - Class in org.apache.commons.math3.optimization
Deprecated.
As of 3.1 (to be removed in 4.0).
Weight(double[]) - Constructor for class org.apache.commons.math3.optimization.Weight
Deprecated.
Creates a diagonal weight matrix.
Weight(RealMatrix) - Constructor for class org.apache.commons.math3.optimization.Weight
Deprecated.
 
WEIGHT_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
WEIGHT_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
WEIGHT_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
WEIGHT_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
WEIGHT_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
WEIGHT_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
WEIGHT_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
WEIGHT_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
WEIGHT_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
weightDiagonal(LeastSquaresProblem, RealVector) - Static method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresFactory
Apply a diagonal weight matrix to the LeastSquaresProblem.
WeightedEvaluation - Interface in org.apache.commons.math3.stat.descriptive
Weighted evaluation for statistics.
weightedMean(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the weighted mean of a data sequence.
WeightedObservedPoint - Class in org.apache.commons.math3.fitting
This class is a simple container for weighted observed point in curve fitting.
WeightedObservedPoint(double, double, double) - Constructor for class org.apache.commons.math3.fitting.WeightedObservedPoint
Simple constructor.
WeightedObservedPoint - Class in org.apache.commons.math3.optimization.fitting
Deprecated.
As of 3.1 (to be removed in 4.0).
WeightedObservedPoint(double, double, double) - Constructor for class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint
Deprecated.
Simple constructor.
WeightedObservedPoints - Class in org.apache.commons.math3.fitting
Simple container for weighted observed points used in curve fitting algorithms.
WeightedObservedPoints() - Constructor for class org.apache.commons.math3.fitting.WeightedObservedPoints
 
WeightedRandomSampler - Class in cern.jet.random.sampling
Conveniently computes a stable subsequence of elements from a given input sequence; Picks (samples) exactly one random element from successive blocks of weight input elements each.
WeightedRandomSampler() - Constructor for class cern.jet.random.sampling.WeightedRandomSampler
Calls BlockedRandomSampler(1,null).
WeightedRandomSampler(int, RandomEngine) - Constructor for class cern.jet.random.sampling.WeightedRandomSampler
Chooses exactly one random element from successive blocks of weight input elements each.
weightedRMS(double, double) - Static method in class cern.jet.stat.Descriptive
Returns the weighted RMS (Root-Mean-Square) of a data sequence.
weightMatrix(LeastSquaresProblem, RealMatrix) - Static method in class org.apache.commons.math3.fitting.leastsquares.LeastSquaresFactory
Apply a dense weight matrix to the LeastSquaresProblem.
Well1024a - Class in org.apache.commons.math3.random
This class implements the WELL1024a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well1024a() - Constructor for class org.apache.commons.math3.random.Well1024a
Creates a new random number generator.
Well1024a(int) - Constructor for class org.apache.commons.math3.random.Well1024a
Creates a new random number generator using a single int seed.
Well1024a(int[]) - Constructor for class org.apache.commons.math3.random.Well1024a
Creates a new random number generator using an int array seed.
Well1024a(long) - Constructor for class org.apache.commons.math3.random.Well1024a
Creates a new random number generator using a single long seed.
Well19937a - Class in org.apache.commons.math3.random
This class implements the WELL19937a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well19937a() - Constructor for class org.apache.commons.math3.random.Well19937a
Creates a new random number generator.
Well19937a(int) - Constructor for class org.apache.commons.math3.random.Well19937a
Creates a new random number generator using a single int seed.
Well19937a(int[]) - Constructor for class org.apache.commons.math3.random.Well19937a
Creates a new random number generator using an int array seed.
Well19937a(long) - Constructor for class org.apache.commons.math3.random.Well19937a
Creates a new random number generator using a single long seed.
Well19937c - Class in org.apache.commons.math3.random
This class implements the WELL19937c pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well19937c() - Constructor for class org.apache.commons.math3.random.Well19937c
Creates a new random number generator.
Well19937c(int) - Constructor for class org.apache.commons.math3.random.Well19937c
Creates a new random number generator using a single int seed.
Well19937c(int[]) - Constructor for class org.apache.commons.math3.random.Well19937c
Creates a new random number generator using an int array seed.
Well19937c(long) - Constructor for class org.apache.commons.math3.random.Well19937c
Creates a new random number generator using a single long seed.
Well44497a - Class in org.apache.commons.math3.random
This class implements the WELL44497a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well44497a() - Constructor for class org.apache.commons.math3.random.Well44497a
Creates a new random number generator.
Well44497a(int) - Constructor for class org.apache.commons.math3.random.Well44497a
Creates a new random number generator using a single int seed.
Well44497a(int[]) - Constructor for class org.apache.commons.math3.random.Well44497a
Creates a new random number generator using an int array seed.
Well44497a(long) - Constructor for class org.apache.commons.math3.random.Well44497a
Creates a new random number generator using a single long seed.
Well44497b - Class in org.apache.commons.math3.random
This class implements the WELL44497b pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well44497b() - Constructor for class org.apache.commons.math3.random.Well44497b
Creates a new random number generator.
Well44497b(int) - Constructor for class org.apache.commons.math3.random.Well44497b
Creates a new random number generator using a single int seed.
Well44497b(int[]) - Constructor for class org.apache.commons.math3.random.Well44497b
Creates a new random number generator using an int array seed.
Well44497b(long) - Constructor for class org.apache.commons.math3.random.Well44497b
Creates a new random number generator using a single long seed.
Well512a - Class in org.apache.commons.math3.random
This class implements the WELL512a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well512a() - Constructor for class org.apache.commons.math3.random.Well512a
Creates a new random number generator.
Well512a(int) - Constructor for class org.apache.commons.math3.random.Well512a
Creates a new random number generator using a single int seed.
Well512a(int[]) - Constructor for class org.apache.commons.math3.random.Well512a
Creates a new random number generator using an int array seed.
Well512a(long) - Constructor for class org.apache.commons.math3.random.Well512a
Creates a new random number generator using a single long seed.
WelzlEncloser<S extends Space,P extends Point<S>> - Class in org.apache.commons.math3.geometry.enclosing
Class implementing Emo Welzl algorithm to find the smallest enclosing ball in linear time.
WelzlEncloser(double, SupportBallGenerator<S, P>) - Constructor for class org.apache.commons.math3.geometry.enclosing.WelzlEncloser
Simple constructor.
WEST_ABOVE - Static variable in class org.jfree.chart.plot.PolarAxisLocation
Axis above west.
WEST_BELOW - Static variable in class org.jfree.chart.plot.PolarAxisLocation
Axis below west.
wholeHyperplane() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Build a region covering the whole hyperplane.
wholeHyperplane() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a region covering the whole hyperplane.
wholeHyperplane() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Build a sub-hyperplane covering the whole hyperplane.
wholeHyperplane() - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Build a sub-hyperplane covering the whole hyperplane.
wholeHyperplane() - Method in class org.apache.commons.math3.geometry.spherical.oned.LimitAngle
Build a region covering the whole hyperplane.
wholeHyperplane() - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Build a sub-hyperplane covering the whole hyperplane.
wholeLine() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Build a sub-line covering the whole line.
wholeSpace() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Build a region covering the whole space.
wholeSpace() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a region covering the whole space.
wholeSpace() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Build a region covering the whole space.
wholeSpace() - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Build a region covering the whole space.
wholeSpace() - Method in class org.apache.commons.math3.geometry.spherical.oned.LimitAngle
Build a region covering the whole space.
wholeSpace() - Method in class org.apache.commons.math3.geometry.spherical.twod.Circle
Build a region covering the whole space.
width() - Method in class j4np.physics.PDGParticle
 
WIDTH - Static variable in class jplot.JPlot
 
width - Variable in class jplot3dp.ModelView.AxesDefinition
 
WIDTH_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
WIDTH_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
WIDTH_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
WIDTH_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
WIDTHMETHOD_AVERAGE - Static variable in class org.jfree.chart.renderer.xy.CandlestickRenderer
The average width method.
WIDTHMETHOD_INTERVALDATA - Static variable in class org.jfree.chart.renderer.xy.CandlestickRenderer
The interval data method.
WIDTHMETHOD_SMALLEST - Static variable in class org.jfree.chart.renderer.xy.CandlestickRenderer
The smallest width method.
wilcoxonSignedRank(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.WilcoxonSignedRankTest
Computes the Wilcoxon signed ranked statistic comparing mean for two related samples or repeated measurements on a single sample.
WilcoxonSignedRankTest - Class in org.apache.commons.math3.stat.inference
An implementation of the Wilcoxon signed-rank test.
WilcoxonSignedRankTest() - Constructor for class org.apache.commons.math3.stat.inference.WilcoxonSignedRankTest
Create a test instance where NaN's are left in place and ties get the average of applicable ranks.
WilcoxonSignedRankTest(NaNStrategy, TiesStrategy) - Constructor for class org.apache.commons.math3.stat.inference.WilcoxonSignedRankTest
Create a test instance using the given strategies for NaN's and ties.
wilcoxonSignedRankTest(double[], double[], boolean) - Method in class org.apache.commons.math3.stat.inference.WilcoxonSignedRankTest
Returns the observed significance level, or p-value, associated with a Wilcoxon signed ranked statistic comparing mean for two related samples or repeated measurements on a single sample.
WildcardFileFilter - Class in org.apache.commons.io.filefilter
Filters files using the supplied wildcards.
WildcardFileFilter(String) - Constructor for class org.apache.commons.io.filefilter.WildcardFileFilter
Construct a new case-sensitive wildcard filter for a single wildcard.
WildcardFileFilter(String, IOCase) - Constructor for class org.apache.commons.io.filefilter.WildcardFileFilter
Construct a new wildcard filter for a single wildcard specifying case-sensitivity.
WildcardFileFilter(String...) - Constructor for class org.apache.commons.io.filefilter.WildcardFileFilter
Construct a new case-sensitive wildcard filter for an array of wildcards.
WildcardFileFilter(String[], IOCase) - Constructor for class org.apache.commons.io.filefilter.WildcardFileFilter
Construct a new wildcard filter for an array of wildcards specifying case-sensitivity.
WildcardFileFilter(List<String>) - Constructor for class org.apache.commons.io.filefilter.WildcardFileFilter
Construct a new case-sensitive wildcard filter for a list of wildcards.
WildcardFileFilter(List<String>, IOCase) - Constructor for class org.apache.commons.io.filefilter.WildcardFileFilter
Construct a new wildcard filter for a list of wildcards specifying case-sensitivity.
WildcardFilter - Class in org.apache.commons.io.filefilter
Deprecated.
Use WildcardFileFilter. Deprecated as this class performs directory filtering which it shouldn't do, but that can't be removed due to compatibility.
WildcardFilter(String) - Constructor for class org.apache.commons.io.filefilter.WildcardFilter
Deprecated.
Construct a new case-sensitive wildcard filter for a single wildcard.
WildcardFilter(String...) - Constructor for class org.apache.commons.io.filefilter.WildcardFilter
Deprecated.
Construct a new case-sensitive wildcard filter for an array of wildcards.
WildcardFilter(List<String>) - Constructor for class org.apache.commons.io.filefilter.WildcardFilter
Deprecated.
Construct a new case-sensitive wildcard filter for a list of wildcards.
wildcardMatch(String, String) - Static method in class org.apache.commons.io.FilenameUtils
Checks a fileName to see if it matches the specified wildcard matcher, always testing case-sensitive.
wildcardMatch(String, String, IOCase) - Static method in class org.apache.commons.io.FilenameUtils
Checks a fileName to see if it matches the specified wildcard matcher allowing control over case-sensitivity.
wildcardMatchOnSystem(String, String) - Static method in class org.apache.commons.io.FilenameUtils
Checks a fileName to see if it matches the specified wildcard matcher using the case rules of the system.
WilsonScoreInterval - Class in org.apache.commons.math3.stat.interval
Implements the Wilson score method for creating a binomial proportion confidence interval.
WilsonScoreInterval() - Constructor for class org.apache.commons.math3.stat.interval.WilsonScoreInterval
 
WindDataset - Interface in org.jfree.data.xy
Interface for a dataset that supplies wind intensity and direction values observed at various points in time.
WindItemRenderer - Class in org.jfree.chart.renderer.xy
A specialised renderer for displaying wind intensity/direction data.
WindItemRenderer() - Constructor for class org.jfree.chart.renderer.xy.WindItemRenderer
Creates a new renderer.
WindNeedle - Class in org.jfree.chart.needle
A needle that indicates wind direction, for use with the CompassPlot class.
WindNeedle() - Constructor for class org.jfree.chart.needle.WindNeedle
Default constructor.
WindowsLineEndingInputStream - Class in org.apache.commons.io.input
A filtering input stream that ensures the content will have windows line endings, CRLF.
WindowsLineEndingInputStream(InputStream, boolean) - Constructor for class org.apache.commons.io.input.WindowsLineEndingInputStream
Create an input stream that filters another stream
winsorizedMean(DoubleArrayList, double, int, int) - Static method in class cern.jet.stat.Descriptive
Returns the winsorized mean of a sorted data sequence.
withBigIntegerCounters() - Static method in class org.apache.commons.io.file.AccumulatorPathVisitor
Creates a new instance configured with a BigInteger Counters.PathCounters.
withBigIntegerCounters() - Static method in class org.apache.commons.io.file.CleaningPathVisitor
Creates a new instance configured with a BigInteger Counters.PathCounters.
withBigIntegerCounters() - Static method in class org.apache.commons.io.file.CountingPathVisitor
Creates a new instance configured with a BigInteger Counters.PathCounters.
withBigIntegerCounters() - Static method in class org.apache.commons.io.file.DeletingPathVisitor
Creates a new instance configured with a BigInteger Counters.PathCounters.
withCallback(IntegerSequence.Incrementor.MaxCountExceededCallback) - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Creates a new instance with a given callback.
withCostRelativeTolerance(double) - Method in class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
 
withDecomposition(GaussNewtonOptimizer.Decomposition) - Method in class org.apache.commons.math3.fitting.leastsquares.GaussNewtonOptimizer
Configure the decomposition algorithm.
withEstimationType(Percentile.EstimationType) - Method in class org.apache.commons.math3.stat.descriptive.rank.Median
Build a new instance similar to the current one except for the estimation type.
withEstimationType(Percentile.EstimationType) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Build a new instance similar to the current one except for the estimation type.
withIncrement(int) - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Creates a new instance with a given increment.
withInitialStepBoundFactor(double) - Method in class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
 
withKthSelector(KthSelector) - Method in class org.apache.commons.math3.stat.descriptive.rank.Median
Build a new instance similar to the current one except for the kthSelector instance specifically set.
withKthSelector(KthSelector) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Build a new instance similar to the current one except for the kthSelector instance specifically set.
withLongCounters() - Static method in class org.apache.commons.io.file.AccumulatorPathVisitor
Creates a new instance configured with a long Counters.PathCounters.
withLongCounters() - Static method in class org.apache.commons.io.file.CleaningPathVisitor
Creates a new instance configured with a long Counters.PathCounters.
withLongCounters() - Static method in class org.apache.commons.io.file.CountingPathVisitor
Creates a new instance configured with a long Counters.PathCounters.
withLongCounters() - Static method in class org.apache.commons.io.file.DeletingPathVisitor
Creates a new instance configured with a long Counters.PathCounters.
withMaximalCount(int) - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Creates a new instance with a given maximal count.
withMaxIterations(int) - Method in class org.apache.commons.math3.fitting.GaussianCurveFitter
Configure the maximum number of iterations.
withMaxIterations(int) - Method in class org.apache.commons.math3.fitting.HarmonicCurveFitter
Configure the maximum number of iterations.
withMaxIterations(int) - Method in class org.apache.commons.math3.fitting.PolynomialCurveFitter
Configure the maximum number of iterations.
withMaxIterations(int) - Method in class org.apache.commons.math3.fitting.SimpleCurveFitter
Configure the maximum number of iterations.
withNaNStrategy(NaNStrategy) - Method in class org.apache.commons.math3.stat.descriptive.rank.Median
Build a new instance similar to the current one except for the NaN handling strategy.
withNaNStrategy(NaNStrategy) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Build a new instance similar to the current one except for the NaN handling strategy.
withOrthoTolerance(double) - Method in class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
Modifies the given parameter.
withParameterRelativeTolerance(double) - Method in class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
 
withPxPyPzM(double, double, double, double) - Static method in class j4np.physics.LorentzVector
 
withRankingThreshold(double) - Method in class org.apache.commons.math3.fitting.leastsquares.LevenbergMarquardtOptimizer
 
withStart(int) - Method in class org.apache.commons.math3.util.IntegerSequence.Incrementor
Creates a new instance with a given initial value.
withStartPoint(double[]) - Method in class org.apache.commons.math3.fitting.GaussianCurveFitter
Configure the start point (initial guess).
withStartPoint(double[]) - Method in class org.apache.commons.math3.fitting.HarmonicCurveFitter
Configure the start point (initial guess).
withStartPoint(double[]) - Method in class org.apache.commons.math3.fitting.PolynomialCurveFitter
Configure the start point (initial guess).
withStartPoint(double[]) - Method in class org.apache.commons.math3.fitting.SimpleCurveFitter
Configure the start point (initial guess).
WobbleStroke - Class in org.jlab.groot.base
 
WobbleStroke(float, float) - Constructor for class org.jlab.groot.base.WobbleStroke
 
WobbleStroke(int) - Constructor for class org.jlab.groot.base.WobbleStroke
 
WORD - Static variable in class org.jfree.chart.util.HexNumberFormat
Number of hexadecimal digits for a word.
WORKING_CALENDAR - Static variable in class org.jfree.data.time.RegularTimePeriod
Deprecated.
This was a bad idea, don't use it!
workingLine - Variable in class org.jfree.chart.renderer.xy.XYItemRendererState
A line object that the renderer can reuse to save instantiating a lot of objects.
wrap(IntegerSequence.Incrementor) - Static method in class org.apache.commons.math3.util.Incrementor
Deprecated.
Create an instance that delegates everything to a IntegerSequence.Incrementor.
write(String) - Method in class jhplot.HPlot
Write HPlot file and inserts graphs to the main frame.
write(double[], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes an array to a file.
write(double[][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(double[][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(double[][][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(double[][][][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(float[], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes an array to a file.
write(float[][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(float[][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(float[][][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(float[][][][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(int[], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes an array to a file.
write(int[][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(int[][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(int[][][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(int[][][][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(boolean[], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes an array to a file.
write(boolean[][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(boolean[][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(boolean[][][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(boolean[][][][][], String) - Static method in class jhplot.io.ArrayReaderWriter
Writes a rectangular jagged array to a file.
write(String) - Method in class jhplot.io.CFBook
write an external XML file with all CFBook objects (H1D, H2D, P1D)
write(PEventFile.HEvent.Builder) - Method in class jhplot.io.EFile
Add a data structure to a file
write(String, H1D) - Method in class jhplot.io.HBook
write H1D histogram to HBook
write(String, H2D) - Method in class jhplot.io.HBook
write H2D histogram to HBook
write(String, P1D) - Method in class jhplot.io.HBook
add P1D histogram to HBook
write(String, PND) - Method in class jhplot.io.HBook
add PND data object.
write(String, PNI) - Method in class jhplot.io.HBook
add PID data object.
write(String, P0D) - Method in class jhplot.io.HBook
add P0D data object.
write(String, P0I) - Method in class jhplot.io.HBook
add P0I data object.
write(String, P2D) - Method in class jhplot.io.HBook
add P2D data object.
write(Object) - Method in class jhplot.io.HBook
Add any object.
write(int, Object) - Method in class jhplot.io.HBook
Write jhplot data container.
write(String, F1D) - Method in class jhplot.io.HBook
write F1D function
write(String, FPR) - Method in class jhplot.io.HBook
write FPR parametric function
write(String, F2D) - Method in class jhplot.io.HBook
write F2D function
write(String, double[]) - Method in class jhplot.io.HBook
add 1D array
write(String, int[]) - Method in class jhplot.io.HBook
add 1D array
write(String, double[][]) - Method in class jhplot.io.HBook
add 2D array
write(String, int[][]) - Method in class jhplot.io.HBook
add 2D array
write(String, FND) - Method in class jhplot.io.HBook
add 2D array
write(String, Object) - Method in class jhplot.io.HFile
Add an object using a key.
write(Object) - Method in class jhplot.io.HFile
Add an object to a file
write(double[]) - Method in class jhplot.io.HFileDIF
Write double 1D array into the DIF file.
write(int[]) - Method in class jhplot.io.HFileDIF
Write double 1D array into the DIF file.
write(String[]) - Method in class jhplot.io.HFileDIF
Write double 1D array into the DIF file.
write(P0I) - Method in class jhplot.io.HFileDIF
Write 1D array into the DIF file.
write(P0D) - Method in class jhplot.io.HFileDIF
Write 1D array into the DIF file.
write(PND) - Method in class jhplot.io.HFileDIF
Write N-dimensional array into the DIF file.
write(PNI) - Method in class jhplot.io.HFileDIF
Write N-dimensional array into the DIF file.
write(H1D) - Method in class jhplot.io.HFileDIF
Write 1-D histograms (including errors) into the DIF file.
write(P1D) - Method in class jhplot.io.HFileDIF
Write 2D array into the DIF file.
write(String, Object) - Method in class jhplot.io.HFileXML
Add an object using a key.
write(Object) - Method in class jhplot.io.HFileXML
Add an object to a XML file
write(Object) - Method in class jhplot.io.PFile
Add an object to a file.
write(Object, String, boolean) - Static method in class jhplot.io.Serialized
Write an object to a serialized file.
write(Object, String) - Static method in class jhplot.io.Serialized
Write an object to a serialized file.
write(Object, String, boolean) - Static method in class jhplot.IO
Write an object to a serialized file.
write(Object, String) - Static method in class jhplot.IO
Write an object to a serialized file.
write(File, String) - Static method in class jhplot.math.io.ASCIIFile
 
write(String, boolean) - Method in class jhplot.math.io.ASCIIFile
Write a text in an ASCII File
write(int) - Method in class jhplot.math.io.BinaryOutputStream
Write a text in a binary File
write(int) - Method in class jhplot.math.io.LEDataOutputStream
 
write(byte[], int, int) - Method in class jhplot.math.io.LEDataOutputStream
 
write(byte[]) - Method in class jhplot.math.io.LEDataOutputStream
 
write(int) - Method in class jhplot.math.io.LERandomAccessFile
 
write(byte[], int, int) - Method in class jhplot.math.io.LERandomAccessFile
 
write(byte[]) - Method in class jhplot.math.io.LERandomAccessFile
 
write(String) - Method in class jhplot.PND
Write a PND to an external file.
write(String) - Method in class jhplot.PNI
Write a PNI to an external file.
write(File, CharSequence) - Static method in class org.apache.commons.io.FileUtils
Deprecated.
2.5 use FileUtils.write(File, CharSequence, Charset) instead (and specify the appropriate encoding)
write(File, CharSequence, boolean) - Static method in class org.apache.commons.io.FileUtils
Deprecated.
2.5 use FileUtils.write(File, CharSequence, Charset, boolean) instead (and specify the appropriate encoding)
write(File, CharSequence, Charset) - Static method in class org.apache.commons.io.FileUtils
Writes a CharSequence to a file creating the file if it does not exist.
write(File, CharSequence, Charset, boolean) - Static method in class org.apache.commons.io.FileUtils
Writes a CharSequence to a file creating the file if it does not exist.
write(File, CharSequence, String) - Static method in class org.apache.commons.io.FileUtils
Writes a CharSequence to a file creating the file if it does not exist.
write(File, CharSequence, String, boolean) - Static method in class org.apache.commons.io.FileUtils
Writes a CharSequence to a file creating the file if it does not exist.
write(byte[], OutputStream) - Static method in class org.apache.commons.io.IOUtils
Writes bytes from a byte[] to an OutputStream.
write(byte[], Writer) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
write(byte[], Writer, Charset) - Static method in class org.apache.commons.io.IOUtils
Writes bytes from a byte[] to chars on a Writer using the specified character encoding.
write(byte[], Writer, String) - Static method in class org.apache.commons.io.IOUtils
Writes bytes from a byte[] to chars on a Writer using the specified character encoding.
write(char[], OutputStream) - Static method in class org.apache.commons.io.IOUtils
write(char[], OutputStream, Charset) - Static method in class org.apache.commons.io.IOUtils
Writes chars from a char[] to bytes on an OutputStream using the specified character encoding.
write(char[], OutputStream, String) - Static method in class org.apache.commons.io.IOUtils
Writes chars from a char[] to bytes on an OutputStream using the specified character encoding.
write(char[], Writer) - Static method in class org.apache.commons.io.IOUtils
Writes chars from a char[] to a Writer
write(CharSequence, OutputStream) - Static method in class org.apache.commons.io.IOUtils
write(CharSequence, OutputStream, Charset) - Static method in class org.apache.commons.io.IOUtils
Writes chars from a CharSequence to bytes on an OutputStream using the specified character encoding.
write(CharSequence, OutputStream, String) - Static method in class org.apache.commons.io.IOUtils
Writes chars from a CharSequence to bytes on an OutputStream using the specified character encoding.
write(CharSequence, Writer) - Static method in class org.apache.commons.io.IOUtils
Writes chars from a CharSequence to a Writer.
write(String, OutputStream) - Static method in class org.apache.commons.io.IOUtils
write(String, OutputStream, Charset) - Static method in class org.apache.commons.io.IOUtils
Writes chars from a String to bytes on an OutputStream using the specified character encoding.
write(String, OutputStream, String) - Static method in class org.apache.commons.io.IOUtils
Writes chars from a String to bytes on an OutputStream using the specified character encoding.
write(String, Writer) - Static method in class org.apache.commons.io.IOUtils
Writes chars from a String to a Writer.
write(StringBuffer, OutputStream) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
replaced by write(CharSequence, OutputStream)
write(StringBuffer, OutputStream, String) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
replaced by write(CharSequence, OutputStream, String)
write(StringBuffer, Writer) - Static method in class org.apache.commons.io.IOUtils
Deprecated.
replaced by write(CharSequence, Writer)
write(byte[], int, int) - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
Writes the bytes to the byte array.
write(int) - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
Write a byte to byte array.
write(InputStream) - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
Writes the entire contents of the specified input stream to this byte stream.
write(int) - Method in class org.apache.commons.io.output.AppendableOutputStream
Write a character to the underlying appendable.
write(char[], int, int) - Method in class org.apache.commons.io.output.AppendableWriter
Writes a portion of an array of characters to the underlying appendable.
write(int) - Method in class org.apache.commons.io.output.AppendableWriter
Writes a character to the underlying appendable.
write(String, int, int) - Method in class org.apache.commons.io.output.AppendableWriter
Writes a portion of a String to the underlying appendable.
write(int) - Method in class org.apache.commons.io.output.BrokenOutputStream
Throws the configured exception.
write(char[], int, int) - Method in class org.apache.commons.io.output.BrokenWriter
Throws the configured exception.
write(byte[], int, int) - Method in class org.apache.commons.io.output.ByteArrayOutputStream
 
write(int) - Method in class org.apache.commons.io.output.ByteArrayOutputStream
 
write(InputStream) - Method in class org.apache.commons.io.output.ByteArrayOutputStream
 
write(byte[], int, int) - Method in class org.apache.commons.io.output.ChunkedOutputStream
Writes the data buffer in chunks to the underlying stream
write(char[], int, int) - Method in class org.apache.commons.io.output.ChunkedWriter
writes the data buffer in chunks to the underlying writer
write(int) - Method in class org.apache.commons.io.output.ClosedOutputStream
Throws an IOException to indicate that the stream is closed.
write(char[], int, int) - Method in class org.apache.commons.io.output.ClosedWriter
Throws an IOException to indicate that the writer is closed.
write(int) - Method in class org.apache.commons.io.output.DemuxOutputStream
Writes byte to stream associated with current thread.
write(int) - Method in class org.apache.commons.io.output.FileWriterWithEncoding
Write a character.
write(char[]) - Method in class org.apache.commons.io.output.FileWriterWithEncoding
Write the characters from an array.
write(char[], int, int) - Method in class org.apache.commons.io.output.FileWriterWithEncoding
Write the specified characters from an array.
write(String) - Method in class org.apache.commons.io.output.FileWriterWithEncoding
Write the characters from a string.
write(String, int, int) - Method in class org.apache.commons.io.output.FileWriterWithEncoding
Write the specified characters from a string.
write(char[], int, int) - Method in class org.apache.commons.io.output.FilterCollectionWriter
Writes a portion of an array of characters.
write(char[]) - Method in class org.apache.commons.io.output.FilterCollectionWriter
 
write(int) - Method in class org.apache.commons.io.output.FilterCollectionWriter
Writes a single character.
write(String) - Method in class org.apache.commons.io.output.FilterCollectionWriter
 
write(String, int, int) - Method in class org.apache.commons.io.output.FilterCollectionWriter
Writes a portion of a string.
write(int) - Method in class org.apache.commons.io.output.LockableFileWriter
Write a character.
write(char[]) - Method in class org.apache.commons.io.output.LockableFileWriter
Write the characters from an array.
write(char[], int, int) - Method in class org.apache.commons.io.output.LockableFileWriter
Write the specified characters from an array.
write(String) - Method in class org.apache.commons.io.output.LockableFileWriter
Write the characters from a string.
write(String, int, int) - Method in class org.apache.commons.io.output.LockableFileWriter
Write the specified characters from a string.
write(byte[], int, int) - Method in class org.apache.commons.io.output.NullOutputStream
Does nothing - output to /dev/null.
write(int) - Method in class org.apache.commons.io.output.NullOutputStream
Does nothing - output to /dev/null.
write(byte[]) - Method in class org.apache.commons.io.output.NullOutputStream
Does nothing - output to /dev/null.
write(int) - Method in class org.apache.commons.io.output.NullWriter
Does nothing - output to /dev/null.
write(char[]) - Method in class org.apache.commons.io.output.NullWriter
Does nothing - output to /dev/null.
write(char[], int, int) - Method in class org.apache.commons.io.output.NullWriter
Does nothing - output to /dev/null.
write(String) - Method in class org.apache.commons.io.output.NullWriter
Does nothing - output to /dev/null.
write(String, int, int) - Method in class org.apache.commons.io.output.NullWriter
Does nothing - output to /dev/null.
write(char[]) - Method in class org.apache.commons.io.output.ProxyCollectionWriter
Invokes the delegate's write(char[]) method.
write(char[], int, int) - Method in class org.apache.commons.io.output.ProxyCollectionWriter
Invokes the delegate's write(char[], int, int) method.
write(int) - Method in class org.apache.commons.io.output.ProxyCollectionWriter
Invokes the delegate's write(int) method.
write(String) - Method in class org.apache.commons.io.output.ProxyCollectionWriter
Invokes the delegate's write(String) method.
write(String, int, int) - Method in class org.apache.commons.io.output.ProxyCollectionWriter
Invokes the delegate's write(String) method.
write(int) - Method in class org.apache.commons.io.output.ProxyOutputStream
Invokes the delegate's write(int) method.
write(byte[]) - Method in class org.apache.commons.io.output.ProxyOutputStream
Invokes the delegate's write(byte[]) method.
write(byte[], int, int) - Method in class org.apache.commons.io.output.ProxyOutputStream
Invokes the delegate's write(byte[]) method.
write(int) - Method in class org.apache.commons.io.output.ProxyWriter
Invokes the delegate's write(int) method.
write(char[]) - Method in class org.apache.commons.io.output.ProxyWriter
Invokes the delegate's write(char[]) method.
write(char[], int, int) - Method in class org.apache.commons.io.output.ProxyWriter
Invokes the delegate's write(char[], int, int) method.
write(String) - Method in class org.apache.commons.io.output.ProxyWriter
Invokes the delegate's write(String) method.
write(String, int, int) - Method in class org.apache.commons.io.output.ProxyWriter
Invokes the delegate's write(String) method.
write(String) - Method in class org.apache.commons.io.output.StringBuilderWriter
Writes a String to the StringBuilder.
write(char[], int, int) - Method in class org.apache.commons.io.output.StringBuilderWriter
Writes a portion of a character array to the StringBuilder.
write(byte[]) - Method in class org.apache.commons.io.output.TeeOutputStream
Write the bytes to both streams.
write(byte[], int, int) - Method in class org.apache.commons.io.output.TeeOutputStream
Write the specified bytes to both streams.
write(int) - Method in class org.apache.commons.io.output.TeeOutputStream
Write a byte to both streams.
write(int) - Method in class org.apache.commons.io.output.ThresholdingOutputStream
Writes the specified byte to this output stream.
write(byte[]) - Method in class org.apache.commons.io.output.ThresholdingOutputStream
Writes b.length bytes from the specified byte array to this output stream.
write(byte[], int, int) - Method in class org.apache.commons.io.output.ThresholdingOutputStream
Writes len bytes from the specified byte array starting at offset off to this output stream.
write(byte[], int, int) - Method in class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
 
write(int) - Method in class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
 
write(InputStream) - Method in class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
 
write(byte[], int, int) - Method in class org.apache.commons.io.output.WriterOutputStream
Write bytes from the specified byte array to the stream.
write(byte[]) - Method in class org.apache.commons.io.output.WriterOutputStream
Write bytes from the specified byte array to the stream.
write(int) - Method in class org.apache.commons.io.output.WriterOutputStream
Write a single byte to the stream.
write(char[], int, int) - Method in class org.apache.commons.io.output.XmlStreamWriter
Writes the characters to the underlying writer, detecting encoding.
WRITE_APPEND - Static variable in interface hep.lcio.event.LCIO
 
WRITE_NEW - Static variable in interface hep.lcio.event.LCIO
 
writeAsJPEG(Drawable, int, int, File) - Static method in class org.jfree.chart.util.ExportUtils
Writes the current content to the specified file in JPEG format.
writeAsPDF(Drawable, int, int, File) - Static method in class org.jfree.chart.util.ExportUtils
Writes a Drawable to the specified file in PDF format.
writeAsPNG(Drawable, int, int, File) - Static method in class org.jfree.chart.util.ExportUtils
Writes the current content to the specified file in PNG format.
writeAsSVG(Drawable, int, int, File) - Static method in class org.jfree.chart.util.ExportUtils
Writes the current content to the specified file in SVG format.
writeBinary(String) - Method in class jhplot.P0D
Write a P0D to a binary file (big endian by default).
writeBinary(String) - Method in class jhplot.P0I
Write a P0I to a binary file (big endian by default).
writeBoolean(boolean) - Method in class jhplot.math.io.LEDataOutputStream
 
writeBoolean(boolean) - Method in class jhplot.math.io.LERandomAccessFile
 
writeBufferedImage(BufferedImage, String, OutputStream) - Static method in class org.jfree.chart.encoders.EncoderUtil
Encode the image in a specific format and write it to an OutputStream.
writeBufferedImage(BufferedImage, String, OutputStream, float) - Static method in class org.jfree.chart.encoders.EncoderUtil
Encode the image in a specific format and write it to an OutputStream.
writeBufferedImage(BufferedImage, String, OutputStream, boolean) - Static method in class org.jfree.chart.encoders.EncoderUtil
Encode the image in a specific format and write it to an OutputStream.
writeBufferedImage(BufferedImage, String, OutputStream, float, boolean) - Static method in class org.jfree.chart.encoders.EncoderUtil
Encode the image in a specific format and write it to an OutputStream.
writeBufferedImageAsJPEG(OutputStream, BufferedImage) - Static method in class org.jfree.chart.ChartUtilities
Writes a BufferedImage to an output stream in JPEG format.
writeBufferedImageAsJPEG(OutputStream, float, BufferedImage) - Static method in class org.jfree.chart.ChartUtilities
Writes a BufferedImage to an output stream in JPEG format.
writeBufferedImageAsPNG(OutputStream, BufferedImage) - Static method in class org.jfree.chart.ChartUtilities
Writes a BufferedImage to an output stream in PNG format.
writeBufferedImageAsPNG(OutputStream, BufferedImage, boolean, int) - Static method in class org.jfree.chart.ChartUtilities
Writes a BufferedImage to an output stream in PNG format.
writeByte(byte, boolean) - Method in class jhplot.math.io.BinaryFile
Write a text in a binary File
writeByte(byte, boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a text in a binary File
writeByte(int) - Method in class jhplot.math.io.LEDataOutputStream
 
writeByte(int) - Method in class jhplot.math.io.LERandomAccessFile
 
writeByteArray(byte[], boolean) - Method in class jhplot.math.io.BinaryFile
Write a text in a binary File
writeByteArray(byte[], boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a text in a binary File
writeByteArrayToFile(File, byte[]) - Static method in class org.apache.commons.io.FileUtils
Writes a byte array to a file creating the file if it does not exist.
writeByteArrayToFile(File, byte[], boolean) - Static method in class org.apache.commons.io.FileUtils
Writes a byte array to a file creating the file if it does not exist.
writeByteArrayToFile(File, byte[], int, int) - Static method in class org.apache.commons.io.FileUtils
Writes len bytes from the specified byte array starting at offset off to a file, creating the file if it does not exist.
writeByteArrayToFile(File, byte[], int, int, boolean) - Static method in class org.apache.commons.io.FileUtils
Writes len bytes from the specified byte array starting at offset off to a file, creating the file if it does not exist.
writeBytes(String) - Method in class jhplot.math.io.LEDataOutputStream
 
writeBytes(String) - Method in class jhplot.math.io.LERandomAccessFile
 
writeChar(int) - Method in class jhplot.math.io.LEDataOutputStream
 
writeChar(int) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeChar.
writeChars(String) - Method in class jhplot.math.io.LEDataOutputStream
 
writeChars(String) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeChars, has to flip each char.
writeChartAsJPEG(OutputStream, JFreeChart, int, int) - Static method in class org.jfree.chart.ChartUtilities
Writes a chart to an output stream in JPEG format.
writeChartAsJPEG(OutputStream, float, JFreeChart, int, int) - Static method in class org.jfree.chart.ChartUtilities
Writes a chart to an output stream in JPEG format.
writeChartAsJPEG(OutputStream, JFreeChart, int, int, ChartRenderingInfo) - Static method in class org.jfree.chart.ChartUtilities
Writes a chart to an output stream in JPEG format.
writeChartAsJPEG(OutputStream, float, JFreeChart, int, int, ChartRenderingInfo) - Static method in class org.jfree.chart.ChartUtilities
Writes a chart to an output stream in JPEG format.
writeChartAsPDF(OutputStream, JFreeChart, int, int, FontMapper) - Static method in class jminhep.gui.MainFrame
 
writeChartAsPNG(OutputStream, JFreeChart, int, int) - Static method in class org.jfree.chart.ChartUtilities
Writes a chart to an output stream in PNG format.
writeChartAsPNG(OutputStream, JFreeChart, int, int, boolean, int) - Static method in class org.jfree.chart.ChartUtilities
Writes a chart to an output stream in PNG format.
writeChartAsPNG(OutputStream, JFreeChart, int, int, ChartRenderingInfo) - Static method in class org.jfree.chart.ChartUtilities
Writes a chart to an output stream in PNG format.
writeChartAsPNG(OutputStream, JFreeChart, int, int, ChartRenderingInfo, boolean, int) - Static method in class org.jfree.chart.ChartUtilities
Writes a chart to an output stream in PNG format.
writeChunked(byte[], OutputStream) - Static method in class org.apache.commons.io.IOUtils
Writes bytes from a byte[] to an OutputStream using chunked writes.
writeChunked(char[], Writer) - Static method in class org.apache.commons.io.IOUtils
Writes chars from a char[] to a Writer using chunked writes.
writeColor(DataOutputStream, Color) - Static method in class jplot3d.Utils
 
writeDouble(double, boolean) - Method in class jhplot.math.io.BinaryFile
Write a double in a binary File
writeDouble(double, boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a double in a binary File
writeDouble(double) - Method in class jhplot.math.io.LEDataOutputStream
 
writeDouble(double) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeDouble.
writeDoubleArray(File, double[]) - Static method in class jhplot.math.io.ASCIIFile
 
writeDoubleArray(File, double[][]) - Static method in class jhplot.math.io.ASCIIFile
 
writeDoubleArray(File, double[], String) - Static method in class jhplot.math.io.BinaryFile
 
writeDoubleArray(double[], boolean) - Method in class jhplot.math.io.BinaryFile
Write a double array in a binary File
writeDoubleArray(OutputStream, double[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
writeDoubleArray(double[], boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a double array in a binary File
writeEvent(LCEvent) - Method in interface hep.lcio.io.LCWriter
Writes the given event to file.
writeExternal(ObjectOutput) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
writeExternal(ObjectOutput) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
writeFile(String) - Method in class org.jlab.groot.data.TDirectory
 
writeFloat(float, boolean) - Method in class jhplot.math.io.BinaryFile
Write a float in a binary File
writeFloat(float, boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a float in a binary File
writeFloat(float) - Method in class jhplot.math.io.LEDataOutputStream
 
writeFloat(float) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeFloat.
writeFloatArray(File, float[], String) - Static method in class jhplot.math.io.BinaryFile
 
writeFloatArray(float[], boolean) - Method in class jhplot.math.io.BinaryFile
Write a float array in a binary File
writeFloatArray(OutputStream, float[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
writeFloatArray(float[], boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a float array in a binary File
writeImageMap(PrintWriter, String, ChartRenderingInfo, boolean) - Static method in class org.jfree.chart.ChartUtilities
Writes an image map to an output stream.
writeImageMap(PrintWriter, String, ChartRenderingInfo, ToolTipTagFragmentGenerator, URLTagFragmentGenerator) - Static method in class org.jfree.chart.ChartUtilities
Writes an image map to the specified writer.
writeImageMap(PrintWriter, String, ChartRenderingInfo) - Static method in class org.jfree.chart.imagemap.ImageMapUtilities
Writes an image map to an output stream.
writeImageMap(PrintWriter, String, ChartRenderingInfo, boolean) - Static method in class org.jfree.chart.imagemap.ImageMapUtilities
Writes an image map to an output stream.
writeImageMap(PrintWriter, String, ChartRenderingInfo, ToolTipTagFragmentGenerator, URLTagFragmentGenerator) - Static method in class org.jfree.chart.imagemap.ImageMapUtilities
Writes an image map to an output stream.
writeInt(int, boolean) - Method in class jhplot.math.io.BinaryFile
Write an int in a binary File
writeInt(int, boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write an int in a binary File
writeInt(int) - Method in class jhplot.math.io.LEDataOutputStream
 
writeInt(int) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeInt.
writeIntArray(File, int[]) - Static method in class jhplot.math.io.ASCIIFile
 
writeIntArray(File, int[][]) - Static method in class jhplot.math.io.ASCIIFile
 
writeIntArray(File, int[], String) - Static method in class jhplot.math.io.BinaryFile
 
writeIntArray(int[], boolean) - Method in class jhplot.math.io.BinaryFile
Write an int array in a binary File
writeIntArray(OutputStream, int[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
writeIntArray(int[], boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write an int array in a binary File
writeLines(File, Collection<?>) - Static method in class org.apache.commons.io.FileUtils
Writes the toString() value of each item in a collection to the specified File line by line.
writeLines(File, Collection<?>, boolean) - Static method in class org.apache.commons.io.FileUtils
Writes the toString() value of each item in a collection to the specified File line by line.
writeLines(File, Collection<?>, String) - Static method in class org.apache.commons.io.FileUtils
Writes the toString() value of each item in a collection to the specified File line by line.
writeLines(File, Collection<?>, String, boolean) - Static method in class org.apache.commons.io.FileUtils
Writes the toString() value of each item in a collection to the specified File line by line.
writeLines(File, String, Collection<?>) - Static method in class org.apache.commons.io.FileUtils
Writes the toString() value of each item in a collection to the specified File line by line.
writeLines(File, String, Collection<?>, boolean) - Static method in class org.apache.commons.io.FileUtils
Writes the toString() value of each item in a collection to the specified File line by line, optionally appending.
writeLines(File, String, Collection<?>, String) - Static method in class org.apache.commons.io.FileUtils
Writes the toString() value of each item in a collection to the specified File line by line.
writeLines(File, String, Collection<?>, String, boolean) - Static method in class org.apache.commons.io.FileUtils
Writes the toString() value of each item in a collection to the specified File line by line.
writeLines(Collection<?>, String, OutputStream) - Static method in class org.apache.commons.io.IOUtils
writeLines(Collection<?>, String, OutputStream, Charset) - Static method in class org.apache.commons.io.IOUtils
Writes the toString() value of each item in a collection to an OutputStream line by line, using the specified character encoding and the specified line ending.
writeLines(Collection<?>, String, OutputStream, String) - Static method in class org.apache.commons.io.IOUtils
Writes the toString() value of each item in a collection to an OutputStream line by line, using the specified character encoding and the specified line ending.
writeLines(Collection<?>, String, Writer) - Static method in class org.apache.commons.io.IOUtils
Writes the toString() value of each item in a collection to a Writer line by line, using the specified line ending.
writeLong(long) - Method in class jhplot.math.io.LEDataOutputStream
 
writeLong(long) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeLong.
writeObject(Object) - Method in class jhplot.io.db.RecordWriter
 
writer(Appendable) - Static method in class org.apache.commons.io.IOUtils
Returns the given Appendable if it is already a Writer, otherwise creates a Writer wrapper around the given Appendable.
WriterOutputStream - Class in org.apache.commons.io.output
OutputStream implementation that transforms a byte stream to a character stream using a specified charset encoding and writes the resulting stream to a Writer.
WriterOutputStream(Writer, CharsetDecoder) - Constructor for class org.apache.commons.io.output.WriterOutputStream
Constructs a new WriterOutputStream with a default output buffer size of characters.
WriterOutputStream(Writer, CharsetDecoder, int, boolean) - Constructor for class org.apache.commons.io.output.WriterOutputStream
Constructs a new WriterOutputStream.
WriterOutputStream(Writer, Charset, int, boolean) - Constructor for class org.apache.commons.io.output.WriterOutputStream
Constructs a new WriterOutputStream.
WriterOutputStream(Writer, Charset) - Constructor for class org.apache.commons.io.output.WriterOutputStream
Constructs a new WriterOutputStream with a default output buffer size of characters.
WriterOutputStream(Writer, String, int, boolean) - Constructor for class org.apache.commons.io.output.WriterOutputStream
Constructs a new WriterOutputStream.
WriterOutputStream(Writer, String) - Constructor for class org.apache.commons.io.output.WriterOutputStream
Constructs a new WriterOutputStream with a default output buffer size of characters.
WriterOutputStream(Writer) - Constructor for class org.apache.commons.io.output.WriterOutputStream
writeRunHeader(LCRunHeader) - Method in interface hep.lcio.io.LCWriter
Writes the given run header to file.
writeScaledChartAsPNG(OutputStream, JFreeChart, int, int, int, int) - Static method in class org.jfree.chart.ChartUtilities
Writes a scaled version of a chart to an output stream in PNG format.
writeScript(File, HPlot) - Static method in class jhplot.io.JHwriter
Write the file
writeScript(File) - Method in class jplot.JPlot
Writes the script to a file.
writeSerialized(String) - Method in class jhplot.P0D
Write a P0D object to a serialized file
writeSerialized(String) - Method in class jhplot.P0I
Write a P0I object to a serialized file
writeSerialized(String) - Method in class jhplot.P1D
Write a P0D object to a serialized file
writeSerialized(String) - Method in class jhplot.P2D
Write a object to a serialized file
writeSerialized(String) - Method in class jhplot.P3D
Write a P0D object to a serialized file
writeSerialized(String) - Method in class jhplot.PND
Write a P0D object to a serialized file
writeSerialized(String) - Method in class jhplot.PNI
Write a P0D object to a serialized file
writeShort(int) - Method in class jhplot.math.io.LEDataOutputStream
 
writeShort(int) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeShort.
writeStringToFile(File, String) - Static method in class org.apache.commons.io.FileUtils
Deprecated.
2.5 use FileUtils.writeStringToFile(File, String, Charset) instead (and specify the appropriate encoding)
writeStringToFile(File, String, boolean) - Static method in class org.apache.commons.io.FileUtils
Deprecated.
2.5 use FileUtils.writeStringToFile(File, String, Charset, boolean) instead (and specify the appropriate encoding)
writeStringToFile(File, String, Charset) - Static method in class org.apache.commons.io.FileUtils
Writes a String to a file creating the file if it does not exist.
writeStringToFile(File, String, Charset, boolean) - Static method in class org.apache.commons.io.FileUtils
Writes a String to a file creating the file if it does not exist.
writeStringToFile(File, String, String) - Static method in class org.apache.commons.io.FileUtils
Writes a String to a file creating the file if it does not exist.
writeStringToFile(File, String, String, boolean) - Static method in class org.apache.commons.io.FileUtils
Writes a String to a file creating the file if it does not exist.
writeSwappedDouble(byte[], int, double) - Static method in class org.apache.commons.io.EndianUtils
Writes a "double" value to a byte array at a given offset.
writeSwappedDouble(OutputStream, double) - Static method in class org.apache.commons.io.EndianUtils
Writes a "double" value to an OutputStream.
writeSwappedFloat(byte[], int, float) - Static method in class org.apache.commons.io.EndianUtils
Writes a "float" value to a byte array at a given offset.
writeSwappedFloat(OutputStream, float) - Static method in class org.apache.commons.io.EndianUtils
Writes a "float" value to an OutputStream.
writeSwappedInteger(byte[], int, int) - Static method in class org.apache.commons.io.EndianUtils
Writes a "int" value to a byte array at a given offset.
writeSwappedInteger(OutputStream, int) - Static method in class org.apache.commons.io.EndianUtils
Writes a "int" value to an OutputStream.
writeSwappedLong(byte[], int, long) - Static method in class org.apache.commons.io.EndianUtils
Writes a "long" value to a byte array at a given offset.
writeSwappedLong(OutputStream, long) - Static method in class org.apache.commons.io.EndianUtils
Writes a "long" value to an OutputStream.
writeSwappedShort(byte[], int, short) - Static method in class org.apache.commons.io.EndianUtils
Writes a "short" value to a byte array at a given offset.
writeSwappedShort(OutputStream, short) - Static method in class org.apache.commons.io.EndianUtils
Writes a "short" value to an OutputStream.
writeTo(DataOutput) - Method in class jhplot.io.db.DbByteArrayOutputStream
Writes the full contents of the buffer a DataOutput stream.
writeTo(DataOutput) - Method in class jhplot.io.db.RecordWriter
Writes the data out to the stream without re-allocating the buffer.
writeTo(OutputStream) - Method in class org.apache.commons.io.output.AbstractByteArrayOutputStream
Writes the entire contents of this byte stream to the specified output stream.
writeTo(OutputStream) - Method in class org.apache.commons.io.output.ByteArrayOutputStream
 
writeTo(OutputStream) - Method in class org.apache.commons.io.output.DeferredFileOutputStream
Writes the data from this output stream to the specified output stream, after it has been closed.
writeTo(OutputStream) - Method in class org.apache.commons.io.output.UnsynchronizedByteArrayOutputStream
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMC.ProMCEvent.Event
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMC.ProMCEvent.Particles
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMC.ProMCEvent
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMCDescriptionFile.ProMCDescription
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMCHeaderFile.ProMCHeader
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaFloat
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMCStatFile.ProMCStat.MetaInt
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMCStatFile.ProMCStat.ProcessData
 
writeTo(CodedOutputStream) - Method in class proeic.io.ProMCStatFile.ProMCStat
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.F1D
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.F2D
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.FND
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.FPR
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.H1D
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.H2D
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.P0D
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.P0I
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.P1D
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.PND
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.PNI
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.PXY
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record.PXYZ
 
writeTo(CodedOutputStream) - Method in class promc.io.PBufFile.Record
 
writeTo(CodedOutputStream) - Method in class promc.io.PEventFile.HEvent.Entry
 
writeTo(CodedOutputStream) - Method in class promc.io.PEventFile.HEvent.Group
 
writeTo(CodedOutputStream) - Method in class promc.io.PEventFile.HEvent
 
writeTo(CodedOutputStream) - Method in class promc.io.ProMC.ProMCEvent.Event
 
writeTo(CodedOutputStream) - Method in class promc.io.ProMC.ProMCEvent.Particles
 
writeTo(CodedOutputStream) - Method in class promc.io.ProMC.ProMCEvent
 
writeTo(CodedOutputStream) - Method in class promc.io.ProMCDescriptionFile.ProMCDescription
 
writeTo(CodedOutputStream) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
writeTo(CodedOutputStream) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
writeTo(CodedOutputStream) - Method in class promc.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
writeTo(CodedOutputStream) - Method in class promc.io.ProMCHeaderFile.ProMCHeader
 
writeTo(CodedOutputStream) - Method in class promc.io.ProMCStatFile.ProMCStat.ProcessData
 
writeTo(CodedOutputStream) - Method in class promc.io.ProMCStatFile.ProMCStat
 
writeTo(CodedOutputStream) - Method in class pronlo.io.ProMC.ProMCEvent.Event
 
writeTo(CodedOutputStream) - Method in class pronlo.io.ProMC.ProMCEvent.Particles
 
writeTo(CodedOutputStream) - Method in class pronlo.io.ProMC.ProMCEvent
 
writeTo(CodedOutputStream) - Method in class pronlo.io.ProMCDescriptionFile.ProMCDescription
 
writeTo(CodedOutputStream) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
writeTo(CodedOutputStream) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
writeTo(CodedOutputStream) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
writeTo(CodedOutputStream) - Method in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
writeTo(CodedOutputStream) - Method in class pronlo.io.ProMCStatFile.ProMCStat.ProcessData
 
writeTo(CodedOutputStream) - Method in class pronlo.io.ProMCStatFile.ProMCStat
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMC.ProMCEvent.BLJets
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMC.ProMCEvent.Electrons
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMC.ProMCEvent.Event
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMC.ProMCEvent.GenJets
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMC.ProMCEvent.Jets
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMC.ProMCEvent.MissingET
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMC.ProMCEvent.Muons
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMC.ProMCEvent.Particles
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMC.ProMCEvent.Photons
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMC.ProMCEvent.Tracks
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMC.ProMCEvent
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMCDescriptionFile.ProMCDescription
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaFloat
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.MetaInt
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader.ParticleData
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMCHeaderFile.ProMCHeader
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMCStatFile.ProMCStat.ProcessData
 
writeTo(CodedOutputStream) - Method in class proreco.io.ProMCStatFile.ProMCStat
 
writeToStream(DataOutputStream) - Method in class jplot3dp.ModelView.AxesDefinition
 
writeToStream(DataOutputStream) - Method in class jplot3dp.ModelView.FunctionsList
 
writeToStream(DataOutputStream) - Method in class jplot3dp.ModelView.ModelFunction
 
writeToStream(DataOutputStream) - Method in class jplot3dp.ModelView
 
writeUTF(String) - Method in class jhplot.math.io.LEDataOutputStream
 
writeUTF(String) - Method in class jhplot.math.io.LERandomAccessFile
 
writeXML(Object, String) - Static method in class jhplot.io.Serialized
Write an object to a serialized XML file.
writeXML(Object, String) - Static method in class jhplot.IO
Write an object to a serialized XML file.

X

x() - Method in class hep.physics.vec.BasicHep3Vector
 
x() - Method in interface hep.physics.vec.Hep3Vector
 
x() - Method in class hep.physics.vec.SpacePoint
Cartesian x
x() - Method in class hephysics.vec.Hep3Vector
 
x() - Method in class hephysics.vec.HepLorentzVector
Get X position or Px
x() - Method in class hephysics.vec.SpacePoint
Cartesian x
x() - Method in class j4np.physics.Vector3
 
X - Variable in class Jampack.Eig
The matrix of eigevectors
x - Variable in class jplot3d.SurfaceVertex
The x coordinate
X - Static variable in class org.jlab.groot.base.AxisAttributes
 
X1_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
X1_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
X1_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
X1_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
X1_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
X1_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
X1_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
X2_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
X2_FIELD_NUMBER - Static variable in class proeic.io.ProMCHeaderFile.ProMCHeader
 
X2_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Event
 
X2_FIELD_NUMBER - Static variable in class promc.io.ProMCHeaderFile.ProMCHeader
 
X2_FIELD_NUMBER - Static variable in class pronlo.io.ProMCHeaderFile.ProMCHeader
 
X2_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Event
 
X2_FIELD_NUMBER - Static variable in class proreco.io.ProMCHeaderFile.ProMCHeader
 
X_AXIS - Static variable in class jplot.Axis
 
X_AXIS - Static variable in class jplot.GraphSettings
Symbolic constant used to name the (bottom) X-axis of the graph.
X_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Event
 
X_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
X_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P1D
 
X_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PXY
 
X_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PXYZ
 
X_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
X_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
X_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
X_MAX_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
X_MIN_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
XAssign - Class in org.lsmp.djep.xjep.function
An assignment operator so we can do x=3+4.
XAssign() - Constructor for class org.lsmp.djep.xjep.function.XAssign
 
xAxis() - Method in interface colt.hep.aida.IHistogram1D
Returns the X Axis.
xAxis() - Method in interface colt.hep.aida.IHistogram2D
Return the X axis.
xAxis() - Method in interface colt.hep.aida.IHistogram3D
Return the X axis.
xaxis - Variable in class graph.DataSet
The Axis object the X data is attached to.
Xeon_Amdahl - Class in org.jlab.groot.demo
 
Xeon_Amdahl() - Constructor for class org.jlab.groot.demo.Xeon_Amdahl
 
XEvaluatorVisitor - Class in org.lsmp.djep.xjep
This class is used for the evaluation of an expression.
XEvaluatorVisitor() - Constructor for class org.lsmp.djep.xjep.XEvaluatorVisitor
 
XIntervalDataItem - Class in org.jfree.data.xy
An item representing data in the form (x, x-low, x-high, y).
XIntervalDataItem(double, double, double, double) - Constructor for class org.jfree.data.xy.XIntervalDataItem
Creates a new instance of XIntervalDataItem.
XIntervalSeries - Class in org.jfree.data.xy
A list of (x, x-low, x-high, y) data items.
XIntervalSeries(Comparable) - Constructor for class org.jfree.data.xy.XIntervalSeries
Creates a new empty series.
XIntervalSeries(Comparable, boolean, boolean) - Constructor for class org.jfree.data.xy.XIntervalSeries
Constructs a new xy-series that contains no data.
XIntervalSeriesCollection - Class in org.jfree.data.xy
A collection of XIntervalSeries objects.
XIntervalSeriesCollection() - Constructor for class org.jfree.data.xy.XIntervalSeriesCollection
Creates a new instance of XIntervalSeriesCollection.
XisSymbolic - Interface in org.jfree.data.xy
Represent a data set where X is a symbolic values.
XJep - Class in org.lsmp.djep.xjep
An extended version of JEP adds various routines for working with trees.
XJep() - Constructor for class org.lsmp.djep.xjep.XJep
Create a new XJep will all the function of JEP plus printing and other features.
XJep(JEP) - Constructor for class org.lsmp.djep.xjep.XJep
Conversion constructor.
XJepConsole - Class in org.lsmp.djepExamples
 
XJepConsole() - Constructor for class org.lsmp.djepExamples.XJepConsole
 
XJepExample - Class in org.lsmp.djepExamples
Examples using differentation
XJepExample() - Constructor for class org.lsmp.djepExamples.XJepExample
 
XJepTest - Class in org.lsmp.djepJUnit
 
XJepTest(String) - Constructor for class org.lsmp.djepJUnit.XJepTest
 
XLABEL - Static variable in class jplot.GraphLabel
 
XLEFT_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P1D
 
XMath - Class in org.lsmp.djep.xjep
 
XMath() - Constructor for class org.lsmp.djep.xjep.XMath
 
xmax - Variable in class graph.DataSet
The current plottable X maximum of the data.
xmax - Variable in class jplot3d.JSurface
 
xmin - Variable in class graph.DataSet
The current plottable X minimum of the data.
xmin - Variable in class jplot3d.JSurface
 
xmin() - Method in class org.freehep.math.minuit.ContoursError
 
xminimum() - Method in class cern.colt.list.MinMaxNumberList
Deprecated. 
xMinosError() - Method in class org.freehep.math.minuit.ContoursError
 
XMLRead - Class in jplot
XML reading utilities.
XMLRead() - Constructor for class jplot.XMLRead
Builds the XML tool class.
XmlStreamReader - Class in org.apache.commons.io.input
Character stream that handles all the necessary Voodoo to figure out the charset encoding of the XML document within the stream.
XmlStreamReader(File) - Constructor for class org.apache.commons.io.input.XmlStreamReader
Creates a Reader for a File.
XmlStreamReader(InputStream) - Constructor for class org.apache.commons.io.input.XmlStreamReader
Creates a Reader for a raw InputStream.
XmlStreamReader(InputStream, boolean) - Constructor for class org.apache.commons.io.input.XmlStreamReader
Creates a Reader for a raw InputStream.
XmlStreamReader(InputStream, boolean, String) - Constructor for class org.apache.commons.io.input.XmlStreamReader
Creates a Reader for a raw InputStream.
XmlStreamReader(URL) - Constructor for class org.apache.commons.io.input.XmlStreamReader
Creates a Reader using the InputStream of a URL.
XmlStreamReader(URLConnection, String) - Constructor for class org.apache.commons.io.input.XmlStreamReader
Creates a Reader using the InputStream of a URLConnection.
XmlStreamReader(InputStream, String) - Constructor for class org.apache.commons.io.input.XmlStreamReader
Creates a Reader using an InputStream and the associated content-type header.
XmlStreamReader(InputStream, String, boolean, String) - Constructor for class org.apache.commons.io.input.XmlStreamReader
Creates a Reader using an InputStream and the associated content-type header.
XmlStreamReader(InputStream, String, boolean) - Constructor for class org.apache.commons.io.input.XmlStreamReader
Creates a Reader using an InputStream and the associated content-type header.
XmlStreamReaderException - Exception in org.apache.commons.io.input
The XmlStreamReaderException is thrown by the XmlStreamReader constructors if the charset encoding can not be determined according to the XML 1.0 specification and RFC 3023.
XmlStreamReaderException(String, String, String, String) - Constructor for exception org.apache.commons.io.input.XmlStreamReaderException
Creates an exception instance if the charset encoding could not be determined.
XmlStreamReaderException(String, String, String, String, String, String) - Constructor for exception org.apache.commons.io.input.XmlStreamReaderException
Creates an exception instance if the charset encoding could not be determined.
XmlStreamWriter - Class in org.apache.commons.io.output
Character stream that handles all the necessary Voodoo to figure out the charset encoding of the XML document written to the stream.
XmlStreamWriter(OutputStream) - Constructor for class org.apache.commons.io.output.XmlStreamWriter
Constructs a new XML stream writer for the specified output stream with a default encoding of UTF-8.
XmlStreamWriter(OutputStream, String) - Constructor for class org.apache.commons.io.output.XmlStreamWriter
Constructs a new XML stream writer for the specified output stream with the specified default encoding.
XmlStreamWriter(File) - Constructor for class org.apache.commons.io.output.XmlStreamWriter
Constructs a new XML stream writer for the specified file with a default encoding of UTF-8.
XmlStreamWriter(File, String) - Constructor for class org.apache.commons.io.output.XmlStreamWriter
Constructs a new XML stream writer for the specified file with the specified default encoding.
XMLWrite - Class in jplot
XML-formated writing utilities.
XMLWrite() - Constructor for class jplot.XMLWrite
Builds the XML writer class with default settings.
XMLWrite(String) - Constructor for class jplot.XMLWrite
Builds the XML writer.
XMLWrite(String, String) - Constructor for class jplot.XMLWrite
Builds the XML writer.
XOperator - Class in org.lsmp.djep.xjep
An Operator with additional information about its commutativity etc.
XOperator(String, PostfixMathCommandI, int) - Constructor for class org.lsmp.djep.xjep.XOperator
construct a new operator.
XOperator(String, PostfixMathCommandI, int, int) - Constructor for class org.lsmp.djep.xjep.XOperator
Allows a given precedent to be set.
XOperator(String, String, PostfixMathCommandI, int) - Constructor for class org.lsmp.djep.xjep.XOperator
construct a new operator, with a different name and symbol
XOperator(String, String, PostfixMathCommandI, int, int) - Constructor for class org.lsmp.djep.xjep.XOperator
Allows a given precedent to be set.
XOperator(Operator, int, int) - Constructor for class org.lsmp.djep.xjep.XOperator
 
XOperator(Operator, int) - Constructor for class org.lsmp.djep.xjep.XOperator
 
XOperatorSet - Class in org.lsmp.djep.xjep
An OperatorSet where the operators have information about their commutativity etc.
XOperatorSet(OperatorSet) - Constructor for class org.lsmp.djep.xjep.XOperatorSet
Creates the operator set from a given set.
XOperatorSet() - Constructor for class org.lsmp.djep.xjep.XOperatorSet
Create the standard set of operators.
xor(BitMatrix) - Method in class cern.colt.bitvector.BitMatrix
Performs a logical XOR of the receiver with another bit matrix.
xor(BitVector) - Method in class cern.colt.bitvector.BitVector
Performs a logical XOR of the receiver with another bit vector (A = A ^ B).
xor - Static variable in class cern.jet.math.IntFunctions
Function that returns a ^ b.
xor(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a | b.
xor(Region<S>, Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Compute the symmetric difference (exclusive or) of two regions.
XOUTER_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
xpar() - Method in class org.freehep.math.minuit.ContoursError
 
Xpos - Static variable in class jhplot.JHPlot
 
xRange() - Method in class org.freehep.math.minuit.ContoursError
 
XRIGHT_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P1D
 
XrootdStoreFactory - Class in root
An implementation of IStoreFactory that creates RootStore.
XrootdStoreFactory() - Constructor for class root.XrootdStoreFactory
 
XSymbolTable - Class in org.lsmp.djep.xjep
An extension of the symbol table with a few new features.
XSymbolTable(VariableFactory) - Constructor for class org.lsmp.djep.xjep.XSymbolTable
Create a new XSymbolTable with the given variable factory.
XSYSLEFT_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P1D
 
XSYSRIGHT_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P1D
 
XVariable - Class in org.lsmp.djep.xjep
Variables which have their equations stored.
XVariable(String) - Constructor for class org.lsmp.djep.xjep.XVariable
 
XVariable(String, Object) - Constructor for class org.lsmp.djep.xjep.XVariable
 
XVariableFactory - Class in org.lsmp.djep.xjep
A VariableFactory which creates XVariables (which have equations).
XVariableFactory() - Constructor for class org.lsmp.djep.xjep.XVariableFactory
 
XYAnnotation - Interface in org.jfree.chart.annotations
The interface that must be supported by annotations that are to be added to an XYPlot.
XYAnnotationBoundsInfo - Interface in org.jfree.chart.annotations
An interface that supplies information about the bounds of the annotation.
XYAnnotationEntity - Class in org.jfree.chart.entity
A chart entity that represents an annotation on an XYPlot.
XYAnnotationEntity(Shape, int, String, String) - Constructor for class org.jfree.chart.entity.XYAnnotationEntity
Creates a new entity.
XYAreaRenderer - Class in org.jfree.chart.renderer.xy
Area item renderer for an XYPlot.
XYAreaRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYAreaRenderer
Constructs a new renderer.
XYAreaRenderer(int) - Constructor for class org.jfree.chart.renderer.xy.XYAreaRenderer
Constructs a new renderer.
XYAreaRenderer(int, XYToolTipGenerator, XYURLGenerator) - Constructor for class org.jfree.chart.renderer.xy.XYAreaRenderer
Constructs a new renderer.
XYAreaRenderer2 - Class in org.jfree.chart.renderer.xy
Area item renderer for an XYPlot.
XYAreaRenderer2() - Constructor for class org.jfree.chart.renderer.xy.XYAreaRenderer2
Constructs a new renderer.
XYAreaRenderer2(XYToolTipGenerator, XYURLGenerator) - Constructor for class org.jfree.chart.renderer.xy.XYAreaRenderer2
Constructs a new renderer.
XYBarDataset - Class in org.jfree.data.xy
A dataset wrapper class that converts a standard XYDataset into an IntervalXYDataset suitable for use in creating XY bar charts.
XYBarDataset(XYDataset, double) - Constructor for class org.jfree.data.xy.XYBarDataset
Creates a new dataset.
XYBarPainter - Interface in org.jfree.chart.renderer.xy
The interface for plugin painter for the XYBarRenderer class.
XYBarRenderer - Class in org.jfree.chart.renderer.xy
A renderer that draws bars on an XYPlot (requires an IntervalXYDataset).
XYBarRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYBarRenderer
The default constructor.
XYBarRenderer(double) - Constructor for class org.jfree.chart.renderer.xy.XYBarRenderer
Constructs a new renderer.
XYBlockRenderer - Class in org.jfree.chart.renderer.xy
A renderer that represents data from an XYZDataset by drawing a color block at each (x, y) point, where the color is a function of the z-value from the dataset.
XYBlockRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYBlockRenderer
Creates a new XYBlockRenderer instance with default attributes.
XYBoxAndWhiskerRenderer - Class in org.jfree.chart.renderer.xy
A renderer that draws box-and-whisker items on an XYPlot.
XYBoxAndWhiskerRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Creates a new renderer for box and whisker charts.
XYBoxAndWhiskerRenderer(double) - Constructor for class org.jfree.chart.renderer.xy.XYBoxAndWhiskerRenderer
Creates a new renderer for box and whisker charts.
XYBoxAnnotation - Class in org.jfree.chart.annotations
A box annotation that can be placed on an XYPlot.
XYBoxAnnotation(double, double, double, double) - Constructor for class org.jfree.chart.annotations.XYBoxAnnotation
Creates a new annotation (where, by default, the box is drawn with a black outline).
XYBoxAnnotation(double, double, double, double, Stroke, Paint) - Constructor for class org.jfree.chart.annotations.XYBoxAnnotation
Creates a new annotation where the box is drawn as an outline using the specified stroke and outlinePaint.
XYBoxAnnotation(double, double, double, double, Stroke, Paint, Paint) - Constructor for class org.jfree.chart.annotations.XYBoxAnnotation
Creates a new annotation.
XYBubbleRenderer - Class in org.jfree.chart.renderer.xy
A renderer that draws a circle at each data point with a diameter that is determined by the z-value in the dataset (the renderer requires the dataset to be an instance of XYZDataset.
XYBubbleRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYBubbleRenderer
Constructs a new renderer.
XYBubbleRenderer(int) - Constructor for class org.jfree.chart.renderer.xy.XYBubbleRenderer
Constructs a new renderer with the specified type of scaling.
XYCoordinate - Class in org.jfree.data.xy
Represents an (x, y) coordinate.
XYCoordinate() - Constructor for class org.jfree.data.xy.XYCoordinate
Creates a new coordinate for the point (0.0, 0.0).
XYCoordinate(double, double) - Constructor for class org.jfree.data.xy.XYCoordinate
Creates a new coordinate for the point (x, y).
XYCoordinateType - Class in org.jfree.chart.util
Represents several possible interpretations for an (x, y) coordinate.
XYCrosshairState - Class in org.jfree.chart.plot
Crosshair state information for the XYPlot and XYItemRenderer classes.
XYCrosshairState() - Constructor for class org.jfree.chart.plot.XYCrosshairState
Creates a new instance.
XYDataImageAnnotation - Class in org.jfree.chart.annotations
An annotation that allows an image to be placed within a rectangle specified in data coordinates on an XYPlot.
XYDataImageAnnotation(Image, double, double, double, double) - Constructor for class org.jfree.chart.annotations.XYDataImageAnnotation
Creates a new annotation to be displayed within the specified rectangle.
XYDataImageAnnotation(Image, double, double, double, double, boolean) - Constructor for class org.jfree.chart.annotations.XYDataImageAnnotation
Creates a new annotation to be displayed within the specified rectangle.
XYDataItem - Class in org.jfree.data.xy
Represents one (x, y) data item for an XYSeries.
XYDataItem(Number, Number) - Constructor for class org.jfree.data.xy.XYDataItem
Constructs a new data item.
XYDataItem(double, double) - Constructor for class org.jfree.data.xy.XYDataItem
Constructs a new data item.
XYDataset - Interface in org.jfree.data.xy
An interface through which data in the form of (x, y) items can be accessed.
XYDatasetTableModel - Class in org.jfree.data.xy
A READ-ONLY wrapper around a TableXYDataset to convert it to a table model for use in a JTable.
XYDatasetTableModel() - Constructor for class org.jfree.data.xy.XYDatasetTableModel
Default constructor.
XYDatasetTableModel(TableXYDataset) - Constructor for class org.jfree.data.xy.XYDatasetTableModel
Creates a new table model based on the specified dataset.
XYDifferenceRenderer - Class in org.jfree.chart.renderer.xy
A renderer for an XYPlot that highlights the differences between two series.
XYDifferenceRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Creates a new renderer with default attributes.
XYDifferenceRenderer(Paint, Paint, boolean) - Constructor for class org.jfree.chart.renderer.xy.XYDifferenceRenderer
Creates a new renderer.
XYDomainInfo - Interface in org.jfree.data.xy
An interface that can (optionally) be implemented by a dataset to assist in determining the minimum and maximum x-values in the dataset.
XYDotRenderer - Class in org.jfree.chart.renderer.xy
A renderer that draws a small dot at each data point for an XYPlot.
XYDotRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYDotRenderer
Constructs a new renderer.
XYDrawableAnnotation - Class in org.jfree.chart.annotations
A general annotation that can be placed on an XYPlot.
XYDrawableAnnotation(double, double, double, double, Drawable) - Constructor for class org.jfree.chart.annotations.XYDrawableAnnotation
Creates a new annotation to be displayed within the given area.
XYDrawableAnnotation(double, double, double, double, double, Drawable) - Constructor for class org.jfree.chart.annotations.XYDrawableAnnotation
Creates a new annotation to be displayed within the given area.
XYErrorRenderer - Class in org.jfree.chart.renderer.xy
A line and shape renderer that can also display x and/or y-error values.
XYErrorRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYErrorRenderer
Creates a new XYErrorRenderer instance.
XYImageAnnotation - Class in org.jfree.chart.annotations
An annotation that allows an image to be placed at some location on an XYPlot.
XYImageAnnotation(double, double, Image) - Constructor for class org.jfree.chart.annotations.XYImageAnnotation
Creates a new annotation to be displayed at the specified (x, y) location.
XYImageAnnotation(double, double, Image, RectangleAnchor) - Constructor for class org.jfree.chart.annotations.XYImageAnnotation
Creates a new annotation to be displayed at the specified (x, y) location.
XYInterval - Class in org.jfree.data.xy
An xy-interval.
XYInterval(double, double, double, double, double) - Constructor for class org.jfree.data.xy.XYInterval
Creates a new instance of XYInterval.
XYIntervalDataItem - Class in org.jfree.data.xy
An item representing data in the form (x, x-low, x-high, y, y-low, y-high).
XYIntervalDataItem(double, double, double, double, double, double) - Constructor for class org.jfree.data.xy.XYIntervalDataItem
Creates a new instance of XYIntervalItem.
XYIntervalSeries - Class in org.jfree.data.xy
A list of (x, x-low, x-high, y, y-low, y-high) data items.
XYIntervalSeries(Comparable) - Constructor for class org.jfree.data.xy.XYIntervalSeries
Creates a new empty series.
XYIntervalSeries(Comparable, boolean, boolean) - Constructor for class org.jfree.data.xy.XYIntervalSeries
Constructs a new xy-series that contains no data.
XYIntervalSeriesCollection - Class in org.jfree.data.xy
A collection of XYIntervalSeries objects.
XYIntervalSeriesCollection() - Constructor for class org.jfree.data.xy.XYIntervalSeriesCollection
Creates a new instance of XIntervalSeriesCollection.
XYItemEntity - Class in org.jfree.chart.entity
A chart entity that represents one item within an XYPlot.
XYItemEntity(Shape, XYDataset, int, int, String, String) - Constructor for class org.jfree.chart.entity.XYItemEntity
Creates a new entity.
XYItemLabelGenerator - Interface in org.jfree.chart.labels
Interface for a label generator for plots that use data from an XYDataset.
XYItemRenderer - Interface in org.jfree.chart.renderer.xy
Interface for rendering the visual representation of a single (x, y) item on an XYPlot.
XYItemRendererState - Class in org.jfree.chart.renderer.xy
The state for an XYItemRenderer.
XYItemRendererState(PlotRenderingInfo) - Constructor for class org.jfree.chart.renderer.xy.XYItemRendererState
Creates a new state.
XYLine3DRenderer - Class in org.jfree.chart.renderer.xy
A XYLineAndShapeRenderer that adds a shadow line to the graph to emulate a 3D-effect.
XYLine3DRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYLine3DRenderer
Creates a new renderer.
XYLineAndShapeRenderer - Class in org.jfree.chart.renderer.xy
A renderer that connects data points with lines and/or draws shapes at each data point.
XYLineAndShapeRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Creates a new renderer with both lines and shapes visible.
XYLineAndShapeRenderer(boolean, boolean) - Constructor for class org.jfree.chart.renderer.xy.XYLineAndShapeRenderer
Creates a new renderer.
XYLineAndShapeRenderer.State - Class in org.jfree.chart.renderer.xy
Records the state for the renderer.
XYLineAnnotation - Class in org.jfree.chart.annotations
A simple line annotation that can be placed on an XYPlot.
XYLineAnnotation(double, double, double, double) - Constructor for class org.jfree.chart.annotations.XYLineAnnotation
Creates a new annotation that draws a line from (x1, y1) to (x2, y2) where the coordinates are measured in data space (that is, against the plot's axes).
XYLineAnnotation(double, double, double, double, Stroke, Paint) - Constructor for class org.jfree.chart.annotations.XYLineAnnotation
Creates a new annotation that draws a line from (x1, y1) to (x2, y2) where the coordinates are measured in data space (that is, against the plot's axes).
XYPlot - Class in org.jfree.chart.plot
A general class for plotting data in the form of (x, y) pairs.
XYPlot() - Constructor for class org.jfree.chart.plot.XYPlot
Creates a new XYPlot instance with no dataset, no axes and no renderer.
XYPlot(XYDataset, ValueAxis, ValueAxis, XYItemRenderer) - Constructor for class org.jfree.chart.plot.XYPlot
Creates a new plot with the specified dataset, axes and renderer.
XYPointerAnnotation - Class in org.jfree.chart.annotations
An arrow and label that can be placed on an XYPlot.
XYPointerAnnotation(String, double, double, double) - Constructor for class org.jfree.chart.annotations.XYPointerAnnotation
Creates a new label and arrow annotation.
XYPolygonAnnotation - Class in org.jfree.chart.annotations
A polygon annotation that can be placed on an XYPlot.
XYPolygonAnnotation(double[]) - Constructor for class org.jfree.chart.annotations.XYPolygonAnnotation
Creates a new annotation (where, by default, the polygon is drawn with a black outline).
XYPolygonAnnotation(double[], Stroke, Paint) - Constructor for class org.jfree.chart.annotations.XYPolygonAnnotation
Creates a new annotation where the box is drawn as an outline using the specified stroke and outlinePaint.
XYPolygonAnnotation(double[], Stroke, Paint, Paint) - Constructor for class org.jfree.chart.annotations.XYPolygonAnnotation
Creates a new annotation.
XYRangeInfo - Interface in org.jfree.data.xy
An interface that can (optionally) be implemented by a dataset to assist in determining the minimum and maximum y-values.
XYSeries - Class in org.jfree.data.xy
Represents a sequence of zero or more data items in the form (x, y).
XYSeries(Comparable) - Constructor for class org.jfree.data.xy.XYSeries
Creates a new empty series.
XYSeries(Comparable, boolean) - Constructor for class org.jfree.data.xy.XYSeries
Constructs a new empty series, with the auto-sort flag set as requested, and duplicate values allowed.
XYSeries(Comparable, boolean, boolean) - Constructor for class org.jfree.data.xy.XYSeries
Constructs a new xy-series that contains no data.
XYSeriesCollection - Class in org.jfree.data.xy
Represents a collection of XYSeries objects that can be used as a dataset.
XYSeriesCollection() - Constructor for class org.jfree.data.xy.XYSeriesCollection
Constructs an empty dataset.
XYSeriesCollection(XYSeries) - Constructor for class org.jfree.data.xy.XYSeriesCollection
Constructs a dataset and populates it with a single series.
XYSeriesLabelGenerator - Interface in org.jfree.chart.labels
A generator that creates labels for the series in an XYDataset.
XYShapeAnnotation - Class in org.jfree.chart.annotations
A simple Shape annotation that can be placed on an XYPlot.
XYShapeAnnotation(Shape) - Constructor for class org.jfree.chart.annotations.XYShapeAnnotation
Creates a new annotation (where, by default, the shape is drawn with a black outline).
XYShapeAnnotation(Shape, Stroke, Paint) - Constructor for class org.jfree.chart.annotations.XYShapeAnnotation
Creates a new annotation where the shape is drawn as an outline using the specified stroke and outlinePaint.
XYShapeAnnotation(Shape, Stroke, Paint, Paint) - Constructor for class org.jfree.chart.annotations.XYShapeAnnotation
Creates a new annotation.
XYShapeRenderer - Class in org.jfree.chart.renderer.xy
A renderer that draws shapes at (x, y) coordinates and, if the dataset is an instance of XYZDataset, fills the shapes with a paint that is based on the z-value (the paint is obtained from a lookup table).
XYShapeRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYShapeRenderer
Creates a new XYShapeRenderer instance with default attributes.
XYSplineRenderer - Class in org.jfree.chart.renderer.xy
A renderer that connects data points with natural cubic splines and/or draws shapes at each data point.
XYSplineRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYSplineRenderer
Creates a new instance with the precision attribute defaulting to 5 and no fill of the area 'under' the spline.
XYSplineRenderer(int) - Constructor for class org.jfree.chart.renderer.xy.XYSplineRenderer
Creates a new renderer with the specified precision and no fill of the area 'under' (between '0' and) the spline.
XYSplineRenderer(int, XYSplineRenderer.FillType) - Constructor for class org.jfree.chart.renderer.xy.XYSplineRenderer
Creates a new renderer with the specified precision and specified fill of the area 'under' (between '0' and) the spline.
XYSplineRenderer.FillType - Enum in org.jfree.chart.renderer.xy
An enumeration of the fill types for the renderer.
XYSplineRenderer.XYSplineState - Class in org.jfree.chart.renderer.xy
Represents state information that applies to a single rendering of a chart.
XYSplineState(PlotRenderingInfo) - Constructor for class org.jfree.chart.renderer.xy.XYSplineRenderer.XYSplineState
Creates a new state instance.
XYStepAreaRenderer - Class in org.jfree.chart.renderer.xy
A step chart renderer that fills the area between the step and the x-axis.
XYStepAreaRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Constructs a new renderer.
XYStepAreaRenderer(int) - Constructor for class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Constructs a new renderer.
XYStepAreaRenderer(int, XYToolTipGenerator, XYURLGenerator) - Constructor for class org.jfree.chart.renderer.xy.XYStepAreaRenderer
Constructs a new renderer.
XYStepRenderer - Class in org.jfree.chart.renderer.xy
Line/Step item renderer for an XYPlot.
XYStepRenderer() - Constructor for class org.jfree.chart.renderer.xy.XYStepRenderer
Constructs a new renderer with no tooltip or URL generation.
XYStepRenderer(XYToolTipGenerator, XYURLGenerator) - Constructor for class org.jfree.chart.renderer.xy.XYStepRenderer
Constructs a new renderer with the specified tool tip and URL generators.
XYTaskDataset - Class in org.jfree.data.gantt
A dataset implementation that wraps a TaskSeriesCollection and presents it as an IntervalXYDataset, allowing a set of tasks to be displayed using an XYBarRenderer (and usually a SymbolAxis).
XYTaskDataset(TaskSeriesCollection) - Constructor for class org.jfree.data.gantt.XYTaskDataset
Creates a new dataset based on the supplied collection of tasks.
XYTextAnnotation - Class in org.jfree.chart.annotations
A text annotation that can be placed at a particular (x, y) location on an XYPlot.
XYTextAnnotation(String, double, double) - Constructor for class org.jfree.chart.annotations.XYTextAnnotation
Creates a new annotation to be displayed at the given coordinates.
XYtitle - Static variable in class jminhep.gui.SetEnv
 
XYTitleAnnotation - Class in org.jfree.chart.annotations
An annotation that allows any Title to be placed at a location on an XYPlot.
XYTitleAnnotation(double, double, Title) - Constructor for class org.jfree.chart.annotations.XYTitleAnnotation
Creates a new annotation to be displayed at the specified (x, y) location.
XYTitleAnnotation(double, double, Title, RectangleAnchor) - Constructor for class org.jfree.chart.annotations.XYTitleAnnotation
Creates a new annotation to be displayed at the specified (x, y) location.
XYToolTipGenerator - Interface in org.jfree.chart.labels
Interface for a tooltip generator for plots that use data from an XYDataset.
XYURLGenerator - Interface in org.jfree.chart.urls
Interface for a URL generator for plots that uses data from an XYDataset.
XYX - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.
XYZ - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.
XYZDataset - Interface in org.jfree.data.xy
The interface through which JFreeChart obtains data in the form of (x, y, z) items - used for XY and XYZ plots.
XYZToolTipGenerator - Interface in org.jfree.chart.labels
Interface for a tooltip generator for plots that use data from an XYZDataset.
XYZURLGenerator - Interface in org.jfree.chart.urls
Interface for a URL generator for plots that uses data from an XYZDataset.
XZX - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.
XZY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.

Y

y() - Method in class hep.physics.vec.BasicHep3Vector
 
y() - Method in interface hep.physics.vec.Hep3Vector
 
y() - Method in class hep.physics.vec.SpacePoint
Cartesian y
y() - Method in class hephysics.vec.Hep3Vector
 
y() - Method in class hephysics.vec.HepLorentzVector
Get Y
y() - Method in class hephysics.vec.SpacePoint
Cartesian y
y() - Method in class j4np.physics.Vector3
 
y - Variable in class jplot3d.SurfaceVertex
The y coordinate
Y - Static variable in class org.jlab.groot.base.AxisAttributes
 
y0(double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the second kind of order 0 of the argument.
y0(double) - Static method in class graph.SpecialFunction
 
y1(double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the second kind of order 1 of the argument.
y1(double) - Static method in class graph.SpecialFunction
 
Y_AXIS - Static variable in class jplot.Axis
 
Y_AXIS - Static variable in class jplot.GraphSettings
Symbolic constant used to name the (left) Y-axis of the graph.
Y_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
Y_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P1D
 
Y_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PXY
 
Y_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PXYZ
 
Y_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
Y_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
Y_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
Y_MAX_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
Y_MIN_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
yAxis() - Method in interface colt.hep.aida.IHistogram2D
Return the Y axis.
yAxis() - Method in interface colt.hep.aida.IHistogram3D
Return the Y axis.
yaxis - Variable in class graph.DataSet
The Axis object the Y data is attached to.
YEAR - Static variable in class org.jfree.chart.axis.DateTickUnit
Deprecated.
As of version 1.0.13, use DateTickUnitType instead.
YEAR - Static variable in class org.jfree.chart.axis.DateTickUnitType
Year.
Year - Class in org.jfree.data.time
Represents a year in the range -9999 to 9999.
Year() - Constructor for class org.jfree.data.time.Year
Creates a new Year, based on the current system date/time.
Year(int) - Constructor for class org.jfree.data.time.Year
Creates a time period representing a single year.
Year(Date) - Constructor for class org.jfree.data.time.Year
Creates a new Year, based on a particular instant in time, using the default time zone.
Year(Date, TimeZone) - Constructor for class org.jfree.data.time.Year
Deprecated.
Since 1.0.12, use Year.Year(Date, TimeZone, Locale) instead.
Year(Date, TimeZone, Locale) - Constructor for class org.jfree.data.time.Year
Creates a new Year instance, for the specified time zone and locale.
YInterval - Class in org.jfree.data.xy
A y-interval.
YInterval(double, double, double) - Constructor for class org.jfree.data.xy.YInterval
Creates a new instance of YInterval.
YIntervalDataItem - Class in org.jfree.data.xy
An item representing data in the form (x, y, y-low, y-high).
YIntervalDataItem(double, double, double, double) - Constructor for class org.jfree.data.xy.YIntervalDataItem
Creates a new instance of YIntervalItem.
YIntervalRenderer - Class in org.jfree.chart.renderer.xy
A renderer that draws a line connecting the start and end Y values for an XYPlot.
YIntervalRenderer() - Constructor for class org.jfree.chart.renderer.xy.YIntervalRenderer
The default constructor.
YIntervalSeries - Class in org.jfree.data.xy
A list of (x, y, y-low, y-high) data items.
YIntervalSeries(Comparable) - Constructor for class org.jfree.data.xy.YIntervalSeries
Creates a new empty series.
YIntervalSeries(Comparable, boolean, boolean) - Constructor for class org.jfree.data.xy.YIntervalSeries
Constructs a new xy-series that contains no data.
YIntervalSeriesCollection - Class in org.jfree.data.xy
A collection of YIntervalSeries objects.
YIntervalSeriesCollection() - Constructor for class org.jfree.data.xy.YIntervalSeriesCollection
Creates a new instance of YIntervalSeriesCollection.
YisSymbolic - Interface in org.jfree.data.xy
Represent a data set where Y is a symbolic values.
YLABEL - Static variable in class jplot.GraphLabel
 
YLOWER_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P1D
 
ymax - Variable in class graph.DataSet
The current plottable Y maximum of the data.
ymax - Variable in class jplot3d.JSurface
 
ymin - Variable in class graph.DataSet
The current plottable Y minimum of the data.
ymin - Variable in class jplot3d.JSurface
 
ymin() - Method in class org.freehep.math.minuit.ContoursError
 
yMinosError() - Method in class org.freehep.math.minuit.ContoursError
 
yn(int, double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the second kind of order n of the argument.
yn(int, double) - Static method in class graph.SpecialFunction
 
YOUTER_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
ypar() - Method in class org.freehep.math.minuit.ContoursError
 
Ypos - Static variable in class jhplot.JHPlot
 
yRange() - Method in class org.freehep.math.minuit.ContoursError
 
YSYSLOWER_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P1D
 
YSYSUPPER_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P1D
 
YUPPER_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.P1D
 
YWithXInterval - Class in org.jfree.data.xy
A y-value plus the bounds for the related x-interval.
YWithXInterval(double, double, double) - Constructor for class org.jfree.data.xy.YWithXInterval
Creates a new instance of YWithXInterval.
YXY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.
YXZ - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.
YZX - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.
YZY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.

Z

z() - Method in class hep.physics.vec.BasicHep3Vector
 
z() - Method in interface hep.physics.vec.Hep3Vector
 
z() - Method in class hep.physics.vec.SpacePoint
Cartesian z
z() - Method in class hephysics.vec.Hep3Vector
 
z() - Method in class hephysics.vec.HepLorentzVector
Get Z position or Pz
z() - Method in class hephysics.vec.SpacePoint
Cartesian z
z() - Method in class j4np.physics.Vector3
 
Z - Class in Jampack
Z is a mutable complex variable class.
Z() - Constructor for class Jampack.Z
Creates a Z and initializes it to zero.
Z(double, double) - Constructor for class Jampack.Z
Creates a Z and initializes its real and imaginary parts.
Z(double) - Constructor for class Jampack.Z
Creates a Z and initializes its real part.
Z(Z) - Constructor for class Jampack.Z
Creates a Z and initializes it to another Z.
z - Variable in class jplot3d.SurfaceVertex
The z coordinate
Z - Static variable in class org.jlab.groot.base.AxisAttributes
 
Z1 - Class in Jampack
Z1 implements a one-dimensional array of complex numbers as a two arrays of type double.
Z1(int) - Constructor for class Jampack.Z1
Creates a Z1 initializes to zero.
Z_FIELD_NUMBER - Static variable in class proeic.io.ProMC.ProMCEvent.Particles
 
Z_FIELD_NUMBER - Static variable in class promc.io.PBufFile.Record.PXYZ
 
Z_FIELD_NUMBER - Static variable in class promc.io.ProMC.ProMCEvent.Particles
 
Z_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Particles
 
Z_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
Z_MAX_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
Z_MIN_PROPERTY - Variable in class jplot3d.SurfaceModelCanvas
 
zAssign27Neighbors(DoubleMatrix3D, Double27Function) - Method in class cern.colt.matrix.DoubleMatrix3D
27 neighbor stencil transformation.
zAssign27Neighbors(DoubleMatrix3D, Double27Function) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
27 neighbor stencil transformation.
zAssign8Neighbors(DoubleMatrix2D, Double9Function) - Method in class cern.colt.matrix.DoubleMatrix2D
8 neighbor stencil transformation.
zAssign8Neighbors(DoubleMatrix2D, Double9Function) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
8 neighbor stencil transformation.
zAxis() - Method in interface colt.hep.aida.IHistogram3D
Return the Z axis.
Zchol - Class in Jampack
Zchol implements the Cholesky decomposition of a positive definite matrix.
Zchol(Zmat) - Constructor for class Jampack.Zchol
Constructs a Zchol from a Zmat A.
zdemo1() - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates advanced sorting.
zdemo2() - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates advanced sorting.
zdemo3() - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates advanced sorting.
zdemo5(int, int, boolean) - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates sorting with precomputation of aggregates (median and sum of logarithms).
zdemo6() - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates advanced sorting.
zdemo7(int, int, boolean) - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates sorting with precomputation of aggregates, comparing mergesort with quicksort.
Zdiagmat - Class in Jampack
Zdiagmat is a storage efficient representation of a complex diagonal matrix.
Zdiagmat(int) - Constructor for class Jampack.Zdiagmat
Constructs a Zdiagmat and initializes it to zero.
Zdiagmat(int, Z) - Constructor for class Jampack.Zdiagmat
Constructs a Zdiagmat and initializes it to a constant.
Zdiagmat(Z1) - Constructor for class Jampack.Zdiagmat
Constructs a Zdiagmat and initializes it to a Z1.
Zdiagmat(Zmat, int) - Constructor for class Jampack.Zdiagmat
Constructs a Zdiagmat and initializes it to the diagonal of a Zmat.
Zdiagmat(Zmat) - Constructor for class Jampack.Zdiagmat
Constructs a Zdiagmat and initializes it to the principal diagonal of a Zmat.
Zdiagmat(Zdiagmat) - Constructor for class Jampack.Zdiagmat
Constructs a Zdiagmat and initializes it to another Zdiagmat.
zDotProduct(DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(DoubleMatrix1D, int, int) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(DoubleMatrix1D, int, int, IntArrayList) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(DoubleMatrix1D, int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
ZERO - Static variable in class cern.colt.matrix.linalg.Algebra
A default Algebra object; has Property.ZERO attached for tolerance.
ZERO - Static variable in class cern.colt.matrix.linalg.Property
A Property object with tolerance()==0.0.
ZERO - Static variable in class Jampack.Z
Complex 0.
zero() - Method in class jhplot.math.ValueErr
Set value to zero
ZERO - Static variable in class org.apache.commons.math3.complex.Complex
A complex number representing "0.0 + 0.0i"
ZERO - Static variable in class org.apache.commons.math3.complex.Quaternion
Zero quaternion.
ZERO - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "0".
ZERO - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "0".
ZERO - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Origin (coordinates: 0).
ZERO - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Null vector (coordinates: 0, 0, 0).
ZERO - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Origin (coordinates: 0, 0).
ZERO - Static variable in class org.apache.commons.math3.util.BigReal
A big real representing 0.
ZERO - Static variable in class org.apache.commons.math3.util.Decimal64
The constant value of 0d as a Decimal64.
ZERO - Static variable in class org.jfree.chart.plot.Plot
Useful constant representing zero.
ZERO - Static variable in class org.jfree.chart.renderer.AbstractRenderer
Zero represented as a Double.
ZERO - Static variable in class org.nfunk.jep.type.DoubleNumberFactory
 
zeroAll() - Method in class org.jfree.data.xy.MatrixSeries
Sets all matrix values to zero and sends a SeriesChangeEvent to all registered listeners.
zeroAll() - Method in class org.jfree.data.xy.NormalizedMatrixSeries
 
zerocolor - Variable in class graph.Axis
Color of the line at the Zero label
zerocolor - Variable in class graph.Graph2D
The color of the zero grid lines.
ZeroException - Exception in org.apache.commons.math3.exception
Exception to be thrown when zero is provided where it is not allowed.
ZeroException() - Constructor for exception org.apache.commons.math3.exception.ZeroException
Construct the exception.
ZeroException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.ZeroException
Construct the exception with a specific context.
zeromean(double[]) - Static method in class jhplot.stat.StatUtils
Zero the mean of all elements of v.
ZeroRemover(String[]) - Static method in class jplot3d.NumUtil
 
Zeta - Class in cern.jet.random
Zeta distribution.
Zeta(double, double, RandomEngine) - Constructor for class cern.jet.random.Zeta
Constructs a Zeta distribution.
Zhess - Class in Jampack
Zhess implements the unitary reduction to Hessenberg form by a unitary similarity transformation.
Zhess(Zmat) - Constructor for class Jampack.Zhess
Creates a Zhess from a square Zmat.
Zhqrd - Class in Jampack
Computes a Householder QR decomposition.Specifically, given a matrix A there are is a unitary matrix U such that
Zhqrd(Zmat) - Constructor for class Jampack.Zhqrd
Computes a Householder QR decomposition of a Zmat
zi - Variable in class Jampack.Rot
The imaginary part of the first component of the transformed vector
ZipfDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Zipf distribution.
ZipfDistribution(int, double) - Constructor for class org.apache.commons.math3.distribution.ZipfDistribution
Create a new Zipf distribution with the given number of elements and exponent.
ZipfDistribution(RandomGenerator, int, double) - Constructor for class org.apache.commons.math3.distribution.ZipfDistribution
Creates a Zipf distribution.
Zltmat - Class in Jampack
Zltmat is a tag class of Zmat, which tells Jampack to expect a lower triangular matrix.
Zltmat(double[][], double[][]) - Constructor for class Jampack.Zltmat
 
Zltmat(Z[][]) - Constructor for class Jampack.Zltmat
 
Zltmat(double[][]) - Constructor for class Jampack.Zltmat
 
Zltmat(Zmat) - Constructor for class Jampack.Zltmat
 
Zltmat(int, int) - Constructor for class Jampack.Zltmat
 
Zludpp - Class in Jampack
Zludpp implements the LU decomposition with partial pivoting.
Zludpp(Zmat) - Constructor for class Jampack.Zludpp
Computes the partially pivoted LU decompostion.
Zmat - Class in Jampack
Zmat implements general complex matrix stored in a rectangular array class Z.
Zmat(double[][], double[][]) - Constructor for class Jampack.Zmat
Creates a Zmat and initializes its real and imaginary parts to a pair of arrays.
Zmat(Z[][]) - Constructor for class Jampack.Zmat
Creates a Zmat and initializes it to an array of class Z.
Zmat(double[][]) - Constructor for class Jampack.Zmat
Creates a Zmat and initializes its real part to to an array of class double.
Zmat(Zmat) - Constructor for class Jampack.Zmat
Creates a Zmat and intitializes it to a Zmat.
Zmat(Z1) - Constructor for class Jampack.Zmat
Creates a Zmat and initialize it to a Z1.
Zmat(Zdiagmat) - Constructor for class Jampack.Zmat
Creates a Zmat and initialize it to a Zdiagmat.
Zmat(int, int) - Constructor for class Jampack.Zmat
Creates a Zmat and initializes it to zero.
zmax - Variable in class jplot3d.JSurface
 
zmin - Variable in class jplot3d.JSurface
 
zMult(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleMatrix2D
Linear algebraic matrix-vector multiplication; z = A * y; Equivalent to return A.zMult(y,z,1,0);
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.DoubleMatrix2D
Linear algebraic matrix-vector multiplication; z = alpha * A * y + beta*z.
zMult(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleMatrix2D
Linear algebraic matrix-matrix multiplication; C = A x B; Equivalent to A.zMult(B,C,1,0,false,false).
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.DoubleMatrix2D
Linear algebraic matrix-matrix multiplication; C = alpha * A x B + beta*C.
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
 
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
 
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
 
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
 
Zn - Class in org.lsmp.djep.groupJep.groups
The group of integers mod n.
Zn(BigInteger) - Constructor for class org.lsmp.djep.groupJep.groups.Zn
 
zoom(Rectangle2D) - Method in class org.jfree.chart.ChartPanel
Zooms in on a selected region.
zoom(double) - Method in class org.jfree.chart.plot.CategoryPlot
Zooms (in or out) on the plot's value axis.
zoom(double) - Method in class org.jfree.chart.plot.CompassPlot
No zooming is implemented for compass plot, so this method is empty.
zoom(double) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Zooms the axis ranges by the specified percentage about the anchor point.
zoom(double) - Method in class org.jfree.chart.plot.MeterPlot
A zoom method that does nothing.
zoom(double) - Method in class org.jfree.chart.plot.Plot
Performs a zoom on the plot.
zoom(double) - Method in class org.jfree.chart.plot.PolarPlot
Zooms the axis ranges by the specified percentage about the anchor point.
zoom(double) - Method in class org.jfree.chart.plot.ThermometerPlot
A zoom method that does nothing.
ZOOM_IN_BOTH_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Zoom in (both axes) action command.
ZOOM_IN_DOMAIN_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Zoom in (domain axis only) action command.
ZOOM_IN_RANGE_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Zoom in (range axis only) action command.
ZOOM_OUT_BOTH_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Zoom out (both axes) action command.
ZOOM_OUT_DOMAIN_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Zoom out (domain axis only) action command.
ZOOM_OUT_RANGE_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Zoom out (range axis only) action command.
ZOOM_RESET_BOTH_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Zoom reset (both axes) action command.
ZOOM_RESET_DOMAIN_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Zoom reset (domain axis only) action command.
ZOOM_RESET_RANGE_COMMAND - Static variable in class org.jfree.chart.ChartPanel
Zoom reset (range axis only) action command.
Zoomable - Interface in org.jfree.chart.plot
A plot that is zoomable must implement this interface to provide a mechanism for the ChartPanel to control the zooming.
zoomDomainAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CategoryPlot
This method does nothing, because CategoryPlot doesn't support zooming on the domain.
zoomDomainAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CategoryPlot
This method does nothing, because CategoryPlot doesn't support zooming on the domain.
zoomDomainAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
This method does nothing, because CategoryPlot doesn't support zooming on the domain.
zoomDomainAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Multiplies the range on the domain axis/axes by the specified factor.
zoomDomainAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Multiplies the range on the domain axis/axes by the specified factor.
zoomDomainAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CombinedRangeXYPlot
Zooms in on the domain axes.
zoomDomainAxes(double, double, double) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Multiplies the range on the domain axis/axes by the specified factor (to be implemented).
zoomDomainAxes(double, double, double, double) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Zooms the domain axes (not yet implemented).
zoomDomainAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.FastScatterPlot
Multiplies the range on the domain axis by the specified factor.
zoomDomainAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.FastScatterPlot
Multiplies the range on the domain axis by the specified factor.
zoomDomainAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.FastScatterPlot
Zooms in on the domain axes.
zoomDomainAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.PolarPlot
This method is required by the Zoomable interface, but since the plot does not have any domain axes, it does nothing.
zoomDomainAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.PolarPlot
This method is required by the Zoomable interface, but since the plot does not have any domain axes, it does nothing.
zoomDomainAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.PolarPlot
This method is required by the Zoomable interface, but since the plot does not have any domain axes, it does nothing.
zoomDomainAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.ThermometerPlot
Multiplies the range on the domain axis/axes by the specified factor.
zoomDomainAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.ThermometerPlot
Multiplies the range on the domain axis/axes by the specified factor.
zoomDomainAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.ThermometerPlot
This method does nothing.
zoomDomainAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.XYPlot
Multiplies the range on the domain axis/axes by the specified factor.
zoomDomainAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.XYPlot
Multiplies the range on the domain axis/axes by the specified factor.
zoomDomainAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.XYPlot
Zooms in on the domain axis/axes.
zoomDomainAxes(double, PlotRenderingInfo, Point2D) - Method in interface org.jfree.chart.plot.Zoomable
Multiplies the range on the domain axis/axes by the specified factor.
zoomDomainAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in interface org.jfree.chart.plot.Zoomable
Multiplies the range on the domain axis/axes by the specified factor.
zoomDomainAxes(double, double, PlotRenderingInfo, Point2D) - Method in interface org.jfree.chart.plot.Zoomable
Zooms in on the domain axes.
ZoomHandlerFX - Class in org.jfree.chart.fx.interaction
Handles drag zooming of charts on a ChartCanvas.
ZoomHandlerFX(String, ChartViewer) - Constructor for class org.jfree.chart.fx.interaction.ZoomHandlerFX
Creates a new instance with no modifier keys required.
ZoomHandlerFX(String, ChartViewer, boolean, boolean, boolean, boolean) - Constructor for class org.jfree.chart.fx.interaction.ZoomHandlerFX
Creates a new instance that will be activated using the specified combination of modifier keys.
zoomInBoth(double, double) - Method in class org.jfree.chart.ChartPanel
Zooms in on an anchor point (specified in screen coordinate space).
zoomInDomain(double, double) - Method in class org.jfree.chart.ChartPanel
Decreases the length of the domain axis, centered about the given coordinate on the screen.
zoomInRange(double, double) - Method in class org.jfree.chart.ChartPanel
Decreases the length of the range axis, centered about the given coordinate on the screen.
zoomOutBoth(double, double) - Method in class org.jfree.chart.ChartPanel
Zooms out on an anchor point (specified in screen coordinate space).
zoomOutDomain(double, double) - Method in class org.jfree.chart.ChartPanel
Increases the length of the domain axis, centered about the given coordinate on the screen.
zoomOutRange(double, double) - Method in class org.jfree.chart.ChartPanel
Increases the length the range axis, centered about the given coordinate on the screen.
zoomRange(double, double) - Method in class org.jfree.chart.axis.DateAxis
Zooms in on the current range (zoom-in stops once the axis length reaches the equivalent of one millisecond).
zoomRange(double, double) - Method in class org.jfree.chart.axis.LogarithmicAxis
Zooms in on the current range.
zoomRange(double, double) - Method in class org.jfree.chart.axis.LogAxis
Zooms in on the current range.
zoomRange(double, double) - Method in class org.jfree.chart.axis.ValueAxis
Zooms in on the current range.
zoomRangeAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CategoryPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.CategoryPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CategoryPlot
Zooms in on the range axes.
zoomRangeAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CombinedDomainCategoryPlot
Zooms in on the range axes.
zoomRangeAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.CombinedDomainXYPlot
Zooms in on the range axes.
zoomRangeAxes(double, double, double) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, double, double, double) - Method in class org.jfree.chart.plot.ContourPlot
Deprecated.
Zooms the range axes (not yet implemented).
zoomRangeAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.FastScatterPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.FastScatterPlot
Multiplies the range on the range axis by the specified factor.
zoomRangeAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.FastScatterPlot
Zooms in on the range axes.
zoomRangeAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.PolarPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.PolarPlot
Multiplies the range on the range axis by the specified factor.
zoomRangeAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.PolarPlot
Zooms in on the range axes.
zoomRangeAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.ThermometerPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.ThermometerPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.ThermometerPlot
Zooms the range axes.
zoomRangeAxes(double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.XYPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in class org.jfree.chart.plot.XYPlot
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, double, PlotRenderingInfo, Point2D) - Method in class org.jfree.chart.plot.XYPlot
Zooms in on the range axes.
zoomRangeAxes(double, PlotRenderingInfo, Point2D) - Method in interface org.jfree.chart.plot.Zoomable
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, PlotRenderingInfo, Point2D, boolean) - Method in interface org.jfree.chart.plot.Zoomable
Multiplies the range on the range axis/axes by the specified factor.
zoomRangeAxes(double, double, PlotRenderingInfo, Point2D) - Method in interface org.jfree.chart.plot.Zoomable
Zooms in on the range axes.
ZOUTER_FIELD_NUMBER - Static variable in class proreco.io.ProMC.ProMCEvent.Tracks
 
Zpsdmat - Class in Jampack
Zpsdmat is a tag class of Zmat, which tells Jampack to expect a (Hermitian) positive semidefinite matrix.
Zpsdmat(double[][], double[][]) - Constructor for class Jampack.Zpsdmat
 
Zpsdmat(Z[][]) - Constructor for class Jampack.Zpsdmat
 
Zpsdmat(double[][]) - Constructor for class Jampack.Zpsdmat
 
Zpsdmat(Zmat) - Constructor for class Jampack.Zpsdmat
 
Zpsdmat(int, int) - Constructor for class Jampack.Zpsdmat
 
Zqrd - Class in Jampack
Implements a QR decomposition.
Zqrd(Zmat) - Constructor for class Jampack.Zqrd
Constructs a Zqrd from a Zmat.
zr - Variable in class Jampack.Rot
The real part of the first component of the transformed vector
Zspec - Class in Jampack
Zspec implements the spectral (eigenvalue-eigenvector) decomposition of a Hermitian matrix.
Zspec(Zmat) - Constructor for class Jampack.Zspec
Creates a Zspec from Zmat.
zSum() - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the sum of all cells; Sum( x[i] ).
zSum() - Method in class cern.colt.matrix.DoubleMatrix2D
Returns the sum of all cells; Sum( x[i,j] ).
zSum() - Method in class cern.colt.matrix.DoubleMatrix3D
Returns the sum of all cells; Sum( x[i,j,k] ).
zSum() - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Returns the sum of all cells; Sum( x[i] ).
zSum() - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Returns the sum of all cells; Sum( x[i,j] ).
Zsvd - Class in Jampack
Zsvd implements the singular value decomposion of a Zmat.
Zsvd(Zmat) - Constructor for class Jampack.Zsvd
Computes the SVD of a Zmat XX.
ZtoEstring(Z, int, int) - Static method in class Jampack.Print
Converts a Z to w.d e format.
Zutmat - Class in Jampack
Zutmat is a tag class of Zmat, which tells Jampack to expect an upper triangular matrix.
Zutmat(double[][], double[][]) - Constructor for class Jampack.Zutmat
 
Zutmat(Z[][]) - Constructor for class Jampack.Zutmat
 
Zutmat(double[][]) - Constructor for class Jampack.Zutmat
 
Zutmat(Zmat) - Constructor for class Jampack.Zutmat
 
Zutmat(int, int) - Constructor for class Jampack.Zutmat
 
ZXY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.
ZXZ - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.
ZYX - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.
ZYZ - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.
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 

Jas4pp 1.5 © Java Analysis Studio for Particle Physics