Uses of Class
de.lmu.ifi.dbs.elki.utilities.optionhandling.OptionID

Packages that use OptionID
de.lmu.ifi.dbs.elki.algorithm Algorithms suitable as a task for the KDDTask main routine. 
de.lmu.ifi.dbs.elki.algorithm.clustering Clustering algorithms Clustering algorithms are supposed to implement the Algorithm-Interface. 
de.lmu.ifi.dbs.elki.algorithm.clustering.correlation Correlation clustering algorithms 
de.lmu.ifi.dbs.elki.algorithm.clustering.subspace Axis-parallel subspace clustering algorithms The clustering algorithms in this package are instances of both, projected clustering algorithms or subspace clustering algorithms according to the classical but somewhat obsolete classification schema of clustering algorithms for axis-parallel subspaces. 
de.lmu.ifi.dbs.elki.algorithm.clustering.trivial Trivial clustering algorithms: all in one, no clusters, label clusterings These methods are mostly useful for providing a reference result in evaluation. 
de.lmu.ifi.dbs.elki.algorithm.outlier Outlier detection algorithms 
de.lmu.ifi.dbs.elki.algorithm.outlier.meta Meta outlier detection algorithms: external scores, score rescaling. 
de.lmu.ifi.dbs.elki.algorithm.outlier.spatial Spatial outlier detection algorithms 
de.lmu.ifi.dbs.elki.algorithm.outlier.spatial.neighborhood Spatial outlier neighborhood classes 
de.lmu.ifi.dbs.elki.algorithm.outlier.spatial.neighborhood.weighted Weighted Neighborhood definitions. 
de.lmu.ifi.dbs.elki.algorithm.outlier.trivial Trivial outlier detection algorithms: no outliers, all outliers, label outliers. 
de.lmu.ifi.dbs.elki.algorithm.statistics Statistical analysis algorithms The algorithms in this package perform statistical analysis of the data (e.g. compute distributions, distance distributions etc.) 
de.lmu.ifi.dbs.elki.application Base classes for stand alone applications. 
de.lmu.ifi.dbs.elki.application.cache Utility applications for the persistence layer such as distance cache builders. 
de.lmu.ifi.dbs.elki.application.internal Internal utilities for development. 
de.lmu.ifi.dbs.elki.application.jsmap JavaScript based map client - server architecture. 
de.lmu.ifi.dbs.elki.application.visualization Visualization applications in ELKI. 
de.lmu.ifi.dbs.elki.data.images Package for processing image data (e.g. compute color histograms) 
de.lmu.ifi.dbs.elki.database ELKI database layer - loading, storing, indexing and accessing data 
de.lmu.ifi.dbs.elki.datasource Data normalization (and reconstitution) of data sets. 
de.lmu.ifi.dbs.elki.datasource.filter Data filtering, in particular for normalization and projection. 
de.lmu.ifi.dbs.elki.datasource.parser Parsers for different file formats and data types. 
de.lmu.ifi.dbs.elki.distance.distancefunction Distance functions for use within ELKI. 
de.lmu.ifi.dbs.elki.distance.distancefunction.adapter Distance functions deriving distances from e.g. similarity measures 
de.lmu.ifi.dbs.elki.distance.distancefunction.colorhistogram Distance functions using correlations. 
de.lmu.ifi.dbs.elki.distance.distancefunction.correlation Distance functions using correlations. 
de.lmu.ifi.dbs.elki.distance.distancefunction.external Distance functions using external data sources. 
de.lmu.ifi.dbs.elki.distance.distancefunction.geo Geographic (earth) distance functions. 
de.lmu.ifi.dbs.elki.distance.distancefunction.subspace Distance functions based on subspaces. 
de.lmu.ifi.dbs.elki.distance.distancefunction.timeseries Distance functions designed for time series. 
de.lmu.ifi.dbs.elki.distance.similarityfunction Similarity functions. 
de.lmu.ifi.dbs.elki.distance.similarityfunction.kernel Kernel functions. 
de.lmu.ifi.dbs.elki.evaluation.histogram Functionality for the evaluation of algorithms using histograms. 
de.lmu.ifi.dbs.elki.evaluation.outlier Evaluate an outlier score using a misclassification based cost model. 
de.lmu.ifi.dbs.elki.evaluation.paircounting Evaluation of clustering results via pair counting. 
de.lmu.ifi.dbs.elki.evaluation.roc Evaluation of rankings using ROC AUC (Receiver Operation Characteristics - Area Under Curve) 
de.lmu.ifi.dbs.elki.evaluation.similaritymatrix Render a distance matrix to visualize a clustering-distance-combination. 
de.lmu.ifi.dbs.elki.gui.util Utility classes for GUIs (e.g. a class to display a logging panel) 
de.lmu.ifi.dbs.elki.index.preprocessed.knn Indexes providing KNN and rKNN data. 
de.lmu.ifi.dbs.elki.index.preprocessed.localpca Index using a preprocessed local PCA. 
de.lmu.ifi.dbs.elki.index.preprocessed.preference Indexes storing preference vectors. 
de.lmu.ifi.dbs.elki.index.preprocessed.snn Indexes providing nearest neighbor sets 
de.lmu.ifi.dbs.elki.index.preprocessed.subspaceproj Index using a preprocessed local subspaces. 
de.lmu.ifi.dbs.elki.index.tree Tree-based index structures 
de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants M-Tree and variants. 
de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants.mktrees Metrical index structures based on the concepts of the M-Tree supporting processing of reverse k nearest neighbor queries by using the k-nn distances of the entries. 
de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants.mktrees.mkapp MkAppTree 
de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants.mktrees.mkcop MkCoPTree 
de.lmu.ifi.dbs.elki.index.tree.spatial.rstarvariants R*-Tree and variants. 
de.lmu.ifi.dbs.elki.index.tree.spatial.rstarvariants.util Utilities for R*-Tree and variants. 
de.lmu.ifi.dbs.elki.math.linearalgebra.pca Principal Component Analysis (PCA) and Eigenvector processing. 
de.lmu.ifi.dbs.elki.result Result types, representation and handling 
de.lmu.ifi.dbs.elki.utilities.optionhandling Parameter handling and option descriptions. 
de.lmu.ifi.dbs.elki.utilities.optionhandling.parameterization Configuration managers See the de.lmu.ifi.dbs.elki.utilities.optionhandling package for documentation! 
de.lmu.ifi.dbs.elki.utilities.optionhandling.parameters Classes for various typed parameters. 
de.lmu.ifi.dbs.elki.utilities.referencepoints Package containing strategies to obtain reference points Shared code for various algorithms that use reference points. 
de.lmu.ifi.dbs.elki.utilities.scaling Scaling functions: linear, logarithmic, gamma, clipping, ... 
de.lmu.ifi.dbs.elki.utilities.scaling.outlier Scaling of Outlier scores, that require a statistical analysis of the occurring values 
de.lmu.ifi.dbs.elki.visualization Visualization package of ELKI. 
de.lmu.ifi.dbs.elki.visualization.gui Package to provide a visualization GUI. 
de.lmu.ifi.dbs.elki.visualization.projector Projectors are responsible for finding appropriate projections for data relations. 
de.lmu.ifi.dbs.elki.visualization.visualizers.vis1d Visualizers based on 1D projections. 
de.lmu.ifi.dbs.elki.visualization.visualizers.vis2d Visualizers based on 2D projections. 
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm
 

Fields in de.lmu.ifi.dbs.elki.algorithm declared as OptionID
static OptionID DependencyDerivator.DEPENDENCY_DERIVATOR_RANDOM_SAMPLE
          Flag to use random sample (use knn query around centroid, if flag is not set).
static OptionID AbstractDistanceBasedAlgorithm.DISTANCE_FUNCTION_ID
          OptionID for AbstractDistanceBasedAlgorithm.DISTANCE_FUNCTION_ID
static OptionID KNNJoin.K_ID
          Parameter that specifies the k-nearest neighbors to be assigned, must be an integer greater than 0.
static OptionID KNNDistanceOrder.K_ID
          Parameter to specify the distance of the k-distant object to be assessed, must be an integer greater than 0.
static OptionID APRIORI.MINFREQ_ID
          Optional parameter to specify the threshold for minimum frequency, must be a double greater than or equal to 0 and less than or equal to 1.
static OptionID APRIORI.MINSUPP_ID
          Parameter to specify the threshold for minimum support as minimally required number of transactions, must be an integer equal to or greater than 0.
static OptionID DependencyDerivator.OUTPUT_ACCURACY_ID
          Parameter to specify the threshold for output accuracy fraction digits, must be an integer equal to or greater than 0.
static OptionID KNNDistanceOrder.PERCENTAGE_ID
          Parameter to specify the average percentage of distances randomly chosen to be provided in the result, must be a double greater than 0 and less than or equal to 1.
static OptionID DependencyDerivator.SAMPLE_SIZE_ID
          Optional parameter to specify the treshold for the size of the random sample to use, must be an integer greater than 0.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm.clustering
 

Fields in de.lmu.ifi.dbs.elki.algorithm.clustering declared as OptionID
static OptionID EM.DELTA_ID
          Parameter to specify the termination criterion for maximization of E(M): E(M) - E(M') < em.delta, must be a double equal to or greater than 0.
static OptionID OPTICS.EPSILON_ID
          Parameter to specify the maximum radius of the neighborhood to be considered, must be suitable to the distance function specified.
static OptionID SNNClustering.EPSILON_ID
          Parameter to specify the minimum SNN density, must be an integer greater than 0.
static OptionID DBSCAN.EPSILON_ID
          Parameter to specify the maximum radius of the neighborhood to be considered, must be suitable to the distance function specified.
static OptionID AbstractProjectedDBSCAN.EPSILON_ID
          Parameter to specify the maximum radius of the neighborhood to be considered, must be suitable to LocallyWeightedDistanceFunction.
static OptionID AbstractProjectedDBSCAN.INNER_DISTANCE_FUNCTION_ID
          Parameter distance function
static OptionID AbstractProjectedClustering.K_I_ID
          Parameter to specify the multiplier for the initial number of seeds, must be an integer greater than 0.
static OptionID KMeans.K_ID
          Parameter to specify the number of clusters to find, must be an integer greater than 0.
static OptionID AbstractProjectedClustering.K_ID
          Parameter to specify the number of clusters to find, must be an integer greater than 0.
static OptionID EM.K_ID
          Parameter to specify the number of clusters to find, must be an integer greater than 0.
static OptionID AbstractProjectedClustering.L_ID
          Parameter to specify the dimensionality of the clusters to find, must be an integer greater than 0.
static OptionID AbstractProjectedDBSCAN.LAMBDA_ID
          Parameter to specify the intrinsic dimensionality of the clusters to find, must be an integer greater than 0.
static OptionID KMeans.MAXITER_ID
          Parameter to specify the number of clusters to find, must be an integer greater or equal to 0, where 0 means no limit.
static OptionID OPTICS.MINPTS_ID
          Parameter to specify the threshold for minimum number of points in the epsilon-neighborhood of a point, must be an integer greater than 0.
static OptionID SNNClustering.MINPTS_ID
          Parameter to specify the threshold for minimum number of points in the epsilon-SNN-neighborhood of a point, must be an integer greater than 0.
static OptionID DeLiClu.MINPTS_ID
          Parameter to specify the threshold for minimum number of points within a cluster, must be an integer greater than 0.
static OptionID DBSCAN.MINPTS_ID
          Parameter to specify the threshold for minimum number of points in the epsilon-neighborhood of a point, must be an integer greater than 0.
static OptionID AbstractProjectedDBSCAN.MINPTS_ID
          Parameter to specify the threshold for minimum number of points in the epsilon-neighborhood of a point, must be an integer greater than 0.
static OptionID AbstractProjectedDBSCAN.OUTER_DISTANCE_FUNCTION_ID
          Parameter to specify the distance function to determine the distance between database objects, must extend LocallyWeightedDistanceFunction .
static OptionID KMeans.SEED_ID
          Parameter to specify the random generator seed.
static OptionID EM.SEED_ID
          Parameter to specify the random generator seed.
static OptionID SLINK.SLINK_MINCLUSTERS_ID
          The minimum number of clusters to extract
static OptionID OPTICSXi.XI_ID
          Parameter to specify the steepness threshold.
static OptionID OPTICSXi.XIALG_ID
          Parameter to specify the actual OPTICS algorithm to use.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm.clustering.correlation
 

Fields in de.lmu.ifi.dbs.elki.algorithm.clustering.correlation declared as OptionID
static OptionID CASH.ADJUST_ID
          Flag to indicate that an adjustment of the applied heuristic for choosing an interval is performed after an interval is selected.
static OptionID HiCO.ALPHA_ID
          The threshold for 'strong' eigenvectors: the 'strong' eigenvectors explain a portion of at least alpha of the total variance.
static OptionID ORCLUS.ALPHA_ID
          Parameter to specify the factor for reducing the number of current clusters in each iteration, must be an integer greater than 0 and less than 1.
static OptionID HiCO.DELTA_ID
          Parameter to specify the threshold of a distance between a vector q and a given space that indicates that q adds a new dimension to the space, must be a double equal to or greater than 0.
static OptionID CASH.JITTER_ID
          Parameter to specify the maximum jitter for distance values, must be a double greater than 0.
static OptionID HiCO.K_ID
          Optional parameter to specify the number of nearest neighbors considered in the PCA, must be an integer greater than 0.
static OptionID CASH.MAXLEVEL_ID
          Parameter to specify the maximum level for splitting the hypercube, must be an integer greater than 0.
static OptionID CASH.MINDIM_ID
          Parameter to specify the minimum dimensionality of the subspaces to be found, must be an integer greater than 0.
static OptionID CASH.MINPTS_ID
          Parameter to specify the threshold for minimum number of points in a cluster, must be an integer greater than 0.
static OptionID HiCO.MU_ID
          Parameter to specify the smoothing factor, must be an integer greater than 0.
static OptionID COPAC.PARTITION_ALGORITHM_ID
          Parameter to specify the clustering algorithm to apply to each partition, must extend ClusteringAlgorithm.
static OptionID COPAC.PARTITION_DISTANCE_ID
          Parameter to specify the distance function to use inside the partitions AbstractIndexBasedDistanceFunction .
static OptionID COPAC.PREPROCESSOR_ID
          Parameter to specify the local PCA preprocessor to derive partition criterion, must extend AbstractFilteredPCAIndex.
static OptionID ORCLUS.SEED_ID
          Parameter to specify the random generator seed.
 

Fields in de.lmu.ifi.dbs.elki.algorithm.clustering.correlation with type parameters of type OptionID
protected  Collection<Pair<OptionID,Object>> COPAC.Parameterizer.algO
           
private  Collection<Pair<OptionID,Object>> COPAC.partitionAlgorithmParameters
          Holds the parameters of the algorithm to run on each partition.
 

Constructor parameters in de.lmu.ifi.dbs.elki.algorithm.clustering.correlation with type arguments of type OptionID
COPAC(FilteredLocalPCABasedDistanceFunction<V,?,D> partitionDistanceFunction, Class<? extends ClusteringAlgorithm<Clustering<Model>>> partitionAlgorithm, Collection<Pair<OptionID,Object>> partitionAlgorithmParameters)
          Constructor.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm.clustering.subspace
 

Fields in de.lmu.ifi.dbs.elki.algorithm.clustering.subspace declared as OptionID
static OptionID SUBCLU.DISTANCE_FUNCTION_ID
          The distance function to determine the distance between database objects.
static OptionID DiSH.EPSILON_ID
          Parameter that specifies the maximum radius of the neighborhood to be considered in each dimension for determination of the preference vector, must be a double equal to or greater than 0.
static OptionID SUBCLU.EPSILON_ID
          Parameter to specify the maximum radius of the neighborhood to be considered, must be suitable to AbstractDimensionsSelectingDoubleDistanceFunction.
static OptionID PROCLUS.M_I_ID
          Parameter to specify the multiplier for the initial number of medoids, must be an integer greater than 0.
static OptionID SUBCLU.MINPTS_ID
          Parameter to specify the threshold for minimum number of points in the epsilon-neighborhood of a point, must be an integer greater than 0.
static OptionID DiSH.MU_ID
          Parameter that specifies the a minimum number of points as a smoothing factor to avoid the single-link-effect, must be an integer greater than 0.
static OptionID CLIQUE.PRUNE_ID
          Flag to indicate that only subspaces with large coverage (i.e. the fraction of the database that is covered by the dense units) are selected, the rest will be pruned.
static OptionID PROCLUS.SEED_ID
          Parameter to specify the random generator seed.
static OptionID CLIQUE.TAU_ID
          Parameter to specify the density threshold for the selectivity of a unit, where the selectivity is the fraction of total feature vectors contained in this unit, must be a double greater than 0 and less than 1.
static OptionID CLIQUE.XSI_ID
          Parameter to specify the number of intervals (units) in each dimension, must be an integer greater than 0.
 

Fields in de.lmu.ifi.dbs.elki.algorithm.clustering.subspace with type parameters of type OptionID
private  Collection<Pair<OptionID,Object>> DiSH.opticsAlgorithmParameters
          Parameters that were given to OPTICS
protected  Collection<Pair<OptionID,Object>> DiSH.Parameterizer.opticsO
           
 

Constructor parameters in de.lmu.ifi.dbs.elki.algorithm.clustering.subspace with type arguments of type OptionID
DiSH(double epsilon, DiSHDistanceFunction dishDistance, Collection<Pair<OptionID,Object>> opticsAlgorithmParameters)
          Constructor.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm.clustering.trivial
 

Fields in de.lmu.ifi.dbs.elki.algorithm.clustering.trivial declared as OptionID
static OptionID ByLabelClustering.MULTIPLE_ID
          Flag to indicate that multiple cluster assignment is possible.
static OptionID ByLabelClustering.NOISE_ID
          Flag to indicate that multiple cluster assignment is possible.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm.outlier
 

Fields in de.lmu.ifi.dbs.elki.algorithm.outlier declared as OptionID
static OptionID LOCI.ALPHA_ID
          Parameter to specify the averaging neighborhood scaling.
static OptionID SOD.ALPHA_ID
          Parameter to indicate the multiplier for the discriminance value for discerning small from large variances.
static OptionID GaussianUniformMixture.C_ID
          Parameter to specify the cutoff.
static OptionID LoOP.COMPARISON_DISTANCE_FUNCTION_ID
          The distance function to determine the reachability distance between database objects.
static OptionID AbstractDBOutlier.D_ID
          Parameter to specify the size of the D-neighborhood
static OptionID ABOD.FAST_SAMPLE_ID
          Parameter for sample size to be used in fast mode.
static OptionID GaussianModel.INVERT_ID
          OptionID for inversion flag.
static OptionID INFLO.K_ID
          Parameter to specify the number of nearest neighbors of an object to be considered for computing its INFLO_SCORE. must be an integer greater than 1.
static OptionID KNNOutlier.K_ID
          Parameter to specify the k nearest neighbor
static OptionID ReferenceBasedOutlierDetection.K_ID
          Parameter to specify the number of nearest neighbors of an object, to be considered for computing its REFOD_SCORE, must be an integer greater than 1.
static OptionID AbstractAggarwalYuOutlier.K_ID
          OptionID for the target dimensionality
static OptionID ABOD.K_ID
          Parameter for k, the number of neighbors used in kNN queries.
static OptionID LDOF.K_ID
          Parameter to specify the number of nearest neighbors of an object to be considered for computing its LDOF_SCORE, must be an integer greater than 1.
static OptionID KNNWeightOutlier.K_ID
          Parameter to specify the k nearest neighbor
static OptionID LOF.K_ID
          Parameter to specify the number of nearest neighbors of an object to be considered for computing its LOF_SCORE, must be an integer greater than 1.
static OptionID LoOP.KCOMP_ID
          Parameter to specify the number of nearest neighbors of an object to be considered for computing its LOOP_SCORE, must be an integer greater than 1.
static OptionID ABOD.KERNEL_FUNCTION_ID
          Parameter for the kernel function.
static OptionID SOD.KNN_ID
          Parameter to specify the number of shared nearest neighbors to be considered for learning the subspace properties., must be an integer greater than 0.
static OptionID KNNWeightOutlier.KNNQUERY_ID
          The kNN query used.
static OptionID LoOP.KREACH_ID
          Parameter to specify the number of nearest neighbors of an object to be considered for computing its LOOP_SCORE, must be an integer greater than 1.
static OptionID GaussianUniformMixture.L_ID
          Parameter to specify the fraction of expected outliers.
static OptionID LoOP.LAMBDA_ID
          Parameter to specify the number of nearest neighbors of an object to be considered for computing its LOOP_SCORE, must be an integer greater than 1.
static OptionID INFLO.M_ID
          Parameter to specify if any object is a Core Object must be a double greater than 0.0 see paper "Two-way search method" 3.2
static OptionID AggarwalYuEvolutionary.M_ID
          Parameter to specify the number of solutions must be an integer greater than 1.
static OptionID LOCI.NMIN_ID
          Parameter to specify the minimum neighborhood size
static OptionID DBOutlierDetection.P_ID
          Parameter to specify the minimum fraction of objects that must be outside the D- neighborhood of an outlier
static OptionID AbstractAggarwalYuOutlier.PHI_ID
          OptionID for the grid size
static OptionID ABOD.PREPROCESSOR_ID
          The preprocessor used to materialize the kNN neighborhoods.
static OptionID LoOP.REACHABILITY_DISTANCE_FUNCTION_ID
          The distance function to determine the reachability distance between database objects.
static OptionID LOF.REACHABILITY_DISTANCE_FUNCTION_ID
          The distance function to determine the reachability distance between database objects.
static OptionID ReferenceBasedOutlierDetection.REFP_ID
          Parameter for the reference points heuristic.
static OptionID LOCI.RMAX_ID
          Parameter to specify the maximum radius of the neighborhood to be considered, must be suitable to the distance function specified.
static OptionID AggarwalYuEvolutionary.SEED_ID
          Parameter to specify the random generator seed.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm.outlier.meta
 

Fields in de.lmu.ifi.dbs.elki.algorithm.outlier.meta declared as OptionID
static OptionID FeatureBagging.Parameterizer.BREADTH_ID
          The flag for using the breadth first approach Key: -fbagging.breadth
static OptionID ExternalDoubleOutlierScore.Parameterizer.FILE_ID
          Parameter that specifies the name of the file to be re-parsed.
static OptionID ExternalDoubleOutlierScore.Parameterizer.ID_ID
          Parameter that specifies the object ID pattern Key: -externaloutlier.idpattern
Default: ^ID=
static OptionID ExternalDoubleOutlierScore.Parameterizer.INVERTED_ID
          Flag parameter for inverted scores.
static OptionID FeatureBagging.Parameterizer.NUM_ID
          Parameter to specify the number of instances to use in the ensemble.
static OptionID RescaleMetaOutlierAlgorithm.SCALING_ID
          Parameter to specify a scaling function to use.
static OptionID ExternalDoubleOutlierScore.Parameterizer.SCALING_ID
          Parameter to specify a scaling function to use.
static OptionID ExternalDoubleOutlierScore.Parameterizer.SCORE_ID
          Parameter that specifies the object score pattern Key: -externaloutlier.scorepattern
static OptionID FeatureBagging.Parameterizer.SEED_ID
          The parameter to specify the random seed Key: -fbagging.seed
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm.outlier.spatial
 

Fields in de.lmu.ifi.dbs.elki.algorithm.outlier.spatial declared as OptionID
static OptionID CTLuGLSBackwardSearchAlgorithm.Parameterizer.ALPHA_ID
          Holds the alpha value - significance niveau
static OptionID CTLuRandomWalkEC.Parameterizer.ALPHA_ID
          Parameter to specify alpha
static OptionID CTLuRandomWalkEC.Parameterizer.C_ID
          Parameter to specify the c
static OptionID CTLuGLSBackwardSearchAlgorithm.Parameterizer.K_ID
          Parameter to specify the k nearest neighbors
static OptionID CTLuRandomWalkEC.Parameterizer.K_ID
          Parameter to specify the number of neighbors
static OptionID AbstractNeighborhoodOutlier.NEIGHBORHOOD_ID
          Parameter to specify the neighborhood predicate to use.
static OptionID AbstractDistanceBasedSpatialOutlier.NON_SPATIAL_DISTANCE_FUNCTION_ID
          Parameter to specify the non spatial distance function to use
static OptionID TrimmedMeanApproach.Parameterizer.P_ID
          Parameter for the percentile value p
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm.outlier.spatial.neighborhood
 

Fields in de.lmu.ifi.dbs.elki.algorithm.outlier.spatial.neighborhood declared as OptionID
static OptionID PrecomputedKNearestNeighborNeighborhood.Factory.Parameterizer.DISTANCEFUNCTION_ID
          Parameter to specify the distance function to use
static OptionID PrecomputedKNearestNeighborNeighborhood.Factory.Parameterizer.K_ID
          Parameter k
static OptionID ExternalNeighborhood.NEIGHBORHOOD_FILE_ID
          Parameter to specify the neighborhood file
static OptionID ExtendedNeighborhood.Factory.Parameterizer.NEIGHBORHOOD_ID
          Parameter to specify the neighborhood predicate to use.
static OptionID ExtendedNeighborhood.Factory.Parameterizer.STEPS_ID
          Parameter to specify the number of steps allowed
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm.outlier.spatial.neighborhood.weighted
 

Fields in de.lmu.ifi.dbs.elki.algorithm.outlier.spatial.neighborhood.weighted declared as OptionID
static OptionID UnweightedNeighborhoodAdapter.Factory.Parameterizer.INNER_ID
          The parameter to give the non-weighted neighborhood to use.
static OptionID LinearWeightedExtendedNeighborhood.Factory.Parameterizer.NEIGHBORHOOD_ID
          Parameter to specify the neighborhood predicate to use.
static OptionID LinearWeightedExtendedNeighborhood.Factory.Parameterizer.STEPS_ID
          Parameter to specify the number of steps allowed
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm.outlier.trivial
 

Fields in de.lmu.ifi.dbs.elki.algorithm.outlier.trivial declared as OptionID
static OptionID ByLabelOutlier.Parameterizer.OUTLIER_PATTERN_ID
          The pattern to match outliers with.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.algorithm.statistics
 

Fields in de.lmu.ifi.dbs.elki.algorithm.statistics declared as OptionID
static OptionID DistanceStatisticsWithClasses.EXACT_ID
          Flag to compute exact value range for binning.
static OptionID RankingQualityHistogram.HISTOGRAM_BINS_ID
          Option to configure the number of bins to use.
static OptionID DistanceStatisticsWithClasses.HISTOGRAM_BINS_ID
          Option to configure the number of bins to use.
static OptionID EvaluateRankingQuality.HISTOGRAM_BINS_ID
          Option to configure the number of bins to use.
static OptionID DistanceStatisticsWithClasses.SAMPLING_ID
          Flag to enable sampling
 

Uses of OptionID in de.lmu.ifi.dbs.elki.application
 

Fields in de.lmu.ifi.dbs.elki.application declared as OptionID
static OptionID ComputeSingleColorHistogram.COLORHIST_ID
          Class parameter for computing the color histogram.
static OptionID AbstractApplication.INPUT_ID
          Parameter that specifies the name of the input file.
static OptionID ComputeSingleColorHistogram.INPUT_ID
          Parameter that specifies the name of the input file.
static OptionID AbstractApplication.OUTPUT_ID
          Parameter that specifies the name of the output file.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.application.cache
 

Fields in de.lmu.ifi.dbs.elki.application.cache declared as OptionID
static OptionID CacheFloatDistanceInOnDiskMatrix.CACHE_ID
          Parameter that specifies the name of the directory to be re-parsed.
static OptionID CacheDoubleDistanceInOnDiskMatrix.CACHE_ID
          Parameter that specifies the name of the directory to be re-parsed.
static OptionID CacheFloatDistanceInOnDiskMatrix.DISTANCE_ID
          Parameter that specifies the name of the directory to be re-parsed.
static OptionID CacheDoubleDistanceInOnDiskMatrix.DISTANCE_ID
          Parameter that specifies the name of the directory to be re-parsed.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.application.internal
 

Methods in de.lmu.ifi.dbs.elki.application.internal with parameters of type OptionID
 int DocumentParameters.SortByOption.compare(OptionID o1, OptionID o2)
           
 

Method parameters in de.lmu.ifi.dbs.elki.application.internal with type arguments of type OptionID
private static void DocumentParameters.buildParameterIndex(HashMapList<Class<?>,Parameter<?,?>> byclass, HashMapList<OptionID,Pair<Parameter<?,?>,Class<?>>> byopt)
           
private static Document DocumentParameters.makeByOptOverview(HashMapList<OptionID,Pair<Parameter<?,?>,Class<?>>> byopt)
           
 

Uses of OptionID in de.lmu.ifi.dbs.elki.application.jsmap
 

Fields in de.lmu.ifi.dbs.elki.application.jsmap declared as OptionID
static OptionID JSONResultHandler.Parameterizer.PORT_ID
          Port to use for listening
 

Uses of OptionID in de.lmu.ifi.dbs.elki.application.visualization
 

Fields in de.lmu.ifi.dbs.elki.application.visualization declared as OptionID
static OptionID KNNExplorer.DISTANCE_FUNCTION_ID
          Parameter to specify the distance function to determine the distance between database objects, must extend DistanceFunction.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.data.images
 

Fields in de.lmu.ifi.dbs.elki.data.images declared as OptionID
static OptionID ComputeNaiveHSBColorHistogram.BINSPERPLANE_ID
          Parameter that specifies the number of bins (per plane) to use.
static OptionID ComputeNaiveRGBColorHistogram.BINSPERPLANE_ID
          Parameter that specifies the number of bins (per plane) to use.
static OptionID ComputeHSBColorHistogram.BINSPERPLANE_ID
          Parameter that specifies the number of bins (per plane) to use.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.database
 

Fields in de.lmu.ifi.dbs.elki.database declared as OptionID
static OptionID AbstractDatabase.INDEX_ID
          Parameter to specify the indexes to use.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.datasource
 

Fields in de.lmu.ifi.dbs.elki.datasource declared as OptionID
static OptionID GeneratorXMLDatabaseConnection.CONFIGFILE_ID
          Parameter to give the configuration file
static OptionID RandomDoubleVectorDatabaseConnection.Parameterizer.DIM_ID
          Database to specify the random vector dimensionality Key: -dbc.dim
static OptionID AbstractDatabaseConnection.FILTERS_ID
          Filters to apply to the input data.
static OptionID FileBasedDatabaseConnection.INPUT_ID
          Parameter that specifies the name of the input file to be parsed.
static OptionID InputStreamDatabaseConnection.PARSER_ID
          Parameter to specify the parser to provide a database.
static OptionID GeneratorXMLDatabaseConnection.RANDOMSEED_ID
          Parameter to give the configuration file
static OptionID RandomDoubleVectorDatabaseConnection.Parameterizer.SEED_ID
          Random generator seed.
static OptionID RandomDoubleVectorDatabaseConnection.Parameterizer.SIZE_ID
          Parameter to specify the database size to generate.
static OptionID GeneratorXMLDatabaseConnection.SIZE_SCALE_ID
          Parameter to give the configuration file
static OptionID ExternalIDJoinDatabaseConnection.Parameterizer.SOURCES_ID
          The static option ID
static OptionID LabelJoinDatabaseConnection.Parameterizer.SOURCES_ID
          The static option ID
 

Uses of OptionID in de.lmu.ifi.dbs.elki.datasource.filter
 

Fields in de.lmu.ifi.dbs.elki.datasource.filter declared as OptionID
static OptionID ClassLabelFilter.CLASS_LABEL_CLASS_ID
          Parameter to specify the class of occurring class labels.
static OptionID ClassLabelFilter.CLASS_LABEL_INDEX_ID
          Optional parameter that specifies the index of the label to be used as class label, must be an integer equal to or greater than 0.
static OptionID ExternalIDFilter.EXTERNALID_INDEX_ID
          Optional parameter that specifies the index of the label to be used as external Id, must be an integer equal to or greater than 0.
static OptionID FixedDBIDsFilter.IDSTART_ID
          Optional parameter to specify the first object ID to use.
static OptionID FilterByLabelFilter.Parameterizer.LABELFILTER_PATTERN_ID
          Parameter that specifies the filter pattern (regular expression).
static OptionID FilterByLabelFilter.Parameterizer.LABELFILTER_PATTERN_INVERT_ID
          Flag to use the pattern in inverted mode Key: -patternfilter.invert
static OptionID AttributeWiseMinMaxNormalization.MAXIMA_ID
          Parameter for maximum.
static OptionID AttributeWiseVarianceNormalization.MEAN_ID
          Parameter for means.
static OptionID AttributeWiseMinMaxNormalization.MINIMA_ID
          Parameter for minimum.
static OptionID AbstractRandomFeatureSelectionFilter.NUMBER_SELECTED_ATTRIBUTES_ID
          Parameter for the desired cardinality of the subset of attributes selected for projection.
static OptionID ShuffleObjectsFilter.SEED_ID
          Optional parameter to specify a seed for randomly shuffling the rows of the database.
static OptionID SplitNumberVectorFilter.Parameterizer.SELECTED_ATTRIBUTES_ID
          The parameter listing the split dimensions.
static OptionID AbstractFeatureSelectionFilter.SELECTED_ATTRIBUTES_ID
           Selected attributes parameter.
static OptionID AttributeWiseVarianceNormalization.STDDEV_ID
          Parameter for stddevs.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.datasource.parser
 

Fields in de.lmu.ifi.dbs.elki.datasource.parser declared as OptionID
static OptionID AbstractParser.COLUMN_SEPARATOR_ID
          OptionID for the column separator parameter (defaults to whitespace as in AbstractParser.WHITESPACE_PATTERN.
static OptionID NumberDistanceParser.DISTANCE_FUNCTION_ID
          Parameter for distance function.
static OptionID NumberVectorLabelParser.LABEL_INDICES_ID
          A comma separated list of the indices of labels (may be numeric), counting whitespace separated entries in a line starting with 0.
static OptionID ArffParser.Parameterizer.MAGIC_CLASS_ID
          Pattern for recognizing class label attributes.
static OptionID ArffParser.Parameterizer.MAGIC_EID_ID
          Pattern for recognizing external ID attributes.
static OptionID AbstractParser.QUOTE_ID
          OptionID for the quote character parameter (defaults to a double quotation mark as in AbstractParser.QUOTE_CHAR.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.distance.distancefunction
 

Fields in de.lmu.ifi.dbs.elki.distance.distancefunction declared as OptionID
static OptionID MinKDistance.DISTANCE_FUNCTION_ID
          OptionID for the base distance used to compute reachability
static OptionID IndexBasedDistanceFunction.INDEX_ID
          OptionID for the index parameter
static OptionID MinKDistance.K_ID
          OptionID for the "k" parameter.
static OptionID MinKDistance.KNNQUERY_ID
          OptionID for the KNN query class to use (preprocessor, approximation, ...)
static OptionID LPNormDistanceFunction.P_ID
          OptionID for the "p" parameter
 

Uses of OptionID in de.lmu.ifi.dbs.elki.distance.distancefunction.adapter
 

Fields in de.lmu.ifi.dbs.elki.distance.distancefunction.adapter declared as OptionID
static OptionID AbstractSimilarityAdapter.SIMILARITY_FUNCTION_ID
          Parameter to specify the similarity function to derive the distance between database objects from.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.distance.distancefunction.colorhistogram
 

Fields in de.lmu.ifi.dbs.elki.distance.distancefunction.colorhistogram declared as OptionID
static OptionID HSBHistogramQuadraticDistanceFunction.BPP_ID
          Parameter for the kernel dimensionality.
static OptionID RGBHistogramQuadraticDistanceFunction.BPP_ID
          Parameter for the kernel dimensionality.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.distance.distancefunction.correlation
 

Fields in de.lmu.ifi.dbs.elki.distance.distancefunction.correlation declared as OptionID
static OptionID PCABasedCorrelationDistanceFunction.DELTA_ID
          Parameter to specify the threshold of a distance between a vector q and a given space that indicates that q adds a new dimension to the space, must be a double equal to or greater than 0.
static OptionID ERiCDistanceFunction.DELTA_ID
          Parameter to specify the threshold for approximate linear dependency: the strong eigenvectors of q are approximately linear dependent from the strong eigenvectors p if the following condition holds for all strong eigenvectors q_i of q (lambda_q < lambda_p): q_i' * M^check_p * q_i <= delta^2, must be a double equal to or greater than 0.
static OptionID ERiCDistanceFunction.TAU_ID
          Parameter to specify the threshold for the maximum distance between two approximately linear dependent subspaces of two objects p and q (lambda_q < lambda_p) before considering them as parallel, must be a double equal to or greater than 0.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.distance.distancefunction.external
 

Fields in de.lmu.ifi.dbs.elki.distance.distancefunction.external declared as OptionID
static OptionID FileBasedDoubleDistanceFunction.MATRIX_ID
          Parameter that specifies the name of the distance matrix file.
static OptionID FileBasedFloatDistanceFunction.MATRIX_ID
          Parameter that specifies the name of the distance matrix file.
static OptionID DiskCacheBasedDoubleDistanceFunction.MATRIX_ID
          Parameter that specifies the name of the distance matrix file.
static OptionID DiskCacheBasedFloatDistanceFunction.MATRIX_ID
          Parameter that specifies the name of the distance matrix file.
static OptionID FileBasedDoubleDistanceFunction.PARSER_ID
          Optional parameter to specify the parsers to provide a database, must extend DistanceParser.
static OptionID FileBasedFloatDistanceFunction.PARSER_ID
          Optional parameter to specify the parsers to provide a database, must extend DistanceParser.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.distance.distancefunction.geo
 

Fields in de.lmu.ifi.dbs.elki.distance.distancefunction.geo declared as OptionID
static OptionID DimensionSelectingLatLngDistanceFunction.Parameterizer.LATDIM_ID
          Latitude dimension parameter.
static OptionID DimensionSelectingLatLngDistanceFunction.Parameterizer.LNGDIM_ID
          Longitude dimension parameter.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.distance.distancefunction.subspace
 

Fields in de.lmu.ifi.dbs.elki.distance.distancefunction.subspace declared as OptionID
static OptionID DimensionSelectingDistanceFunction.DIM_ID
          Parameter for dimensionality.
static OptionID AbstractDimensionsSelectingDoubleDistanceFunction.DIMS_ID
          Dimensions parameter.
static OptionID AbstractPreferenceVectorBasedCorrelationDistanceFunction.EPSILON_ID
          Parameter to specify the maximum distance between two vectors with equal preference vectors before considering them as parallel, must be a double equal to or greater than 0.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.distance.distancefunction.timeseries
 

Fields in de.lmu.ifi.dbs.elki.distance.distancefunction.timeseries declared as OptionID
static OptionID AbstractEditDistanceFunction.BANDSIZE_ID
          BANDSIZE parameter
static OptionID EDRDistanceFunction.DELTA_ID
          DELTA parameter
static OptionID ERPDistanceFunction.G_ID
          G parameter
static OptionID LCSSDistanceFunction.PDELTA_ID
          PDELTA parameter
static OptionID LCSSDistanceFunction.PEPSILON_ID
          PEPSILON parameter
 

Uses of OptionID in de.lmu.ifi.dbs.elki.distance.similarityfunction
 

Fields in de.lmu.ifi.dbs.elki.distance.similarityfunction declared as OptionID
static OptionID AbstractIndexBasedSimilarityFunction.INDEX_ID
          Parameter to specify the preprocessor to be used.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.distance.similarityfunction.kernel
 

Fields in de.lmu.ifi.dbs.elki.distance.similarityfunction.kernel declared as OptionID
static OptionID PolynomialKernelFunction.DEGREE_ID
          Degree parameter
static OptionID FooKernelFunction.MAX_DEGREE_ID
          Parameter for the maximum degree
 

Uses of OptionID in de.lmu.ifi.dbs.elki.evaluation.histogram
 

Fields in de.lmu.ifi.dbs.elki.evaluation.histogram declared as OptionID
static OptionID ComputeOutlierHistogram.BINS_ID
          number of bins for the histogram Default value: EuclideanDistanceFunction Key: -comphist.bins
static OptionID ComputeOutlierHistogram.POSITIVE_CLASS_NAME_ID
          The object pattern to identify positive classes Key: -comphist.positive
static OptionID ComputeOutlierHistogram.SCALING_ID
          Parameter to specify a scaling function to use.
static OptionID ComputeOutlierHistogram.SPLITFREQ_ID
          Flag to count frequencies of outliers and non-outliers separately Key: -histogram.splitfreq
 

Uses of OptionID in de.lmu.ifi.dbs.elki.evaluation.outlier
 

Fields in de.lmu.ifi.dbs.elki.evaluation.outlier declared as OptionID
static OptionID JudgeOutlierScores.POSITIVE_CLASS_NAME_ID
          The distance function to determine the reachability distance between database objects.
static OptionID JudgeOutlierScores.SCALING_ID
          Parameter to specify a scaling function to use.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.evaluation.paircounting
 

Fields in de.lmu.ifi.dbs.elki.evaluation.paircounting declared as OptionID
static OptionID EvaluatePairCountingFMeasure.NOISE_ID
          Parameter flag for special noise handling.
static OptionID EvaluatePairCountingFMeasure.REFERENCE_ID
          Parameter to obtain the reference clustering.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.evaluation.roc
 

Fields in de.lmu.ifi.dbs.elki.evaluation.roc declared as OptionID
static OptionID ComputeROCCurve.POSITIVE_CLASS_NAME_ID
          The pattern to identify positive classes.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.evaluation.similaritymatrix
 

Fields in de.lmu.ifi.dbs.elki.evaluation.similaritymatrix declared as OptionID
static OptionID ComputeSimilarityMatrixImage.SCALING_ID
          OptionID for the scaling function to use
static OptionID ComputeSimilarityMatrixImage.SKIPZERO_ID
          OptionID to skip zero values when plotting to increase contrast.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.gui.util
 

Fields in de.lmu.ifi.dbs.elki.gui.util declared as OptionID
protected static OptionID DynamicParameters.REMAINING_OPTIONS_ID
          OptionID for unrecognized options.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.preprocessed.knn
 

Fields in de.lmu.ifi.dbs.elki.index.preprocessed.knn declared as OptionID
static OptionID AbstractMaterializeKNNPreprocessor.Factory.DISTANCE_FUNCTION_ID
          Parameter to indicate the distance function to be used to ascertain the nearest neighbors.
static OptionID AbstractMaterializeKNNPreprocessor.Factory.K_ID
          Parameter to specify the number of nearest neighbors of an object to be materialized. must be an integer greater than 1.
static OptionID PartitionApproximationMaterializeKNNPreprocessor.Factory.PARTITIONS_ID
          Parameter to specify the number of partitions to use for materializing the kNN.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.preprocessed.localpca
 

Fields in de.lmu.ifi.dbs.elki.index.preprocessed.localpca declared as OptionID
static OptionID RangeQueryFilteredPCAIndex.Factory.EPSILON_ID
          Parameter to specify the maximum radius of the neighborhood to be considered in the PCA, must be suitable to the distance function specified.
static OptionID KNNQueryFilteredPCAIndex.Factory.K_ID
          Optional parameter to specify the number of nearest neighbors considered in the PCA, must be an integer greater than 0.
static OptionID AbstractFilteredPCAIndex.Factory.PCA_DISTANCE_ID
          Parameter to specify the distance function used for running PCA.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.preprocessed.preference
 

Fields in de.lmu.ifi.dbs.elki.index.preprocessed.preference declared as OptionID
static OptionID HiSCPreferenceVectorIndex.Factory.ALPHA_ID
          The maximum absolute variance along a coordinate axis.
static OptionID DiSHPreferenceVectorIndex.Factory.EPSILON_ID
          A comma separated list of positive doubles specifying the maximum radius of the neighborhood to be considered in each dimension for determination of the preference vector (default is DiSHPreferenceVectorIndex.Factory.DEFAULT_EPSILON in each dimension).
static OptionID HiSCPreferenceVectorIndex.Factory.K_ID
          The number of nearest neighbors considered to determine the preference vector.
static OptionID DiSHPreferenceVectorIndex.Factory.MINPTS_ID
          Positive threshold for minimum numbers of points in the epsilon-neighborhood of a point, must satisfy following DiSHPreferenceVectorIndex.Factory.CONDITION.
static OptionID DiSHPreferenceVectorIndex.Factory.STRATEGY_ID
          The strategy for determination of the preference vector, available strategies are: DiSHPreferenceVectorIndex.Strategy.APRIORI and DiSHPreferenceVectorIndex.Strategy.MAX_INTERSECTION.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.preprocessed.snn
 

Fields in de.lmu.ifi.dbs.elki.index.preprocessed.snn declared as OptionID
static OptionID SharedNearestNeighborPreprocessor.Factory.DISTANCE_FUNCTION_ID
          Parameter to indicate the distance function to be used to ascertain the nearest neighbors.
static OptionID SharedNearestNeighborPreprocessor.Factory.NUMBER_OF_NEIGHBORS_ID
          Parameter to indicate the number of neighbors to be taken into account for the shared-nearest-neighbor similarity.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.preprocessed.subspaceproj
 

Fields in de.lmu.ifi.dbs.elki.index.preprocessed.subspaceproj declared as OptionID
static OptionID PreDeConSubspaceIndex.Factory.DELTA_ID
          Parameter for Delta
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.tree
 

Fields in de.lmu.ifi.dbs.elki.index.tree declared as OptionID
static OptionID TreeIndexFactory.CACHE_SIZE_ID
          Parameter to specify the size of the cache in bytes, must be an integer equal to or greater than 0.
static OptionID TreeIndexFactory.FILE_ID
          Optional parameter that specifies the name of the file storing the index.
static OptionID TreeIndexFactory.PAGE_SIZE_ID
          Parameter to specify the size of a page in bytes, must be an integer greater than 0.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants
 

Fields in de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants declared as OptionID
static OptionID AbstractMTreeFactory.DISTANCE_FUNCTION_ID
          Parameter to specify the distance function to determine the distance between database objects, must extend DistanceFunction.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants.mktrees
 

Fields in de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants.mktrees declared as OptionID
static OptionID AbstractMkTreeUnifiedFactory.K_MAX_ID
          Parameter specifying the maximal number k of reverse k nearest neighbors to be supported, must be an integer greater than 0.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants.mktrees.mkapp
 

Fields in de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants.mktrees.mkapp declared as OptionID
static OptionID MkAppTreeFactory.K_ID
          Parameter for k
static OptionID MkAppTreeFactory.NOLOG_ID
          Parameter for nolog
static OptionID MkAppTreeFactory.P_ID
          Parameter for p
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants.mktrees.mkcop
 

Fields in de.lmu.ifi.dbs.elki.index.tree.metrical.mtreevariants.mktrees.mkcop declared as OptionID
static OptionID MkCopTreeFactory.K_ID
          Parameter for k
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.tree.spatial.rstarvariants
 

Fields in de.lmu.ifi.dbs.elki.index.tree.spatial.rstarvariants declared as OptionID
static OptionID AbstractRStarTreeFactory.BULK_SPLIT_ID
          Parameter for bulk strategy
static OptionID AbstractRStarTreeFactory.INSERTION_STRATEGY_ID
          Fast-insertion parameter.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.index.tree.spatial.rstarvariants.util
 

Fields in de.lmu.ifi.dbs.elki.index.tree.spatial.rstarvariants.util declared as OptionID
static OptionID ApproximateLeastOverlapInsertionStrategy.Parameterizer.INSERTION_CANDIDATES_ID
          Fast-insertion parameter.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.math.linearalgebra.pca
 

Fields in de.lmu.ifi.dbs.elki.math.linearalgebra.pca declared as OptionID
static OptionID PercentageEigenPairFilter.ALPHA_ID
          The threshold for 'strong' eigenvectors: the 'strong' eigenvectors explain a portion of at least alpha of the total variance.
static OptionID PCAFilteredRunner.BIG_ID
          Parameter to specify a constant big value to reset high eigenvalues, must be a double greater than 0.
static OptionID LimitEigenPairFilter.EIGENPAIR_FILTER_ABSOLUTE
          "absolute" Flag
static OptionID CompositeEigenPairFilter.EIGENPAIR_FILTER_COMPOSITE_LIST
          The list of filters to use.
static OptionID LimitEigenPairFilter.EIGENPAIR_FILTER_DELTA
          Parameter delta
static OptionID FirstNEigenPairFilter.EIGENPAIR_FILTER_N
          Paremeter n
static OptionID ProgressiveEigenPairFilter.EIGENPAIR_FILTER_PALPHA
          Parameter progressive alpha.
static OptionID RelativeEigenPairFilter.EIGENPAIR_FILTER_RALPHA
          Parameter relative alpha.
static OptionID WeakEigenPairFilter.EIGENPAIR_FILTER_WALPHA
          OptionID for the weak alpha value of WeakEigenPairFilter, ProgressiveEigenPairFilter and SignificantEigenPairFilter
static OptionID PCARunner.PCA_COVARIANCE_MATRIX
          Parameter to specify the class to compute the covariance matrix, must be a subclass of CovarianceMatrixBuilder.
static OptionID PCAFilteredRunner.PCA_EIGENPAIR_FILTER
          Parameter to specify the filter for determination of the strong and weak eigenvectors, must be a subclass of EigenPairFilter.
static OptionID PCAFilteredRunner.SMALL_ID
          Parameter to specify a constant small value to reset low eigenvalues, must be a double greater than 0.
static OptionID WeightedCovarianceMatrixBuilder.WEIGHT_ID
          Parameter to specify the weight function to use in weighted PCA, must implement WeightFunction .
 

Uses of OptionID in de.lmu.ifi.dbs.elki.result
 

Fields in de.lmu.ifi.dbs.elki.result declared as OptionID
static OptionID KMLOutputHandler.Parameterizer.AUTOOPEN_ID
          Parameter for automatically opening the output file.
static OptionID KMLOutputHandler.Parameterizer.COMPAT_ID
          Parameter for compatibility mode.
static OptionID ResultWriter.GZIP_OUTPUT_ID
          Flag to control GZIP compression.
static OptionID ResultWriter.OVERWRITE_OPTION_ID
          Flag to suppress overwrite warning.
static OptionID KMLOutputHandler.Parameterizer.SCALING_ID
          Parameter for scaling functions Key: -kml.scaling
 

Uses of OptionID in de.lmu.ifi.dbs.elki.utilities.optionhandling
 

Fields in de.lmu.ifi.dbs.elki.utilities.optionhandling declared as OptionID
static OptionID OptionID.ALGORITHM
          OptionID for AlgorithmStep
static OptionID OptionID.DATABASE
          OptionID for InputStep
static OptionID OptionID.DATABASE_CONNECTION
          OptionID for InputStep
static OptionID OptionID.DEBUG
          Optional Parameter to specify a class to enable debugging for.
static OptionID OptionID.DESCRIPTION
          Optional Parameter to specify a class to obtain a description for.
static OptionID OptionID.EVALUATOR
          OptionID for EvaluationStep
static OptionID OptionID.HELP
          Flag to obtain help-message.
static OptionID OptionID.HELP_LONG
          Flag to obtain help-message.
static OptionID OptionID.OUTPUT
          OptionID for the application output file/folder
static OptionID OptionID.RESULT_HANDLER
          OptionID for OutputStep
static OptionID OptionID.VERBOSE_FLAG
          Flag to allow verbose messages while running the application.
 

Methods in de.lmu.ifi.dbs.elki.utilities.optionhandling that return OptionID
static OptionID OptionID.getOptionID(String name)
          Returns the OptionID for the given name if it exists, null otherwise.
static OptionID OptionID.getOrCreateOptionID(String name, String description)
          Gets or creates the OptionID for the given class and given name.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.utilities.optionhandling.parameterization
 

Fields in de.lmu.ifi.dbs.elki.utilities.optionhandling.parameterization with type parameters of type OptionID
(package private)  LinkedList<Pair<OptionID,Object>> ListParameterization.parameters
          The actual parameters, for storage
private  Vector<Pair<OptionID,Object>> MergedParameterization.used
          Parameters to rewind.
 

Methods in de.lmu.ifi.dbs.elki.utilities.optionhandling.parameterization that return types with arguments of type OptionID
 Collection<Pair<OptionID,Object>> TrackParameters.getGivenParameters()
          Get the tracked parameters that were actually set.
 List<Pair<OptionID,Object>> ListParameterization.getRemainingParameters()
          Return the yet unused parameters.
 

Methods in de.lmu.ifi.dbs.elki.utilities.optionhandling.parameterization with parameters of type OptionID
 void ListParameterization.addFlag(OptionID optionid)
          Add a flag to the parameter list
 void ListParameterization.addParameter(OptionID optionid, Object value)
          Add a parameter to the parameter list
 

Constructor parameters in de.lmu.ifi.dbs.elki.utilities.optionhandling.parameterization with type arguments of type OptionID
ListParameterization(Collection<Pair<OptionID,Object>> dbParameters)
          Constructor with an existing collection.
MergedParameterization(Parameterization inner, ListParameterization current, Vector<Pair<OptionID,Object>> used)
          Constructor for descending
 

Uses of OptionID in de.lmu.ifi.dbs.elki.utilities.optionhandling.parameters
 

Fields in de.lmu.ifi.dbs.elki.utilities.optionhandling.parameters declared as OptionID
protected  OptionID Parameter.optionid
          The option name.
 

Methods in de.lmu.ifi.dbs.elki.utilities.optionhandling.parameters that return OptionID
 OptionID Parameter.getOptionID()
          Return the OptionID of this option.
 

Constructors in de.lmu.ifi.dbs.elki.utilities.optionhandling.parameters with parameters of type OptionID
ClassListParameter(OptionID optionID, Class<?> restrictionClass)
          Constructs a class list parameter with the given optionID and restriction class.
ClassListParameter(OptionID optionID, Class<?> restrictionClass, boolean optional)
          Constructs a class list parameter with the given optionID and restriction class.
ClassParameter(OptionID optionID, Class<?> restrictionClass)
          Constructs a class parameter with the given optionID, and restriction class.
ClassParameter(OptionID optionID, Class<?> restrictionClass, boolean optional)
          Constructs a class parameter with the given optionID, restriction class, and optional flag.
ClassParameter(OptionID optionID, Class<?> restrictionClass, Class<?> defaultValue)
          Constructs a class parameter with the given optionID, restriction class, and default value.
DistanceParameter(OptionID optionID, D dist)
          Constructs a double parameter with the given optionID.
DistanceParameter(OptionID optionID, D dist, boolean optional)
          Constructs a double parameter with the given optionID and optional flag.
DistanceParameter(OptionID optionID, D dist, D defaultValue)
          Constructs a double parameter with the given optionID and default value.
DistanceParameter(OptionID optionID, DistanceFunction<?,D> dist)
          Constructs a double parameter with the given optionID.
DistanceParameter(OptionID optionID, DistanceFunction<?,D> dist, boolean optional)
          Constructs a double parameter with the given optionID and optional flag.
DistanceParameter(OptionID optionID, DistanceFunction<?,D> dist, D defaultValue)
          Constructs a double parameter with the given optionID and default value.
DistanceParameter(OptionID optionID, DistanceFunction<?,D> dist, List<ParameterConstraint<D>> constraints)
          Constructs a double parameter with the given optionID, and parameter constraints.
DistanceParameter(OptionID optionID, DistanceFunction<?,D> dist, List<ParameterConstraint<D>> cons, boolean optional)
          Constructs a double parameter with the given optionID, parameter constraints, and optional flag.
DistanceParameter(OptionID optionID, DistanceFunction<?,D> dist, List<ParameterConstraint<D>> cons, D defaultValue)
          Constructs a double parameter with the given optionID, parameter constraints, and default value.
DistanceParameter(OptionID optionID, DistanceFunction<?,D> dist, ParameterConstraint<D> constraint)
          Constructs a double parameter with the given optionID, and parameter constraint.
DistanceParameter(OptionID optionID, DistanceFunction<?,D> dist, ParameterConstraint<D> constraint, boolean optional)
          Constructs a double parameter with the given optionID, parameter constraint, and optional flag.
DistanceParameter(OptionID optionID, DistanceFunction<?,D> dist, ParameterConstraint<D> constraint, D defaultValue)
          Constructs a double parameter with the given optionID, parameter constraint, and default value.
DistanceParameter(OptionID optionID, D dist, List<ParameterConstraint<D>> constraints)
          Constructs a double parameter with the given optionID, and parameter constraints.
DistanceParameter(OptionID optionID, D dist, List<ParameterConstraint<D>> cons, boolean optional)
          Constructs a double parameter with the given optionID, parameter constraints, and optional flag.
DistanceParameter(OptionID optionID, D dist, List<ParameterConstraint<D>> cons, D defaultValue)
          Constructs a double parameter with the given optionID, parameter constraints, and default value.
DistanceParameter(OptionID optionID, D dist, ParameterConstraint<D> constraint)
          Constructs a double parameter with the given optionID, and parameter constraint.
DistanceParameter(OptionID optionID, D dist, ParameterConstraint<D> constraint, boolean optional)
          Constructs a double parameter with the given optionID, parameter constraint, and optional flag.
DistanceParameter(OptionID optionID, D dist, ParameterConstraint<D> constraint, D defaultValue)
          Constructs a double parameter with the given optionID, parameter constraint, and default value.
DoubleListParameter(OptionID optionID)
          Constructs a list parameter with the given optionID.
DoubleListParameter(OptionID optionID, boolean optional)
          Constructs a list parameter with the given optionID and optional flag.
DoubleListParameter(OptionID optionID, List<ParameterConstraint<List<Double>>> constraints, boolean optional)
          Constructs a list parameter with the given optionID.
DoubleListParameter(OptionID optionID, List<ParameterConstraint<List<Double>>> constraints, List<Double> defaultValue)
          Constructs a list parameter with the given optionID.
DoubleListParameter(OptionID optionID, ParameterConstraint<List<Double>> constraint)
          Constructs a list parameter with the given optionID.
DoubleListParameter(OptionID optionID, ParameterConstraint<List<Double>> constraint, boolean optional)
          Constructs a list parameter with the given optionID.
DoubleListParameter(OptionID optionID, ParameterConstraint<List<Double>> constraint, List<Double> defaultValue)
          Constructs a list parameter with the given optionID.
DoubleParameter(OptionID optionID)
          Constructs a double parameter with the given optionID.
DoubleParameter(OptionID optionID, boolean optional)
          Constructs a double parameter with the given optionID and optional flag.
DoubleParameter(OptionID optionID, Double defaultValue)
          Constructs a double parameter with the given optionID and default value.
DoubleParameter(OptionID optionID, List<ParameterConstraint<Number>> constraints)
          Constructs a double parameter with the given optionID, and parameter constraints.
DoubleParameter(OptionID optionID, List<ParameterConstraint<Number>> cons, boolean optional)
          Constructs a double parameter with the given optionID, parameter constraints, and optional flag.
DoubleParameter(OptionID optionID, List<ParameterConstraint<Number>> cons, Double defaultValue)
          Constructs a double parameter with the given optionID, parameter constraints, and default value.
DoubleParameter(OptionID optionID, ParameterConstraint<Number> constraint)
          Constructs a double parameter with the given optionID, and parameter constraint.
DoubleParameter(OptionID optionID, ParameterConstraint<Number> constraint, boolean optional)
          Constructs a double parameter with the given optionID, parameter constraint, and optional flag.
DoubleParameter(OptionID optionID, ParameterConstraint<Number> constraint, Double defaultValue)
          Constructs a double parameter with the given optionID, parameter constraint, and default value.
EnumParameter(OptionID optionID, Class<E> enumClass)
          Constructs an enum parameter with the given optionID, constraints and default value.
EnumParameter(OptionID optionID, Class<E> enumClass, boolean optional)
          Constructs an enum parameter with the given optionID, constraints and default value.
EnumParameter(OptionID optionID, Class<E> enumClass, E defaultValue)
          Constructs an enum parameter with the given optionID, constraints and default value.
FileListParameter(OptionID optionID, FileListParameter.FilesType filesType)
          Constructs a file list parameter with the given optionID, and file type.
FileParameter(OptionID optionID, FileParameter.FileType fileType)
          Constructs a file parameter with the given optionID, and file type.
FileParameter(OptionID optionID, FileParameter.FileType fileType, boolean optional)
          Constructs a file parameter with the given optionID, file type, and optional flag.
Flag(OptionID optionID)
          Constructs a flag object with the given optionID.
IntListParameter(OptionID optionID)
          Constructs an integer list parameter
IntListParameter(OptionID optionID, boolean optional)
          Constructs an integer list parameter
IntListParameter(OptionID optionID, List<ParameterConstraint<List<Integer>>> constraints, boolean optional)
          Constructs an integer list parameter
IntListParameter(OptionID optionID, List<ParameterConstraint<List<Integer>>> constraints, List<Integer> defaultValue)
          Constructs an integer list parameter
IntListParameter(OptionID optionID, ParameterConstraint<List<Integer>> constraint)
          Constructs an integer list parameter
IntListParameter(OptionID optionID, ParameterConstraint<List<Integer>> constraint, boolean optional)
          Constructs an integer list parameter
IntListParameter(OptionID optionID, ParameterConstraint<List<Integer>> constraint, List<Integer> defaultValue)
          Constructs an integer list parameter
IntParameter(OptionID optionID)
          Constructs an integer parameter with the given optionID.
IntParameter(OptionID optionID, boolean optional)
          Constructs an integer parameter with the given optionID.
IntParameter(OptionID optionID, Integer defaultValue)
          Constructs an integer parameter with the given optionID.
IntParameter(OptionID optionID, List<ParameterConstraint<Number>> constraints)
          Constructs an integer parameter with the given optionID, and parameter constraint.
IntParameter(OptionID optionID, List<ParameterConstraint<Number>> constraints, boolean optional)
          Constructs an integer parameter with the given optionID, parameter constraint, and optional flag.
IntParameter(OptionID optionID, List<ParameterConstraint<Number>> constraints, Integer defaultValue)
          Constructs an integer parameter with the given optionID, parameter constraint, and default value.
IntParameter(OptionID optionID, ParameterConstraint<Number> constraint)
          Constructs an integer parameter with the given optionID, and parameter constraint.
IntParameter(OptionID optionID, ParameterConstraint<Number> constraint, boolean optional)
          Constructs an integer parameter with the given optionID, parameter constraint, and optional flag.
IntParameter(OptionID optionID, ParameterConstraint<Number> constraint, Integer defaultValue)
          Constructs an integer parameter with the given optionID, parameter constraint, and default value.
ListParameter(OptionID optionID)
          Constructs a list parameter with the given optionID.
ListParameter(OptionID optionID, boolean optional)
          Constructs a list parameter with the given optionID and optional flag.
ListParameter(OptionID optionID, List<ParameterConstraint<List<T>>> constraints, boolean optional)
          Constructs a list parameter with the given optionID.
ListParameter(OptionID optionID, List<ParameterConstraint<List<T>>> constraints, List<T> defaultValue)
          Constructs a list parameter with the given optionID.
ListParameter(OptionID optionID, ParameterConstraint<List<T>> constraint)
          Constructs a list parameter with the given optionID.
ListParameter(OptionID optionID, ParameterConstraint<List<T>> constraint, boolean optional)
          Constructs a list parameter with the given optionID.
ListParameter(OptionID optionID, ParameterConstraint<List<T>> constraint, List<T> defaultValue)
          Constructs a list parameter with the given optionID.
LongParameter(OptionID optionID)
          Constructs a long parameter with the given optionID.
LongParameter(OptionID optionID, boolean optional)
          Constructs a long parameter with the given optionID.
LongParameter(OptionID optionID, List<ParameterConstraint<Number>> constraints)
          Constructs a long parameter with the given optionID, and parameter constraint.
LongParameter(OptionID optionID, List<ParameterConstraint<Number>> constraints, boolean optional)
          Constructs a long parameter with the given optionID, and parameter constraint.
LongParameter(OptionID optionID, List<ParameterConstraint<Number>> constraints, long defaultValue)
          Constructs a long parameter with the given optionID, parameter constraint and default value.
LongParameter(OptionID optionID, long defaultValue)
          Constructs a long parameter with the given optionID and default value.
LongParameter(OptionID optionID, ParameterConstraint<Number> constraint)
          Constructs a long parameter with the given optionID, and parameter constraint.
LongParameter(OptionID optionID, ParameterConstraint<Number> constraint, boolean optional)
          Constructs a long parameter with the given optionID, and parameter constraint.
LongParameter(OptionID optionID, ParameterConstraint<Number> constraint, long defaultValue)
          Constructs a long parameter with the given optionID, parameter constraint and default value.
NumberParameter(OptionID optionID)
          Constructs a number parameter with the given optionID.
NumberParameter(OptionID optionID, boolean optional)
          Constructs a number parameter with the given optionID and optional flag.
NumberParameter(OptionID optionID, List<ParameterConstraint<Number>> constraints)
          Constructs a number parameter with the given optionID, and constraint.
NumberParameter(OptionID optionID, List<ParameterConstraint<Number>> constraints, boolean optional)
          Constructs a number parameter with the given optionID, constraint, and optional flag.
NumberParameter(OptionID optionID, List<ParameterConstraint<Number>> constraints, T defaultValue)
          Constructs a number parameter with the given optionID, constraint, and optional flag.
NumberParameter(OptionID optionID, ParameterConstraint<Number> constraint)
          Constructs a number parameter with the given optionID, and constraint.
NumberParameter(OptionID optionID, ParameterConstraint<Number> constraint, boolean optional)
          Constructs a number parameter with the given optionID, constraint, and optional flag.
NumberParameter(OptionID optionID, ParameterConstraint<Number> constraint, T defaultValue)
          Constructs a number parameter with the given optionID, constraint, and optional flag.
NumberParameter(OptionID optionID, T defaultValue)
          Constructs a number parameter with the given optionID and default Value.
ObjectListParameter(OptionID optionID, Class<?> restrictionClass)
          Constructor for non-optional.
ObjectListParameter(OptionID optionID, Class<?> restrictionClass, boolean optional)
          Constructor with optional flag.
ObjectParameter(OptionID optionID, Class<?> restrictionClass)
          Constructs a class parameter with the given optionID, and restriction class.
ObjectParameter(OptionID optionID, Class<?> restrictionClass, boolean optional)
          Constructs a class parameter with the given optionID, restriction class, and optional flag.
ObjectParameter(OptionID optionID, Class<?> restrictionClass, Class<?> defaultValue)
          Constructs a class parameter with the given optionID, restriction class, and default value.
ObjectParameter(OptionID optionID, Class<?> restrictionClass, T defaultValue)
          Constructs a class parameter with the given optionID, restriction class, and default value.
Parameter(OptionID optionID)
          Constructs a parameter with the given optionID.
Parameter(OptionID optionID, boolean optional)
          Constructs a parameter with the given optionID and optional flag.
Parameter(OptionID optionID, List<ParameterConstraint<S>> constraints)
          Constructs a parameter with the given optionID, and constraints.
Parameter(OptionID optionID, List<ParameterConstraint<S>> constraints, boolean optional)
          Constructs a parameter with the given optionID, constraints, and optional flag.
Parameter(OptionID optionID, List<ParameterConstraint<S>> constraints, T defaultValue)
          Constructs a parameter with the given optionID, constraints, and default value.
Parameter(OptionID optionID, ParameterConstraint<S> constraint)
          Constructs a parameter with the given optionID, and constraint.
Parameter(OptionID optionID, ParameterConstraint<S> constraint, boolean optional)
          Constructs a parameter with the given optionID, constraint, and optional flag.
Parameter(OptionID optionID, ParameterConstraint<S> constraint, T defaultValue)
          Constructs a parameter with the given optionID, constraint, and default value.
Parameter(OptionID optionID, T defaultValue)
          Constructs a parameter with the given optionID and default value.
PatternParameter(OptionID optionID)
          Constructs a pattern parameter with the given optionID.
PatternParameter(OptionID optionID, boolean optional)
          Constructs a pattern parameter with the given optionID.
PatternParameter(OptionID optionID, List<ParameterConstraint<Pattern>> constraints)
          Constructs a pattern parameter with the given optionID, constraints and default value.
PatternParameter(OptionID optionID, List<ParameterConstraint<Pattern>> constraints, boolean optional)
          Constructs a pattern parameter with the given optionID, constraints and default value.
PatternParameter(OptionID optionID, List<ParameterConstraint<Pattern>> constraint, Pattern defaultValue)
          Constructs a pattern parameter with the given optionID, constraints and default value.
PatternParameter(OptionID optionID, List<ParameterConstraint<Pattern>> constraint, String defaultValue)
          Constructs a pattern parameter with the given optionID, constraints and default value.
PatternParameter(OptionID optionID, ParameterConstraint<Pattern> constraint)
          Constructs a pattern parameter with the given optionID, constraints and default value.
PatternParameter(OptionID optionID, ParameterConstraint<Pattern> constraint, boolean optional)
          Constructs a pattern parameter with the given optionID, constraints and default value.
PatternParameter(OptionID optionID, ParameterConstraint<Pattern> constraint, Pattern defaultValue)
          Constructs a pattern parameter with the given optionID, constraints and default value.
PatternParameter(OptionID optionID, ParameterConstraint<Pattern> constraint, String defaultValue)
          Constructs a pattern parameter with the given optionID, constraints and default value.
PatternParameter(OptionID optionID, Pattern defaultValue)
          Constructs a pattern parameter with the given optionID, and default value.
PatternParameter(OptionID optionID, String defaultValue)
          Constructs a pattern parameter with the given optionID, and default value.
StringParameter(OptionID optionID)
          Constructs a string parameter with the given optionID.
StringParameter(OptionID optionID, boolean optional)
          Constructs a string parameter with the given optionID.
StringParameter(OptionID optionID, List<ParameterConstraint<String>> constraints)
          Constructs a string parameter with the given optionID, constraints and default value.
StringParameter(OptionID optionID, List<ParameterConstraint<String>> constraints, boolean optional)
          Constructs a string parameter with the given optionID, constraints and default value.
StringParameter(OptionID optionID, List<ParameterConstraint<String>> constraint, String defaultValue)
          Constructs a string parameter with the given optionID, constraints and default value.
StringParameter(OptionID optionID, ParameterConstraint<String> constraint)
          Constructs a string parameter with the given optionID, constraints and default value.
StringParameter(OptionID optionID, ParameterConstraint<String> constraint, boolean optional)
          Constructs a string parameter with the given optionID, constraints and default value.
StringParameter(OptionID optionID, ParameterConstraint<String> constraint, String defaultValue)
          Constructs a string parameter with the given optionID, constraints and default value.
StringParameter(OptionID optionID, String defaultValue)
          Constructs a string parameter with the given optionID, and default value.
VectorListParameter(OptionID optionID)
          Constructs a vector list parameter with the given name and description.
VectorListParameter(OptionID optionID, boolean optional)
          Constructs a vector list parameter with the given name and description.
VectorListParameter(OptionID optionID, List<ParameterConstraint<List<List<Double>>>> constraints, boolean optional)
          Constructs a vector list parameter with the given name and description.
VectorListParameter(OptionID optionID, List<ParameterConstraint<List<List<Double>>>> constraints, List<List<Double>> defaultValue)
          Constructs a vector list parameter with the given name and description.
VectorListParameter(OptionID optionID, ParameterConstraint<List<List<Double>>> constraint)
          Constructs a vector list parameter with the given name and description.
VectorListParameter(OptionID optionID, ParameterConstraint<List<List<Double>>> constraint, boolean optional)
          Constructs a vector list parameter with the given name and description.
VectorListParameter(OptionID optionID, ParameterConstraint<List<List<Double>>> constraint, List<List<Double>> defaultValue)
          Constructs a vector list parameter with the given name and description.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.utilities.referencepoints
 

Fields in de.lmu.ifi.dbs.elki.utilities.referencepoints declared as OptionID
static OptionID GridBasedReferencePoints.GRID_ID
          Parameter to specify the grid resolution.
static OptionID GridBasedReferencePoints.GRID_SCALE_ID
          Parameter to specify the extra scaling of the space, to allow out-of-data-space reference points.
static OptionID RandomSampleReferencePoints.N_ID
          Parameter to specify the sample size.
static OptionID RandomGeneratedReferencePoints.N_ID
          Parameter to specify the number of requested reference points.
static OptionID StarBasedReferencePoints.NOCENTER_ID
          Parameter to specify the grid resolution.
static OptionID RandomGeneratedReferencePoints.SCALE_ID
          Parameter for additional scaling of the space, to allow out-of-space reference points.
static OptionID StarBasedReferencePoints.SCALE_ID
          Parameter to specify the extra scaling of the space, to allow out-of-data-space reference points.
static OptionID AxisBasedReferencePoints.SPACE_SCALE_ID
          Parameter to specify the extra scaling of the space, to allow out-of-data-space reference points.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.utilities.scaling
 

Fields in de.lmu.ifi.dbs.elki.utilities.scaling declared as OptionID
static OptionID GammaScaling.GAMMA_ID
          OptionID for the gamma value.
static OptionID ClipScaling.MAX_ID
          Parameter to specify the maximum value Key: -clipscale.max
static OptionID ClipScaling.MIN_ID
          Parameter to specify a fixed minimum to use.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.utilities.scaling.outlier
 

Fields in de.lmu.ifi.dbs.elki.utilities.scaling.outlier declared as OptionID
static OptionID TopKOutlierScaling.BINARY_ID
          Parameter to specify the lambda value Key: -topk.binary
static OptionID TopKOutlierScaling.K_ID
          Parameter to specify the number of outliers to keep Key: -topk.k
static OptionID StandardDeviationScaling.LAMBDA_ID
          Parameter to specify the lambda value Key: -stddevscale.lambda
static OptionID SqrtStandardDeviationScaling.LAMBDA_ID
          Parameter to specify the lambda value Key: -sqrtstddevscale.lambda
static OptionID OutlierLinearScaling.MAX_ID
          Parameter to specify the maximum value Key: -linearscale.max
static OptionID OutlierSqrtScaling.MAX_ID
          Parameter to specify the fixed maximum to use.
static OptionID OutlierLinearScaling.MEAN_ID
          Flag to use the mean as minimum for scaling.
static OptionID StandardDeviationScaling.MEAN_ID
          Parameter to specify a fixed mean to use.
static OptionID SqrtStandardDeviationScaling.MEAN_ID
          Parameter to specify a fixed mean to use.
static OptionID OutlierLinearScaling.MIN_ID
          Parameter to specify a fixed minimum to use.
static OptionID OutlierSqrtScaling.MIN_ID
          Parameter to specify the fixed minimum to use.
static OptionID SqrtStandardDeviationScaling.MIN_ID
          Parameter to specify the fixed minimum to use.
static OptionID OutlierGammaScaling.NORMALIZE_ID
          Normalization flag.
static OptionID OutlierLinearScaling.NOZEROS_ID
          Flag to use ignore zeros when computing the min and max.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.visualization
 

Fields in de.lmu.ifi.dbs.elki.visualization declared as OptionID
static OptionID VisualizerParameterizer.HIDEVIS_ID
          Parameter to disable visualizers Key: -vis.hide Default: default properties file
static OptionID VisualizerParameterizer.STYLELIB_ID
          Parameter to get the style properties file.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.visualization.gui
 

Fields in de.lmu.ifi.dbs.elki.visualization.gui declared as OptionID
static OptionID ResultVisualizer.WINDOW_TITLE_ID
          Parameter to specify the window title Key: -vis.window.title Default value: "ELKI Result Visualization"
 

Uses of OptionID in de.lmu.ifi.dbs.elki.visualization.projector
 

Fields in de.lmu.ifi.dbs.elki.visualization.projector declared as OptionID
static OptionID ScatterPlotFactory.Parameterizer.MAXDIM_ID
          Parameter for the maximum number of dimensions, Code: -vis.maxdim
 

Uses of OptionID in de.lmu.ifi.dbs.elki.visualization.visualizers.vis1d
 

Fields in de.lmu.ifi.dbs.elki.visualization.visualizers.vis1d declared as OptionID
static OptionID P1DHistogramVisualizer.Factory.HISTOGRAM_BINS_ID
          Parameter to specify the number of bins to use in histogram.
static OptionID P1DHistogramVisualizer.Factory.STYLE_CURVES_ID
          Flag to specify the "curves" rendering style.
 

Uses of OptionID in de.lmu.ifi.dbs.elki.visualization.visualizers.vis2d
 

Fields in de.lmu.ifi.dbs.elki.visualization.visualizers.vis2d declared as OptionID
static OptionID TooltipScoreVisualization.Factory.DIGITS_ID
          Parameter for the gamma-correction.
static OptionID TreeMBRVisualization.Factory.FILL_ID
          Flag for half-transparent filling of bubbles.
static OptionID BubbleVisualization.Factory.FILL_ID
          Flag for half-transparent filling of bubbles.
static OptionID SelectionCubeVisualization.Factory.NOFILL_ID
          Flag for half-transparent filling of selection cubes.
static OptionID BubbleVisualization.Factory.SCALING_ID
          Parameter for scaling functions Key: -bubble.scaling
 


Release 0.4.0 (2011-09-20_1324)