diff --git a/doc/allclasses-index.html b/doc/allclasses-index.html index 9a1b2ea..5c06ab0 100644 --- a/doc/allclasses-index.html +++ b/doc/allclasses-index.html @@ -1,11 +1,11 @@ - + All Classes and Interfaces - + @@ -60,25 +60,17 @@

All Classes and Interfaces<
Class
Description
- +
-
Implementation of the Runnable interface to execute threaded allele analysis to infer proteoforms.
-
- -
-
Comprises static methods used to solve specifically bioinformatics problems.
-
- -
-
Enum to store different modes to handle prefix gaps for global sequence alignment.
+
Implements static methods for allele analysis to infer proteoforms.
-
Parse parameters for the `build` task from a HashMap.
+
Parse parameters for `build` task.
-
This class comprises static methods used for calling command line commands.
+
Implements static methods to run command line commands.
@@ -86,20 +78,28 @@

All Classes and Interfaces<

-
Comprises static methods to compress String content using the `brotli4j` library.
+
Implements static methods to compress String content using the `brotli4j` library.
- +
-
Container to store representation of a reference sequence location that is subject to analysis.
+
Collection of common property keys used for annotations.
- +
-
Extension of the Feature class to represent coding features.
+
Container to store representation of a reference sequence location that is subject to analysis.
- +
+
Extension of the Feature class to represent coding features.
+
+ +
Container to store a biological variation of a feature, i.e., an allele of a gene or proteoform of a protein.
+ +
+
Interface for meta-information storage.
+
This class comprises static methods used for reading and writing files.
@@ -113,50 +113,58 @@

All Classes and Interfaces<
Main class of MUSIAL (MUlti Sample varIant AnaLysis), a tool to calculate SNV, gene, and whole genome alignments, together with other relevant statistics based on vcf files.

- -
-
Collection of common property keys used for annotations.
-
- -
+ +
Exception thrown if any data generation or storage process is incorrect in the context of the software, e.g. gene features with negative lengths.
- -
+ +
Main data structure to store information about variants wrt. features and samples.
- + +
+
Factory class for MusialStorage instances.
+
+
-
Comprises static methods to analyze samples in order to build a MUSIAL storage.
+
Stores parameters used for variant call filtering.
- +
-
Stores parameters used for variant call filtering.
+
Interface for sample occurrence storage.
- -
-
Enum specifying tasks of MUSIAL to choose from.
+ +
+
Representation of a sample, i.e., variant calls from a single biological sample.
- +
-
Internal representation of a sample, i.e., a set of variant calls from a single biological sample.
+
Implements static methods to run sample/.vcf analysis.
- +
-
Implementation of the Runnable interface to execute threaded sample analysis.
+
Implements static methods for sequence operations, such as inversion, translation, and alignment.
- -
-
Runs SnpEff locally via command line.
+ +
+
Enum to store different modes to handle prefix gaps for global sequence alignment.
+
+ +
+
Implements static methods to run SnpEff locally via command line.
+
+ +
+
Enum specifying tasks of MUSIAL to choose from.
-
This class comprises static methods used for validating input data.
+
Implements static methods used for validating input parameters.
- +
-
Container to store annotations of a single variant.
+
Container to store annotations and information of a single variant on a feature.
diff --git a/doc/allpackages-index.html b/doc/allpackages-index.html index 5ecc8ab..fbba1f1 100644 --- a/doc/allpackages-index.html +++ b/doc/allpackages-index.html @@ -1,11 +1,11 @@ - + All Packages - + @@ -70,12 +70,8 @@

All Packages

Comprises the main class of MUSIAL.
- +
-
Comprises classes that implement the Runnable interface and are used to execute multithreaded tasks.
-
- -
Comprises classes that mainly implement static methods, which are used by MUSIAL modules.
diff --git a/doc/cli/BuildConfiguration.html b/doc/cli/BuildConfiguration.html index f7cbb5f..40845ff 100644 --- a/doc/cli/BuildConfiguration.html +++ b/doc/cli/BuildConfiguration.html @@ -1,11 +1,11 @@ - + BuildConfiguration - + @@ -78,7 +78,7 @@

Class BuildConfiguration


public final class BuildConfiguration extends Object
-
Parse parameters for the `build` task from a HashMap.
+
Parse parameters for `build` task.
Since:
2.1
@@ -105,65 +105,50 @@

Field Summary

Optional positions to exclude from the analysis.
- + - +
-
Maximum allele frequency (with respect to reads) in order to call heterozygous SNVs.
+
Minimum (read) coverage in order to accept an allele.
- +
-
Minimum (read) coverage in order to call an SNV.
+
Minimum allele frequency (with respect to reads) in order to accept an allele.
- - -
-
Minimum allele frequency (with respect to reads) in order to call heterozygous SNVs.
-
- - -
-
Minimum allele frequency (with respect to reads) in order to call an SNV.
-
- - + +
-
Minimum quality, i.e. the value given in the QUAL field of .vcf files, in order to call an SNV.
-
- - -
File object specifying the output directory.
-
org.biojava.nbio.genome.parsers.gff.FeatureList
- -
+
org.biojava.nbio.genome.parsers.gff.FeatureList
+ +
FeatureList object specifying the reference genome features.
- - -
+ + +
File object pointing to the reference features file.
-
htsjdk.samtools.reference.IndexedFastaSequenceFile
- -
+
htsjdk.samtools.reference.IndexedFastaSequenceFile
+ +
BlockCompressedIndexedFastaSequenceFile object providing the compressed indexed reference genome sequence.
- - -
+ + +
File object pointing to the reference genome sequence file.
- - - @@ -195,11 +180,10 @@

Method Summary

Method
Description
private void
-
addFeature(String name, +
addFeature(String name, String matchKey, String matchValue, - File pdbFile, - boolean asCds, + boolean coding, Map<String,String> annotations)
Initializes a Feature object with the specified parameters and adds it to the features list.
@@ -229,38 +213,53 @@

Methods inherited from cl

Field Details

  • -
    -

    minimalCoverage

    -
    public Double minimalCoverage
    -
    Minimum (read) coverage in order to call an SNV.
    +
    +

    samples

    +
    public final HashMap<String,Sample> samples
    + +
    +
  • +
  • +
    +

    features

    +
    public final HashMap<String,Feature> features
    +
  • -
    -

    minimalHomozygousFrequency

    -
    public Double minimalHomozygousFrequency
    -
    Minimum allele frequency (with respect to reads) in order to call an SNV.
    +
    +

    excludedPositions

    +
    public final HashMap<String,TreeSet<Integer>> excludedPositions
    +
    Optional positions to exclude from the analysis.
  • -
    -

    minimalHeterozygousFrequency

    -
    public Double minimalHeterozygousFrequency
    -
    Minimum allele frequency (with respect to reads) in order to call heterozygous SNVs.
    +
    +

    EXCEPTION_PREFIX

    +
    private final String EXCEPTION_PREFIX
    +
    Prefix to use for exception messages.
    +
    +
    See Also:
    +
    + +
    +
  • -
    -

    maximalHeterozygousFrequency

    -
    public Double maximalHeterozygousFrequency
    -
    Maximum allele frequency (with respect to reads) in order to call heterozygous SNVs.
    +
    +

    minimalCoverage

    +
    public Double minimalCoverage
    +
    Minimum (read) coverage in order to accept an allele.
  • -
    -

    minimalQuality

    -
    public Double minimalQuality
    -
    Minimum quality, i.e. the value given in the QUAL field of .vcf files, in order to call an SNV.
    +
    +

    minimalFrequency

    +
    public Double minimalFrequency
    +
    Minimum allele frequency (with respect to reads) in order to accept an allele.
  • @@ -292,48 +291,12 @@

    referenceFeatures

  • -
    -

    samples

    -
    public final ConcurrentSkipListMap<String,Sample> samples
    - -
    -
  • -
  • -
    -

    features

    -
    public final ConcurrentSkipListMap<String,Feature> features
    - -
    -
  • -
  • output

    public File output
    File object specifying the output directory.
  • -
  • -
    -

    excludedPositions

    -
    public final HashMap<String,TreeSet<Integer>> excludedPositions
    -
    Optional positions to exclude from the analysis.
    -
    -
  • -
  • -
    -

    EXCEPTION_PREFIX

    -
    private final String EXCEPTION_PREFIX
    -
    Prefix to use for exception messages.
    -
    -
    See Also:
    -
    - -
    -
    -
    -
@@ -350,7 +313,7 @@

BuildConfiguration

Constructor of the BuildConfiguration class.

Used to parse and validate command line interface input. Parsed arguments are stored - and accessible by other - components - via class properties.

+ components - as class properties.
Parameters:
parameters - LinkedTreeMap containing parameter information.
@@ -386,13 +349,12 @@

addSample

  • -
    +

    addFeature

    private void addFeature(String name, String matchKey, String matchValue, - File pdbFile, - boolean asCds, + boolean coding, Map<String,String> annotations) throws MusialException
    Initializes a Feature object with the specified parameters and adds it to the features list.
    @@ -401,8 +363,7 @@

    addFeature

    name - String; The internal name to use for the feature.
    matchKey - String; The key of the attribute in the specified .gff format reference annotation to match the feature from.
    matchValue - String; The value of the attribute in the specified .gff format reference annotation to match the feature from.
    -
    asCds - Boolean; Whether to consider feature as cds, independent of provided structure.
    -
    pdbFile - File; Optional object pointing to a .pdb format file yielding a protein structure derived for the (gene) feature.
    +
    coding - Boolean; Whether to consider feature as cds, independent of provided structure.
    annotations - HashMap of String key/pair values; feature meta information.
    Throws:
    MusialException - If the initialization of the Feature fails; If the specified .gff reference annotation or .pdb protein file can not be read; If the specified feature is not found or parsed multiple times from the reference annotation.
    diff --git a/doc/cli/CLIParametersUpdateVDict.html b/doc/cli/CLIParametersUpdateVDict.html index 0f552b5..e2fc196 100644 --- a/doc/cli/CLIParametersUpdateVDict.html +++ b/doc/cli/CLIParametersUpdateVDict.html @@ -364,7 +364,7 @@

    features

    ConcurrentSkipListMap of String, File pairs. Each key specifies one feature on the passed reference `FASTA` to be analyzed. Each assigned value points to an optional `PDB` file per feature and induces the analysis variants allocated to the protein structure; values are expected to be `null` or `""` if - variant to protein structure allocation shall not be run.
    + variantInformation to protein structure allocation shall not be run.
  • diff --git a/doc/cli/CLIParser.html b/doc/cli/CLIParser.html index 1f2064d..b98c812 100644 --- a/doc/cli/CLIParser.html +++ b/doc/cli/CLIParser.html @@ -1,11 +1,11 @@ - + CLIParser - + diff --git a/doc/cli/package-summary.html b/doc/cli/package-summary.html index 2ac4c31..02e1363 100644 --- a/doc/cli/package-summary.html +++ b/doc/cli/package-summary.html @@ -1,11 +1,11 @@ - + cli - + @@ -73,7 +73,7 @@

    Package cli

    Description
    -
    Parse parameters for the `build` task from a HashMap.
    +
    Parse parameters for `build` task.
    diff --git a/doc/cli/package-tree.html b/doc/cli/package-tree.html index b8a89a5..c24f7fb 100644 --- a/doc/cli/package-tree.html +++ b/doc/cli/package-tree.html @@ -1,11 +1,11 @@ - + cli Class Hierarchy - + diff --git a/doc/components/Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES.html b/doc/components/Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES.html index 790b75e..4cb6eb3 100644 --- a/doc/components/Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES.html +++ b/doc/components/Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES.html @@ -77,7 +77,7 @@

    En

    java.lang.Object
    java.lang.Enum<Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES> -
    utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    +
    utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    diff --git a/doc/components/Bio.html b/doc/components/Bio.html index 5fea314..665e7c0 100644 --- a/doc/components/Bio.html +++ b/doc/components/Bio.html @@ -76,7 +76,7 @@

    Class Bio

  • java.lang.Object -
    utility.Bio
    +
    utility.SequenceOperations

    @@ -283,7 +283,7 @@

    Method Summary

    Invokes the globalSequenceAlignment(java.lang.String, java.lang.String, java.util.HashMap<java.lang.Character, java.lang.Integer>, int[][], int, int, - utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES) method with pre-specified parameters for amino-acid sequence + utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES) method with pre-specified parameters for amino-acid sequence alignment.
    @@ -296,7 +296,7 @@

    Method Summary

    Invokes the globalSequenceAlignment(java.lang.String, java.lang.String, java.util.HashMap<java.lang.Character, java.lang.Integer>, int[][], int, int, - utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES) method with pre-specified parameters for nucleotide sequence + utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES) method with pre-specified parameters for nucleotide sequence alignment.
    @@ -637,7 +637,7 @@

    globalNucleotideSequenceAlignment

    Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES right_mode)
    Invokes the globalSequenceAlignment(java.lang.String, java.lang.String, java.util.HashMap<java.lang.Character, java.lang.Integer>, int[][], int, int, - utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES) method with pre-specified parameters for nucleotide sequence + utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES) method with pre-specified parameters for nucleotide sequence alignment.

    - Uses a simple substitution matrix that scores matches with 1 and mismatches with -1. @@ -664,7 +664,7 @@

    globalAminoAcidSequenceAlignment

    Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES right_mode)
    Invokes the globalSequenceAlignment(java.lang.String, java.lang.String, java.util.HashMap<java.lang.Character, java.lang.Integer>, int[][], int, int, - utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES) method with pre-specified parameters for amino-acid sequence + utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES) method with pre-specified parameters for amino-acid sequence alignment.

    - Uses the PAM120 substitution matrix.

    @@ -715,7 +715,7 @@

    getVariantsOfAlignedSequences

    java.lang.String querySequence)
    Computes variants from two aligned sequences.

    - Variants are extracted wrt. the query versus the target sequence and formatted as p@r@a, where p is the variant + Variants are extracted wrt. the query versus the target sequence and formatted as p@r@a, where p is the variantInformation position, r is the reference content and a is the single alternate alleles content..

    Parameters:
    @@ -737,10 +737,10 @@

    inferProteoform

    musialStorage.

    - The computed variants maps keys are formatted as `x+y`, where x is the 1-based indexed position in the - reference sequence at which the variant occurs and y is the 1-based indexed number of inserted positions after + reference sequence at which the variantInformation occurs and y is the 1-based indexed number of inserted positions after this position. - The computed variants maps values are the respective single letter code amino-acid contents of the variants - including the content at the variant position.

    + including the content at the variantInformation position.
    Parameters:
    musialStorage - VariantsDictionary instance which content is used to infer proteoform information.
    @@ -749,7 +749,7 @@

    inferProteoform

    sId - String specifying the SampleEntry.name of the sample of which the proteoform should be inferred.
    Returns:
    -
    ConcurrentSkipListMap mapping positions to variant contents.
    +
    ConcurrentSkipListMap mapping positions to variantInformation contents.
    Throws:
    MusialBioException - If any translation procedure of nucleotide sequences fails.
    diff --git a/doc/components/IO.html b/doc/components/IO.html index d7456f5..e126472 100644 --- a/doc/components/IO.html +++ b/doc/components/IO.html @@ -484,9 +484,9 @@

    writeVcf

    Parameters:
    outputFile - File object pointing to the output vcf file.
    -
    variants - NavigableSet containing variant information, cf. method description.
    +
    variants - NavigableSet containing variantInformation information, cf. method description.
    chrom - String representing the value to use for the chromosome field of the vcf format for - each variant.
    + each variantInformation.
    diff --git a/doc/components/SnpEffAnnotator.html b/doc/components/SnpEffAnnotator.html index d36652e..73a4c24 100644 --- a/doc/components/SnpEffAnnotator.html +++ b/doc/components/SnpEffAnnotator.html @@ -76,7 +76,7 @@

    Class SnpEffAnnotator

    java.lang.Object -
    runnables.SnpEffAnnotator
    +
    utility.SnpEffAnnotator

    diff --git a/doc/components/VariantsDictionaryFactory.html b/doc/components/VariantsDictionaryFactory.html index 9713acf..c90c4b0 100644 --- a/doc/components/VariantsDictionaryFactory.html +++ b/doc/components/VariantsDictionaryFactory.html @@ -76,7 +76,7 @@

    Class VariantsDictionaryFactory

    java.lang.Object -
    utility.MusialStorageFactory
    +
    datastructure.MusialStorageFactory

    diff --git a/doc/constant-values.html b/doc/constant-values.html index f6e9c45..9a3c021 100644 --- a/doc/constant-values.html +++ b/doc/constant-values.html @@ -1,11 +1,11 @@ - + Constant Field Values - + @@ -54,7 +54,6 @@

    Contents

    @@ -81,7 +80,7 @@

    cli.*

    Value
    private final String
    -
    "\n\n build Build a local .json database (MUSIAL storage) from variant calls.\n view_features View annotated features from a built MUSIAL storage in a tabular format.\n view_samples View annotated samples from a built MUSIAL storage in a tabular format.\n view_variants View annotated variants from a built MUSIAL storage in a tabular format.\n export_table Export variants from a built MUSIAL storage into a matrix-like .tsv file.\n export_sequence Generate sequences in .fasta format from a built MUSIAL storage.\n\n\n"
    +
    "\n\n build Build a local database/MUSIAL storage (brotli compressed binary JSON format) from variant calls.\n view_features View annotated features from a built MUSIAL storage in a tabular format.\n view_samples View annotated samples from a built MUSIAL storage in a tabular format.\n view_variants View annotated variants from a built MUSIAL storage in a tabular format.\n export_table Export variants from a built MUSIAL storage into a matrix-like .tsv file.\n export_sequence Generate sequences in .fasta format from a built MUSIAL storage.\n\n\n"
    @@ -90,78 +89,115 @@

    cli.*

    main.*

    -
    -
    -

    runnables.*

    - @@ -170,32 +206,14 @@

    runnables.*

    utility.*

    diff --git a/doc/datastructure/AminoacidVariantAnnotationEntry.html b/doc/datastructure/AminoacidVariantAnnotationEntry.html index 7580a37..7430017 100644 --- a/doc/datastructure/AminoacidVariantAnnotationEntry.html +++ b/doc/datastructure/AminoacidVariantAnnotationEntry.html @@ -76,7 +76,7 @@

    Class AminoacidV
    public class AminoacidVariantAnnotationEntry
     extends java.lang.Object
    -
    Object used to store annotations for a single amino-acid variant.
    +
    Object used to store annotations for a single amino-acid variantInformation.
    Since:
    2.1
    @@ -107,14 +107,14 @@

    Field Summary

    java.util.HashMap<java.lang.String,​java.lang.String> annotations -
    HashMap of String key/value pairs specifying any information related to the variant.
    +
    HashMap of String key/value pairs specifying any information related to the variantInformation.
    java.util.concurrent.ConcurrentSkipListSet<java.lang.String> occurrence -
    ConcurrentSkipListSet of Strings indicating the occurrence of this variant.
    +
    ConcurrentSkipListSet of Strings indicating the occurrence of this variantInformation.
    @@ -169,14 +169,14 @@

    Field Details

    annotations

    public final java.util.HashMap<java.lang.String,​java.lang.String> annotations
    -
    HashMap of String key/value pairs specifying any information related to the variant.
    +
    HashMap of String key/value pairs specifying any information related to the variantInformation.
  • occurrence

    public final java.util.concurrent.ConcurrentSkipListSet<java.lang.String> occurrence
    -
    ConcurrentSkipListSet of Strings indicating the occurrence of this variant.
    +
    ConcurrentSkipListSet of Strings indicating the occurrence of this variantInformation.
  • diff --git a/doc/datastructure/Feature.html b/doc/datastructure/Feature.html index 00e261f..9bf6744 100644 --- a/doc/datastructure/Feature.html +++ b/doc/datastructure/Feature.html @@ -1,11 +1,11 @@ - + Feature - + @@ -72,8 +72,10 @@

    Class Feature

    Direct Known Subclasses:
    @@ -81,7 +83,7 @@

    Class Feature


    public class Feature -extends Object
    +extends InfoContainer
    Container to store representation of a reference sequence location that is subject to analysis. This may be the full genome, a single gene, contigs or plasmids and chromosomes.
    @@ -100,49 +102,44 @@

    Field Summary

    Modifier and Type
    Field
    Description
    -
    protected final LinkedHashMap<String,Form>
    +
    private final LinkedHashMap<String,Form>
    LinkedHashMap storing all Form instances, i.e. alleles, associated with this feature.
    -
    protected final LinkedHashMap<String,String>
    - +
    final String
    +
    -
    A LinkedHashMap yielding any meta-information String key-value pairs about this Feature.
    -
    -
    final String
    - -
    The chromosome/location of the entry on the reference, i.e., the contig or chromosome the feature is located on.
    -
    final int
    - -
    +
    final int
    + +
    The 1-based indexed end position of the feature.
    -
    final boolean
    - -
    +
    final boolean
    + +
    Indicates if the feature is located on the sense strand.
    -
    final String
    - -
    +
    final String
    + +
    The internal name of the feature.
    - - -
    + + +
    Hierarchical map structure to store variants wrt. the nucleotide sequences.
    -
    final int
    - -
    +
    final int
    + +
    The 1-based indexed starting position of the feature.
    -
    protected String
    - -
    +
    final String
    + +
    The type of this feature; Either coding or non_coding.
    @@ -157,7 +154,7 @@

    Constructor Summary

    Constructor
    Description
    Feature(String name, - String chromosome, + String contig, int start, int end, String type)
    @@ -184,85 +181,68 @@

    Method Summary

    Adds an allele, i.e., a Form instance to alleles if it not already exists.
    void
    -
    addAnnotation(String key, - String value)
    +
    addNucleotideVariant(int position, + String alt, + String ref)
    -
    Adds an annotation specified by the provided key and value to this instances annotations.
    -
    -
    void
    -
    addNucleotideVariant(int position, - String content)
    -
    Adds a nucleotide variant to this nucleotideVariants.
    - -
    getAllele(String alleleName)
    -
    + +
    getAllele(String alleleName)
    +
    Returns the Form, i.e., allele, stored with alleleName from alleles or null if it does not exist.
    -
    int
    - -
    +
    int
    + +
    Returns the number of alleles stored for this feature.
    - - -
     
    - - -
    -
    Returns the value stored under key in annotations.
    -
    - - + + +
     
    + +
    getNucleotideVariant(int pos, + String alt)
    -
    Returns all annotations of this instance.
    +
    Returns the VariantInformation stored at this instances nucleotideVariants at position and content.
    - -
    getNucleotideVariantAnnotation(int position, - String content)
    + +
    -
    Returns the VariantAnnotation stored at this instances nucleotideVariants at position and content.
    -
    - - -
    Retrieves a set of all variant positions of this Feature.
    - -
    getNucleotideVariants(int position)
    -
    -
    Returns all VariantAnnotations stored at this instances nucleotideVariants at position.
    -
    Returns a map representation of all variants of a single allele of this Feature.
    -
    boolean
    -
    hasAllele(String alleleName)
    + +
    -
    Checks whether a Form, i.e., allele is stored with alleleName in alleles.
    +
    Returns all VariantInformations stored at this instances nucleotideVariants at position.
    boolean
    - +
    hasAllele(String alleleName)
    -
    Checks whether this instance of Feature is an instance of FeatureCoding, i.e., declared as a coding feature.
    +
    Checks whether a Form, i.e., allele is stored with alleleName in alleles.
    -
    void
    -
    removeAllele(String alleleName)
    +
    boolean
    +
    -
    Removes the Form, i.e., allele, with alleleName from alleles if it exists.
    +
    Return whether this instance of Feature is declared as a coding feature.
    void
    - +
    removeAllele(String alleleName)
    -
    Removes the annotation stored at key from this instances annotations.
    +
    Removes the Form, i.e., allele, with alleleName from alleles if it exists.
    +

    Methods inherited from class datastructure.InfoContainer

    +addInfo, getInfo, getInfoKeys, getInfoSet, hasInfoKey, removeInfo
    +

    Methods inherited from class java.lang.Object

    clone, equals, getClass, hashCode, notify, notifyAll, toString, wait, wait, wait
    @@ -279,7 +259,7 @@

    Field Details

  • type

    -
    protected String type
    +
    public final String type
    The type of this feature; Either coding or non_coding. This value is used to distinguish Feature from FeatureCoding instances during parsing an existing MUSIAL storage JSON file.
    @@ -292,9 +272,9 @@

    name

  • -
    -

    chromosome

    -
    public final String chromosome
    +
    +

    contig

    +
    public final String contig
    The chromosome/location of the entry on the reference, i.e., the contig or chromosome the feature is located on.
  • @@ -322,21 +302,14 @@

    isSense

  • alleles

    -
    protected final LinkedHashMap<String,Form> alleles
    +
    private final LinkedHashMap<String,Form> alleles
    LinkedHashMap storing all Form instances, i.e. alleles, associated with this feature.
  • -
    -

    annotations

    -
    protected final LinkedHashMap<String,String> annotations
    -
    A LinkedHashMap yielding any meta-information String key-value pairs about this Feature.
    -
    -
  • -
  • nucleotideVariants

    - +
    private final TreeMap<Integer,LinkedHashMap<String,VariantInformation>> nucleotideVariants
    Hierarchical map structure to store variants wrt. the nucleotide sequences. The first layer represents the position on the chromosome. The second layer represents the variant content.
    @@ -353,7 +326,7 @@

    Constructor Details

    Feature

    public Feature(String name, - String chromosome, + String contig, int start, int end, String type) @@ -362,8 +335,8 @@

    Feature

    Parameters:
    name - String representing the internal name of the reference feature to analyze.
    -
    chromosome - String the name of the reference location (contig, chromosome, plasmid) the feature - is located on.
    +
    contig - String the name of the reference location (contig, chromosome, plasmid) the feature + is located on.
    start - Integer The 1-based indexed starting position of the feature on the reference.
    end - Integer The 1-based indexed end position of the feature on the reference.
    Throws:
    @@ -383,7 +356,7 @@

    Method Details

    isCoding

    public boolean isCoding()
    -
    Checks whether this instance of Feature is an instance of FeatureCoding, i.e., declared as a coding feature.
    +
    Return whether this instance of Feature is declared as a coding feature.
    Returns:
    True if this is instance of FeatureCoding.
    @@ -460,107 +433,58 @@

    getAlleleNameIterator

  • -
    -

    addAnnotation

    -
    public void addAnnotation(String key, - String value)
    -
    Adds an annotation specified by the provided key and value to this instances annotations.
    -
    -
    Parameters:
    -
    key - String key of the annotation.
    -
    value - String value of the annotation.
    -
    -
    -
  • -
  • -
    -

    removeAnnotation

    -
    public void removeAnnotation(String key)
    -
    Removes the annotation stored at key from this instances annotations.
    -
    -
    Parameters:
    -
    key - String key value of the annotation to remove.
    -
    -
    -
  • -
  • -
    -

    getAnnotation

    -
    public String getAnnotation(String key)
    -
    Returns the value stored under key in annotations.
    -
    -
    Parameters:
    -
    key - String key of the annotation.
    -
    Returns:
    -
    The value of the annotation.
    -
    -
    -
  • -
  • -
    -

    getAnnotations

    -
    public Set<Map.Entry<String,String>> getAnnotations()
    -
    Returns all annotations of this instance.
    -
    -
    Returns:
    -
    Set of all annotations.
    -
    -
    -
  • -
  • -
    +

    addNucleotideVariant

    public void addNucleotideVariant(int position, - String content)
    + String alt, + String ref)
    Adds a nucleotide variant to this nucleotideVariants.
    Parameters:
    position - The position of the variant.
    -
    content - The alternative content of the variant.
    +
    alt - The alternative content of the variant.
    +
    ref - The reference content of the variant.
  • -
    -

    getNucleotideVariantAnnotation

    -
    public VariantAnnotation getNucleotideVariantAnnotation(int position, - String content)
    -
    Returns the VariantAnnotation stored at this instances nucleotideVariants at position and content.
    +
    +

    getNucleotideVariant

    +
    public VariantInformation getNucleotideVariant(int pos, + String alt)
    +
    Returns the VariantInformation stored at this instances nucleotideVariants at position and content.
    Parameters:
    -
    position - The position of the variant annotation to access.
    -
    content - The alternative content of the variant annotation to access.
    +
    pos - The position of the variant annotation to access.
    +
    alt - The alternative content of the variant annotation to access.
    Returns:
    -
    VariantAnnotation object.
    +
    VariantInformation object.
  • -
    -

    getNucleotideVariants

    -
    public ConcurrentSkipListMap<String,VariantAnnotation> getNucleotideVariants(int position)
    -
    Returns all VariantAnnotations stored at this instances nucleotideVariants at position.
    +
    +

    getNucleotideVariantsAt

    +
    public LinkedHashMap<String,VariantInformation> getNucleotideVariantsAt(int position)
    +
    Returns all VariantInformations stored at this instances nucleotideVariants at position.
    Parameters:
    position - The position of the variant annotations to access.
    Returns:
    -
    A map of alternative contents to VariantAnnotations.
    +
    A map of alternative contents to VariantInformations.
  • getNucleotideVariants

    -
    public TreeMap<Integer,String> getNucleotideVariants(String alleleName) - throws IOException
    +
    public TreeMap<Integer,String> getNucleotideVariants(String alleleName)
    Returns a map representation of all variants of a single allele of this Feature.
    Parameters:
    alleleName - The name of the allele.
    Returns:
    Map of variable positions to alternative base contents.
    -
    Throws:
    -
    IOException - If decoding of the internal variant representation fails.
  • diff --git a/doc/datastructure/FeatureCoding.html b/doc/datastructure/FeatureCoding.html index dd9b280..6e8b662 100644 --- a/doc/datastructure/FeatureCoding.html +++ b/doc/datastructure/FeatureCoding.html @@ -1,11 +1,11 @@ - + FeatureCoding - + @@ -72,10 +72,12 @@

    Class FeatureCoding

    java.lang.Object +
    datastructure.InfoContainer
    datastructure.Feature
    datastructure.FeatureCoding
    +

    public class FeatureCoding @@ -97,7 +99,7 @@

    Field Summary

    Modifier and Type
    Field
    Description
    - +
    Hierarchical map structure to store variants wrt. proteoforms.
    @@ -112,15 +114,10 @@

    Field Summary

    LinkedHashMap storing all Form instances, i.e. proteoforms, associated with this feature.
    -
    private String
    - -
    -
    The protein's structure in .pdb format, if this feature is a coding sequence.
    -

    Fields inherited from class datastructure.Feature

    -alleles, annotations, chromosome, end, isSense, name, nucleotideVariants, start, type
    +contig, end, isSense, name, start, type
    @@ -154,8 +151,9 @@

    Method Summary

    Method
    Description
    void
    -
    addAminoacidVariant(int position, - String content)
    +
    addAminoacidVariant(int position, + String alt, + String ref)
    Adds an aminoacid variant to this aminoacidVariants.
    @@ -164,45 +162,37 @@

    Method Summary

    Adds a proteoform, i.e., a Form instance to proteoforms if it not already exists.
    -
    VariantAnnotation
    -
    getAminoacidVariantAnnotation(int position, + +
    getAminoacidVariant(int position, String content)
    -
    Returns the VariantAnnotation stored at this instances aminoacidVariants at position and content.
    +
    Returns the VariantInformation stored at this instances aminoacidVariants at position and content.
    Retrieves a set of all variant positions of this FeatureCoding.
    - -
    getAminoacidVariants(int position)
    + +
    getAminoacidVariantsAt(int position)
    -
    Returns all VariantAnnotations stored at this instances aminoacidVariants at position.
    +
    Returns all VariantInformations stored at this instances aminoacidVariants at position.
    - -
    getAminoacidVariants(String proteoformName)
    -
    -
    Returns a map representation of all variants of a single proteoform of this FeatureCoding.
    -
    - - -
     
    - -
    getProteoform(String proteoformName)
    -
    + + +
     
    + +
    getProteoform(String proteoformName)
    +
    Returns the Form, i.e., proteoform, stored with proteoformName from proteoforms or null if it does not exist.
    -
    int
    - -
    +
    int
    + +
    Returns the number of proteoforms stored for this feature.
    - - -
     
    -
    org.biojava.nbio.structure.Structure
    - + +
     
    boolean
    hasProteoform(String proteoformName)
    @@ -219,17 +209,15 @@

    Method Summary

    Sets the specified string as the coding sequence of this instance.
    -
    void
    -
    setStructure(File pdbFile)
    -
    -
    Sets the protein structure from a pdb format file.
    -

    Methods inherited from class datastructure.Feature

    -addAllele, addAnnotation, addNucleotideVariant, getAllele, getAlleleCount, getAlleleNameIterator, getAnnotation, getAnnotations, getNucleotideVariantAnnotation, getNucleotideVariantPositions, getNucleotideVariants, getNucleotideVariants, hasAllele, isCoding, removeAllele, removeAnnotation
    +addAllele, addNucleotideVariant, getAllele, getAlleleCount, getAlleleNameIterator, getNucleotideVariant, getNucleotideVariantPositions, getNucleotideVariants, getNucleotideVariantsAt, hasAllele, isCoding, removeAllele +
    +

    Methods inherited from class datastructure.InfoContainer

    +addInfo, getInfo, getInfoKeys, getInfoSet, hasInfoKey, removeInfo

    Methods inherited from class java.lang.Object

    clone, equals, getClass, hashCode, notify, notifyAll, toString, wait, wait, wait
    @@ -245,20 +233,6 @@

    Methods inherited from cl

    Field Details

    @@ -317,22 +298,6 @@

    FeatureCoding

    Method Details

    java.lang.Object + +

    public class Form -extends Object
    +extends OccurrenceContainer
    Container to store a biological variation of a feature, i.e., an allele of a gene or proteoform of a protein.
    Since:
    @@ -95,20 +95,15 @@

    Field Summary

    Modifier and Type
    Field
    Description
    -
    private final HashMap<String,String>
    - +
    final String
    +
    -
    Stores meta-information as key-value pairs about this instance.
    +
    The internal name to use for this object.
    final String
    - +
    -
    The internal name to use for this form.
    -
    -
    private final TreeSet<String>
    - -
    -
    Stores all occurrences of this form in, e.g., variant call sets (samples) or alleles.
    +
    Variants that occur for this form in the format POS:ALT;....
    @@ -121,7 +116,8 @@

    Constructor Summary

    Constructor
    Description
    -
    Form(String name)
    +
    Form(String name, + String variants)
    Constructor of Form.
    @@ -132,55 +128,12 @@

    Constructor Summary

  • Method Summary

    -
    -
    -
    -
    -
    Modifier and Type
    -
    Method
    -
    Description
    -
    void
    -
    addAnnotation(String key, - String value)
    -
    -
    Add an annotation to this annotations.
    -
    -
    void
    -
    addOccurrence(String occurrenceName)
    -
    -
    Add an entry to this occurrence.
    -
    - - -
    -
    Query an annotation value from annotations or null, if it does not exist.
    -
    - - -
     
    -
    boolean
    - -
    -
    Check if an annotation in annotations exists.
    -
    -
    boolean
    -
    hasOccurrence(String occurrenceName)
    -
    -
    Check if an entry in occurrence exists.
    -
    -
    void
    - -
    -
    Remove an annotation from annotations, if it exists.
    -
    -
    void
    -
    removeOccurrence(String occurrenceName)
    -
    -
    Remove an entry from occurrence, if it exists.
    -
    -
    -
    -
    + +
    +

    Methods inherited from class datastructure.InfoContainer

    +addInfo, getInfo, getInfoKeys, getInfoSet, hasInfoKey, removeInfo

    Methods inherited from class java.lang.Object

    clone, equals, getClass, hashCode, notify, notifyAll, toString, wait, wait, wait
    @@ -199,21 +152,14 @@

    Field Details

    name

    public final String name
    -
    The internal name to use for this form. This attribute is inferred from the variants that define this instance.
    +
    The internal name to use for this object.
  • -
    -

    annotations

    -
    private final HashMap<String,String> annotations
    -
    Stores meta-information as key-value pairs about this instance.
    -
    -
  • -
  • -
    -

    occurrence

    -
    private final TreeSet<String> occurrence
    -
    Stores all occurrences of this form in, e.g., variant call sets (samples) or alleles.
    +
    +

    variants

    +
    public final String variants
    +
    Variants that occur for this form in the format POS:ALT;....
  • @@ -225,116 +171,15 @@

    occurrence

    Constructor Details

    - - - -
  • -
    -

    Method Details

    -
      -
    • -
      -

      addAnnotation

      -
      public void addAnnotation(String key, - String value)
      -
      Add an annotation to this annotations.
      -
      -
      Parameters:
      -
      key - Key of the annotation to add.
      -
      value - Value of the annotation to add.
      -
      -
      -
    • -
    • -
      -

      removeAnnotation

      -
      public void removeAnnotation(String key)
      -
      Remove an annotation from annotations, if it exists.
      -
      -
      Parameters:
      -
      key - Key of the annotation to remove.
      -
      -
      -
    • -
    • -
      -

      getAnnotation

      -
      public String getAnnotation(String key)
      -
      Query an annotation value from annotations or null, if it does not exist.
      -
      -
      Parameters:
      -
      key - Key of the annotation to query.
      -
      Returns:
      -
      Value of the annotation to query or null.
      -
      -
      -
    • -
    • -
      -

      hasAnnotation

      -
      public boolean hasAnnotation(String key)
      -
      Check if an annotation in annotations exists.
      -
      -
      Parameters:
      -
      key - Key of the annotation to query.
      -
      Returns:
      -
      True, if an annotation is stored with the specified key.
      -
      -
      -
    • -
    • -
      -

      addOccurrence

      -
      public void addOccurrence(String occurrenceName)
      -
      Add an entry to this occurrence.
      -
      -
      Parameters:
      -
      occurrenceName - Name of the entry to add.
      -
      -
      -
    • -
    • -
      -

      removeOccurrence

      -
      public void removeOccurrence(String occurrenceName)
      -
      Remove an entry from occurrence, if it exists.
      -
      -
      Parameters:
      -
      occurrenceName - Name of the entry to remove.
      -
      -
      -
    • -
    • -
      -

      getOccurrence

      -
      public TreeSet<String> getOccurrence()
      -
      -
      Returns:
      -
      The occurrence of this instance.
      -
      -
      -
    • -
    • -
      -

      hasOccurrence

      -
      public boolean hasOccurrence(String occurrenceName)
      -
      Check if an entry in occurrence exists.
      -
      -
      Parameters:
      -
      occurrenceName - Name of the entry to query.
      -
      Returns:
      -
      True, if an entry is stored with the specified name.
      +
      variants - Variants fingerprint for this object, i.e., sequence of POS:ALT;....
    • diff --git a/doc/datastructure/InfoContainer.html b/doc/datastructure/InfoContainer.html new file mode 100644 index 0000000..8442594 --- /dev/null +++ b/doc/datastructure/InfoContainer.html @@ -0,0 +1,287 @@ + + + + +InfoContainer + + + + + + + + + + + + + + + +
      + +
      +
      + +
      +
      Package datastructure
      +

      Class InfoContainer

      +
      +
      java.lang.Object +
      datastructure.InfoContainer
      +
      +
      +
      +
      Direct Known Subclasses:
      +
      Feature, MusialStorage, OccurrenceContainer, Sample
      +
      +
      +
      public class InfoContainer +extends Object
      +
      Interface for meta-information storage.
      +
      +
      Since:
      +
      2.3
      +
      +
      +
      + +
      +
      +
        + +
      • +
        +

        Field Details

        +
          +
        • +
          +

          info

          +
          private final HashMap<String,String> info
          +
          Stores arbitrary meta information.
          +
          +
        • +
        +
        +
      • + +
      • +
        +

        Constructor Details

        +
          +
        • +
          +

          InfoContainer

          +
          public InfoContainer()
          +
          Constructor of InfoContainer.
          +
          +
        • +
        +
        +
      • + +
      • +
        +

        Method Details

        +
          +
        • +
          +

          addInfo

          +
          public void addInfo(String key, + String value)
          +
          Add meta information (key: value) to this instance.
          +
          +
          Parameters:
          +
          key - Key under which the value is stored.
          +
          value - Value to be stored under Key.
          +
          +
          +
        • +
        • +
          +

          removeInfo

          +
          public void removeInfo(String key)
          +
          Remove meta information stored at key from this instance.
          +
          +
          Parameters:
          +
          key - Key whose value is to be deleted.
          +
          +
          +
        • +
        • +
          +

          getInfo

          +
          public String getInfo(String key)
          +
          Returns the value stored at key in this instance.
          +
          +
          Parameters:
          +
          key - Key whose value is to be returned.
          +
          Returns:
          +
          Value stored at key or null if no value is stored.
          +
          +
          +
        • +
        • +
          +

          getInfoSet

          +
          public Set<Map.Entry<String,String>> getInfoSet()
          +
          +
          Returns:
          +
          All meta information stored for this instance.
          +
          +
          +
        • +
        • +
          +

          getInfoKeys

          +
          public Set<String> getInfoKeys()
          +
          +
          Returns:
          +
          All stored keys of this instance.
          +
          +
          +
        • +
        • +
          +

          hasInfoKey

          +
          public boolean hasInfoKey(String key)
          +
          +
          Parameters:
          +
          key - Key for which it is to be checked whether it is stored.
          +
          Returns:
          +
          True, if key is stored.
          +
          +
          +
        • +
        +
        +
      • +
      +
      + +
      +
      +
      + + diff --git a/doc/datastructure/MusialStorage.html b/doc/datastructure/MusialStorage.html index 8f47899..10c74f9 100644 --- a/doc/datastructure/MusialStorage.html +++ b/doc/datastructure/MusialStorage.html @@ -1,11 +1,11 @@ - + MusialStorage - + @@ -72,12 +72,14 @@

      Class MusialStorage

  • java.lang.Object +
    datastructure.InfoContainer
    datastructure.MusialStorage
    +

    public class MusialStorage -extends Object
    +extends InfoContainer
    Main data structure to store information about variants wrt. features and samples.
    Since:
    @@ -95,7 +97,7 @@

    Field Summary

    Modifier and Type
    Field
    Description
    - +
    private final HashMap<String,TreeSet<Integer>>
    Specification of positions to exclude from the analysis per reference contig.
    @@ -105,19 +107,24 @@

    Field Summary

    Container to store maintained genomic features.
    - - +
    private final HashMap<Integer,String>
    +
    -
    Set of parameters used for filtering variant calls.
    +
    Stores already seen variants to avoid redundant form names.
    -
    htsjdk.samtools.reference.IndexedFastaSequenceFile
    - + +
    -
    Indexed reference genome.
    +
    Set of parameters used for filtering variant calls.
    -
    private final HashMap<String,Sample>
    - +
    private htsjdk.samtools.reference.IndexedFastaSequenceFile
    +
    +
    Indexed reference sequences.
    +
    +
    private final HashMap<String,Sample>
    + +
    Container to store samples, i.e., variant call sets from one biological sample.
    @@ -131,15 +138,21 @@

    Constructor Summary

    Constructor
    Description
    -
    MusialStorage(htsjdk.samtools.reference.IndexedFastaSequenceFile reference, +
    MusialStorage(htsjdk.samtools.reference.IndexedFastaSequenceFile reference, Double minimalCoverage, - Double minimalFrequency, - Double minimalHeterozygousFrequency, - Double maximalHeterozygousFrequency, - Double minimalQuality)
    + Double minimalFrequency)
    Constructor of MusialStorage.
    +
    MusialStorage(htsjdk.samtools.reference.IndexedFastaSequenceFile reference, + Double minimalCoverage, + Double minimalFrequency, + Collection<Feature> features, + Collection<Sample> samples, + HashMap<String,TreeSet<Integer>> excludedPositions)
    +
    +
    Constructor of MusialStorage.
    +
    @@ -165,7 +178,7 @@

    Method Summary

    Add an entry to this samples.
    void
    -
    dump(File outfile, +
    dump(String path, boolean compress)
    Dumps this MusialStorage instance into a .json(.br) format file.
    @@ -181,24 +194,46 @@

    Method Summary

    getFeatureNameIterator(int position)
     
    -
    int
    - + +
    getFormName(int hashKey, + String value)
    -
    Getter method for samples size.
    +
    Used to collide form names based on mapping stored in formNameCodes.
    - - +
    int
    +
    -
    Constructs the base sequence of the specified feature wrt.
    +
    Getter method for samples size.
    - - + +
    +
    Constructs the base sequence of the specified feature wrt.
    +
    + + +
    Getter method for samples.
    - - -
     
    + + +
     
    +
    boolean
    + +
    +
    Query whether a feature is stored in this instance by its name.
    +
    +
    boolean
    + +
    +
    Query whether a sample is stored in this instance by its name.
    +
    +
    boolean
    +
    isPositionExcluded(String contig, + int position)
    +
    +
    Checks whether position is excluded on contig of reference.
    +
    void
    removeFeature(String featureName)
    @@ -218,6 +253,9 @@

    Method Summary

    +

    Methods inherited from class datastructure.InfoContainer

    +addInfo, getInfo, getInfoKeys, getInfoSet, hasInfoKey, removeInfo
    +

    Methods inherited from class java.lang.Object

    clone, equals, getClass, hashCode, notify, notifyAll, toString, wait, wait, wait
    @@ -255,15 +293,22 @@

    samples

  • excludedPositions

    -
    public final HashMap<String,TreeSet<Integer>> excludedPositions
    +
    private final HashMap<String,TreeSet<Integer>> excludedPositions
    Specification of positions to exclude from the analysis per reference contig.
  • +
    +

    formNameCodes

    +
    private final transient HashMap<Integer,String> formNameCodes
    +
    Stores already seen variants to avoid redundant form names. No permanent storage in MUSIAL session.
    +
    +
  • +
  • reference

    -
    public transient htsjdk.samtools.reference.IndexedFastaSequenceFile reference
    -
    Indexed reference genome.
    +
    private transient htsjdk.samtools.reference.IndexedFastaSequenceFile reference
    +
    Indexed reference sequences. No permanent storage in MUSIAL session.
  • @@ -275,22 +320,36 @@

    reference

    Constructor Details

    • -
      +
      +

      MusialStorage

      +
      public MusialStorage(htsjdk.samtools.reference.IndexedFastaSequenceFile reference, + Double minimalCoverage, + Double minimalFrequency)
      +
      Constructor of MusialStorage.
      +
      +
      Parameters:
      +
      minimalCoverage - Double; Minimal read coverage to use for allele filtering.
      +
      minimalFrequency - Double; Minimal allele frequency to use for allele filtering.
      +
      +
      +
    • +
    • +

      MusialStorage

      public MusialStorage(htsjdk.samtools.reference.IndexedFastaSequenceFile reference, Double minimalCoverage, Double minimalFrequency, - Double minimalHeterozygousFrequency, - Double maximalHeterozygousFrequency, - Double minimalQuality)
      + Collection<Feature> features, + Collection<Sample> samples, + HashMap<String,TreeSet<Integer>> excludedPositions) + throws MusialException
    Constructor of MusialStorage.
    Parameters:
    -
    minimalCoverage - Double; Minimal read coverage to use for variant filtering.
    -
    minimalFrequency - Double; Minimal allele frequency to use for hom. variant filtering.
    -
    minimalHeterozygousFrequency - Double; Minimal allele frequency to use for het. variant filtering.
    -
    maximalHeterozygousFrequency - Double; Maximal allele frequency to use for het. variant filtering.
    -
    minimalQuality - Double; Minimal Phred scaled call quality to use for variant filtering.
    +
    minimalCoverage - Double; Minimal read coverage to use for allele filtering.
    +
    minimalFrequency - Double; Minimal allele frequency to use for allele filtering.
    +
    Throws:
    +
    MusialException
    @@ -314,6 +373,21 @@

    setReference

  • +
    +

    isPositionExcluded

    +
    public boolean isPositionExcluded(String contig, + int position)
    +
    Checks whether position is excluded on contig of reference.
    +
    +
    Parameters:
    +
    contig - Contig (name) to check fo exclusion.
    +
    position - Position to check for exclusion.
    +
    Returns:
    +
    True if position on feature featureName is excluded from the analysis.
    +
    +
    +
  • +
  • addFeature

    public void addFeature(Feature feature)
    @@ -338,6 +412,19 @@

    getFeature

  • +
    +

    hasFeature

    +
    public boolean hasFeature(String name)
    +
    Query whether a feature is stored in this instance by its name.
    +
    +
    Parameters:
    +
    name - Name of the feature to query.
    +
    Returns:
    +
    Whether the queried feature is present in this instance.
    +
    +
    +
  • +
  • getFeatureNameIterator

    public Iterator<String> getFeatureNameIterator()
    @@ -408,6 +495,19 @@

    getSample

  • +
    +

    hasSample

    +
    public boolean hasSample(String name)
    +
    Query whether a sample is stored in this instance by its name.
    +
    +
    Parameters:
    +
    name - Name of the sample to query.
    +
    Returns:
    +
    Whether the queried sample is present in this instance.
    +
    +
    +
  • +
  • getSampleNameIterator

    public Iterator<String> getSampleNameIterator()
    @@ -429,15 +529,15 @@

    getNumberOfSamples

  • -
    +

    dump

    -
    public void dump(File outfile, +
    public void dump(String path, boolean compress) throws MusialException
    Dumps this MusialStorage instance into a .json(.br) format file. The output is optionally compressed with brotli.
    Parameters:
    -
    outfile - File object pointing to the file this MusialStorage should be written to.
    +
    path - String specifying file path to which MusialStorage should be written to.
    compress - Boolean indicating whether the output file should be compressed.
    Throws:
    MusialException - If the output generation fails.
    @@ -455,6 +555,23 @@

    toVcf

  • +
  • +
    +

    getFormName

    +
    public String getFormName(int hashKey, + String value)
    +
    Used to collide form names based on mapping stored in formNameCodes. +

    + Specifically, this is used to map hash keys of variant fingerprints (see Form.variants) to human-readable names.

    +
    +
    Parameters:
    +
    hashKey - Key to store.
    +
    value - Value to store.
    +
    Returns:
    +
    Returns value or the value stored at hashKey, if present.
    +
    +
    +
  • diff --git a/doc/datastructure/MusialStorageFactory.html b/doc/datastructure/MusialStorageFactory.html new file mode 100644 index 0000000..eabd09c --- /dev/null +++ b/doc/datastructure/MusialStorageFactory.html @@ -0,0 +1,198 @@ + + + + +MusialStorageFactory + + + + + + + + + + + + + + + +
    + +
    +
    + +
    +
    Package datastructure
    +

    Class MusialStorageFactory

    +
    +
    java.lang.Object +
    datastructure.MusialStorageFactory
    +
    +
    +
    +
    public final class MusialStorageFactory +extends Object
    +
    Factory class for MusialStorage instances. Implements methods to build new or load existing instances from local files.
    +
    +
    Since:
    +
    2.0
    +
    +
    +
    + +
    +
    + +
    + +
    +
    +
    + + diff --git a/doc/datastructure/MusialStorageParameters.html b/doc/datastructure/MusialStorageParameters.html index a38f08b..6e67a80 100644 --- a/doc/datastructure/MusialStorageParameters.html +++ b/doc/datastructure/MusialStorageParameters.html @@ -1,11 +1,11 @@ - + MusialStorageParameters - + @@ -92,29 +92,14 @@

    Field Summary

    Field
    Description
    final double
    - +
    -
    The maximal het. frequency of a nucleotide variant to be accepted (extracted from the AF attribute of .vcf file format).
    +
    The minimal coverage of an allele to be accepted (extracted from the DP attribute of .vcf file format).
    final double
    - +
    -
    The minimal coverage of a nucleotide variant to be accepted (extracted from the DP attribute of .vcf file format).
    -
    -
    final double
    - -
    -
    The minimal het. frequency of a nucleotide variant to be accepted (extracted from the AF attribute of .vcf file format).
    -
    -
    final double
    - -
    -
    The minimal hom. frequency of a nucleotide variant to be accepted (extracted from the AF attribute of .vcf file format).
    -
    -
    final double
    - -
    -
    The minimal quality of a nucleotide variant to be accepted (extracted from the Phred scaled GQ attribute of .vcf file format).
    +
    The minimal frequency of an allele to be accepted (extracted from the AF attribute of .vcf file format).
    @@ -127,11 +112,8 @@

    Constructor Summary

    Constructor
    Description
    -
    MusialStorageParameters(Double minimalCoverage, - Double minimalFrequency, - Double minimalHeterozygousFrequency, - Double maximalHeterozygousFrequency, - Double minimalQuality)
    +
    MusialStorageParameters(Double minimalCoverage, + Double minimalFrequency)
    Constructor of MusialStorageParameters.
    @@ -160,35 +142,14 @@

    Field Details

    minimalCoverage

    public final double minimalCoverage
    -
    The minimal coverage of a nucleotide variant to be accepted (extracted from the DP attribute of .vcf file format).
    -
    - -
  • -
    -

    minimalHomozygousFrequency

    -
    public final double minimalHomozygousFrequency
    -
    The minimal hom. frequency of a nucleotide variant to be accepted (extracted from the AF attribute of .vcf file format).
    -
    -
  • -
  • -
    -

    minimalHeterozygousFrequency

    -
    public final double minimalHeterozygousFrequency
    -
    The minimal het. frequency of a nucleotide variant to be accepted (extracted from the AF attribute of .vcf file format).
    -
    -
  • -
  • -
    -

    maximalHeterozygousFrequency

    -
    public final double maximalHeterozygousFrequency
    -
    The maximal het. frequency of a nucleotide variant to be accepted (extracted from the AF attribute of .vcf file format).
    +
    The minimal coverage of an allele to be accepted (extracted from the DP attribute of .vcf file format).
  • -
    -

    minimalQuality

    -
    public final double minimalQuality
    -
    The minimal quality of a nucleotide variant to be accepted (extracted from the Phred scaled GQ attribute of .vcf file format).
    +
    +

    minimalFrequency

    +
    public final double minimalFrequency
    +
    The minimal frequency of an allele to be accepted (extracted from the AF attribute of .vcf file format).
  • @@ -200,21 +161,15 @@

    minimalQuality

    Constructor Details

    • -
      +

      MusialStorageParameters

      public MusialStorageParameters(Double minimalCoverage, - Double minimalFrequency, - Double minimalHeterozygousFrequency, - Double maximalHeterozygousFrequency, - Double minimalQuality)
      + Double minimalFrequency)
    Constructor of MusialStorageParameters.
    Parameters:
    -
    minimalCoverage - Double; Minimal read coverage to use for variant filtering.
    -
    minimalFrequency - Double; Minimal allele frequency to use for hom. variant filtering.
    -
    minimalHeterozygousFrequency - Double; Minimal allele frequency to use for het. variant filtering.
    -
    maximalHeterozygousFrequency - Double; Maximal allele frequency to use for het. variant filtering.
    -
    minimalQuality - Double; Minimal Phred scaled genotyping call quality to use for variant filtering.
    +
    minimalCoverage - Double; Minimal read coverage to use for allele filtering.
    +
    minimalFrequency - Double; Minimal allele frequency to use for allele filtering.
    diff --git a/doc/datastructure/NucleotideVariantAnnotationEntry.html b/doc/datastructure/NucleotideVariantAnnotationEntry.html index b0c84e8..186a04e 100644 --- a/doc/datastructure/NucleotideVariantAnnotationEntry.html +++ b/doc/datastructure/NucleotideVariantAnnotationEntry.html @@ -82,7 +82,7 @@

    Class Nucleotid
    public class NucleotideVariantAnnotationEntry
     extends java.lang.Object
    -
    Object used to store annotations for a single nucleotide variant.
    +
    Object used to store annotations for a single nucleotide variantInformation.
    Since:
    2.1
    @@ -113,14 +113,14 @@

    Field Summary

    java.util.HashMap<java.lang.String,​java.lang.String> annotations -
    HashMap of String key/value pairs specifying any information related to the variant.
    +
    HashMap of String key/value pairs specifying any information related to the variantInformation.
    java.util.concurrent.ConcurrentSkipListMap<java.lang.String,​java.lang.String> occurrence -
    ConcurrentSkipListMap of String key/value pairs indicating the occurrence of this variant.
    +
    ConcurrentSkipListMap of String key/value pairs indicating the occurrence of this variantInformation.
    @@ -202,14 +202,14 @@

    Field Details

    annotations

    public final java.util.HashMap<java.lang.String,​java.lang.String> annotations
    -
    HashMap of String key/value pairs specifying any information related to the variant.
    +
    HashMap of String key/value pairs specifying any information related to the variantInformation.
  • occurrence

    public final java.util.concurrent.ConcurrentSkipListMap<java.lang.String,​java.lang.String> occurrence
    -
    ConcurrentSkipListMap of String key/value pairs indicating the occurrence of this variant. +
    ConcurrentSkipListMap of String key/value pairs indicating the occurrence of this variantInformation.

    - Keys correspond to sample names. - Values correspond to return values of the constructSampleSpecificAnnotation(boolean, boolean, double, double, double) method.

    @@ -248,18 +248,18 @@

    constructSampleSpecificAnnotation

    double coverage)
    Constructs a String yielding information about the following properties wrt. a single sample, separated by a `|` symbol:

    - - If the variant was rejected, i.e. failed any filter criteria. - - If the variant is primary, i.e. has the highest frequency in the case of a het. variant. - - The quality of the variant call. - - The frequency wrt. coverage of the variant call. - - The total coverage at the variant site.

    + - If the variantInformation was rejected, i.e. failed any filter criteria. + - If the variantInformation is primary, i.e. has the highest frequency in the case of a het. variantInformation. + - The quality of the variantInformation call. + - The frequency wrt. coverage of the variantInformation call. + - The total coverage at the variantInformation site.
    Parameters:
    -
    rejected - Boolean whether the variant was rejected.
    -
    primary - Boolean whether the variant is a primary variant.
    -
    quality - Double; The quality of the variant call.
    -
    frequency - Double; The frequency of the variant call wrt. coverage.
    -
    coverage - Double; The total coverage at the variant site.
    +
    rejected - Boolean whether the variantInformation was rejected.
    +
    primary - Boolean whether the variantInformation is a primary variantInformation.
    +
    quality - Double; The quality of the variantInformation call.
    +
    frequency - Double; The frequency of the variantInformation call wrt. coverage.
    +
    coverage - Double; The total coverage at the variantInformation site.
    Returns:
    String; The passed parameters separated by `|` symbols.
    diff --git a/doc/datastructure/OccurrenceContainer.html b/doc/datastructure/OccurrenceContainer.html new file mode 100644 index 0000000..b44bdf0 --- /dev/null +++ b/doc/datastructure/OccurrenceContainer.html @@ -0,0 +1,265 @@ + + + + +OccurrenceContainer + + + + + + + + + + + + + + + +
    + +
    +
    + +
    +
    Package datastructure
    +

    Class OccurrenceContainer

    +
    +
    java.lang.Object +
    datastructure.InfoContainer +
    datastructure.OccurrenceContainer
    +
    +
    +
    +
    +
    Direct Known Subclasses:
    +
    Form, VariantInformation
    +
    +
    +
    public class OccurrenceContainer +extends InfoContainer
    +
    Interface for sample occurrence storage.
    +
    +
    Since:
    +
    2.3
    +
    +
    +
    + +
    +
    +
      + +
    • +
      +

      Field Details

      +
        +
      • +
        +

        occurrence

        +
        private final LinkedHashSet<String> occurrence
        +
        Set of all samples, represented by their internal name, allocated to this instance.
        +
        +
      • +
      +
      +
    • + +
    • +
      +

      Constructor Details

      +
        +
      • +
        +

        OccurrenceContainer

        +
        public OccurrenceContainer()
        +
        Constructor of OccurrenceContainer.
        +
        +
      • +
      +
      +
    • + +
    • +
      +

      Method Details

      +
        +
      • +
        +

        addOccurrence

        +
        public void addOccurrence(String sampleName)
        +
        +
        Parameters:
        +
        sampleName - Adds specified name to this instance.
        +
        +
        +
      • +
      • +
        +

        hasOccurrence

        +
        public boolean hasOccurrence(String sampleName)
        +
        +
        Parameters:
        +
        sampleName - Sample name for which the occurrence of this instance is to be checked.
        +
        Returns:
        +
        True, if sampleName is stored in this instance.
        +
        +
        +
      • +
      • +
        +

        getOccurrenceIterator

        +
        public Iterator<String> getOccurrenceIterator()
        +
        +
        Returns:
        +
        Iterator over all stored values in this instance.
        +
        +
        +
      • +
      • +
        +

        getOccurrenceSet

        +
        public LinkedHashSet<String> getOccurrenceSet()
        +
        +
        Returns:
        +
        Set view of this instance.
        +
        +
        +
      • +
      • +
        +

        getOccurrenceCount

        +
        public int getOccurrenceCount()
        +
        +
        Returns:
        +
        Size of this instance.
        +
        +
        +
      • +
      +
      +
    • +
    +
    + +
    +
    +
    + + diff --git a/doc/datastructure/Sample.html b/doc/datastructure/Sample.html index 40ad55c..60c5403 100644 --- a/doc/datastructure/Sample.html +++ b/doc/datastructure/Sample.html @@ -1,11 +1,11 @@ - + Sample - + @@ -72,13 +72,15 @@

    Class Sample


    public final class Sample -extends Object
    -
    Internal representation of a sample, i.e., a set of variant calls from a single biological sample.
    +extends InfoContainer +
    Representation of a sample, i.e., variant calls from a single biological sample.
    Since:
    2.0
    @@ -95,20 +97,30 @@

    Field Summary

    Modifier and Type
    Field
    Description
    -
    private final HashMap<String,String>
    - +
    private final LinkedHashMap<String,String>
    + +
    +
    HashMap that assigns features to alleles (names).
    +
    + + +
    +
    Hierarchical map structure to store variant calls wrt. features.
    +
    +
    final String
    +
    -
    A HashMap yielding any meta-information String key-value pairs about this Sample.
    +
    Internal name of the sample.
    -
    final String
    - +
    private final LinkedHashMap<String,String>
    +
    -
    The internal name of the sample.
    +
    HashMap that assigns features to proteoforms (names).
    final File
    -
    The vcf file that is associated with this sample from which all variant calls are parsed.
    +
    .vcf file that is associated with this sample.
    htsjdk.variant.vcf.VCFFileReader
    @@ -126,8 +138,9 @@

    Constructor Summary

    Constructor
    Description
    -
    Sample(File vcfFile, - String name)
    +
    Sample(File vcfFile, + String name, + int noFeatures)
    Constructor of Sample.
    @@ -146,40 +159,81 @@

    Method Summary

    Method
    Description
    void
    -
    addAnnotation(String key, - String value)
    +
    addVariantCall(String featureName, + int pos, + htsjdk.samtools.util.Tuple<String,Integer> call, + List<htsjdk.samtools.util.Tuple<String,Integer>> calls)
    -
    Add an annotation to this annotations.
    +
    Adds a variant call for the specified feature at the given position.
    - +
    getAllele(String featureName)
    -
    Query an annotation value from annotations or null, if it does not exist.
    +
    Returns the value set for featureName in allele or null if not set.
    - - + +
    getCallAt(String featureName, + int position)
    -
    Queries all annotation values from annotations.
    +
    Retrieves the variant call at the specified position for the given feature.
    -
    void
    - + +
    getCallVariantsStringAt(String featureName, + int position)
    -
    Initialize a VCFFileReader instance pointing to the .vcf file associated with this instance.
    +
    Retrieves the string representation of the variant call at the specified position for the given feature.
    +
    + +
    getProteoform(String featureName)
    +
    +
    Returns the value set for featureName in proteoform or null if not set.
    +
    + +
    getVariantCalls(String featureName)
    +
    +
    Retrieves the variant calls associated with the specified feature.
    void
    - + +
    +
    Initialize a VCFFileReader instance pointing to the .vcf file associated with this instance.
    +
    +
    boolean
    +
    isAmbiguousCallAt(String featureName, + int position)
    +
    +
    Checks if the variant call at the specified position for the given feature is ambiguous.
    +
    +
    boolean
    +
    isReferenceCallAt(String featureName, + int position)
    +
    Checks if the variant call at the specified position for the given feature is a reference call.
    +
    +
    void
    + +
    Closes and removes the VCFFileReader of this instance, if imputed.
    +
    void
    +
    setAllele(String featureName, + String alleleName)
    +
    +
    Sets the allele allocation of this sample for feature featureName to alleleName.
    +
    void
    - +
    setProteoform(String featureName, + String proteoformName)
    -
    Remove an annotation from annotations, if it exists.
    +
    Sets the proteoform allocation of this sample for feature featureName to alleleName.
    +

    Methods inherited from class datastructure.InfoContainer

    +addInfo, getInfo, getInfoKeys, getInfoSet, hasInfoKey, removeInfo
    +

    Methods inherited from class java.lang.Object

    clone, equals, getClass, hashCode, notify, notifyAll, toString, wait, wait, wait
    @@ -197,28 +251,47 @@

    Field Details

    name

    public final String name
    -
    The internal name of the sample.
    -
    -
  • -
  • -
    -

    annotations

    -
    private final HashMap<String,String> annotations
    -
    A HashMap yielding any meta-information String key-value pairs about this Sample.
    +
    Internal name of the sample.
  • vcfFile

    public final transient File vcfFile
    -
    The vcf file that is associated with this sample from which all variant calls are parsed.
    +
    .vcf file that is associated with this sample. No permanent storage in MUSIAL session.
    +
    +
  • +
  • +
    +

    allele

    +
    private final LinkedHashMap<String,String> allele
    +
    HashMap that assigns features to alleles (names).
    +
    +
  • +
  • +
    +

    proteoform

    +
    private final LinkedHashMap<String,String> proteoform
    +
    HashMap that assigns features to proteoforms (names).
    +
    +
  • +
  • +
    +

    calls

    + +
    Hierarchical map structure to store variant calls wrt. features. +
      +
    • First level: A Feature.name.
    • +
    • Second level: Position on feature.
    • +
    • Third level: CALL;DP;ALT:AD,... with CALL as one of N (ambiguous), ? (no coverage), or the index of the alternative call. DP, AD as defined in VCF specification (samtools.github.io/hts-specs/VCFv4.2.pdf}).
    • +
  • vcfFileReader

    public transient htsjdk.variant.vcf.VCFFileReader vcfFileReader
    -
    VCFFileReader instance pointing to the vcf file of this sample.
    +
    VCFFileReader instance pointing to the vcf file of this sample. No permanent storage in MUSIAL session.
  • @@ -230,10 +303,11 @@

    vcfFileReader

    Constructor Details

    • -
      +

      Sample

      public Sample(File vcfFile, - String name)
      + String name, + int noFeatures)
      Constructor of Sample.
      Parameters:
      @@ -272,50 +346,140 @@

      killVcfFileReader

    • -
      -

      addAnnotation

      -
      public void addAnnotation(String key, - String value)
      -
      Add an annotation to this annotations.
      +
      +

      setAllele

      +
      public void setAllele(String featureName, + String alleleName)
      +
      Sets the allele allocation of this sample for feature featureName to alleleName.
      Parameters:
      -
      key - Key of the annotation to add.
      -
      value - Value of the annotation to add.
      +
      featureName - Feature.name.
      +
      alleleName - Form.name.
    • -
      -

      removeAnnotation

      -
      public void removeAnnotation(String key)
      -
      Remove an annotation from annotations, if it exists.
      +
      +

      getAllele

      +
      public String getAllele(String featureName)
      +
      Returns the value set for featureName in allele or null if not set.
      Parameters:
      -
      key - Key of the annotation to remove.
      +
      featureName - Feature.name to retrieve Form.name associated with this sample for.
    • -
      -

      getAnnotation

      -
      public String getAnnotation(String key)
      -
      Query an annotation value from annotations or null, if it does not exist.
      +
      +

      setProteoform

      +
      public void setProteoform(String featureName, + String proteoformName)
      +
      Sets the proteoform allocation of this sample for feature featureName to alleleName.
      Parameters:
      -
      key - Key of the annotation to query.
      +
      featureName - Feature.name.
      +
      proteoformName - Form.name.
      +
      +
      +
    • +
    • +
      +

      getProteoform

      +
      public String getProteoform(String featureName)
      +
      Returns the value set for featureName in proteoform or null if not set.
      +
      +
      Parameters:
      +
      featureName - Feature.name.
      +
      +
      +
    • +
    • +
      +

      addVariantCall

      +
      public void addVariantCall(String featureName, + int pos, + htsjdk.samtools.util.Tuple<String,Integer> call, + List<htsjdk.samtools.util.Tuple<String,Integer>> calls)
      +
      Adds a variant call for the specified feature at the given position.
      +
      +
      Parameters:
      +
      featureName - The name of the feature.
      +
      pos - The position of the variant call.
      +
      call - A Tuple representing the primary variant call.
      +
      calls - A List of Tuples representing additional variant calls.
      +
      +
      +
    • +
    • +
      +

      getVariantCalls

      +
      public LinkedHashMap<Integer,String> getVariantCalls(String featureName)
      +
      Retrieves the variant calls associated with the specified feature.
      +
      +
      Parameters:
      +
      featureName - The name of the feature.
      +
      Returns:
      +
      A LinkedHashMap containing variant calls mapped by their positions.
      +
      +
      +
    • +
    • +
      +

      getCallAt

      +
      public String getCallAt(String featureName, + int position)
      +
      Retrieves the variant call at the specified position for the given feature.
      +
      +
      Parameters:
      +
      featureName - The name of the feature.
      +
      position - The position of the variant call.
      Returns:
      -
      Value of the annotation to query or null.
      +
      The variant call at the specified position, or Constants.CALL_INFO_NO_VARIANT if not present.
    • -
      -

      getAnnotations

      -
      public Set<Map.Entry<String,String>> getAnnotations()
      -
      Queries all annotation values from annotations.
      +
      +

      getCallVariantsStringAt

      +
      public String getCallVariantsStringAt(String featureName, + int position)
      +
      Retrieves the string representation of the variant call at the specified position for the given feature.
      +
      Parameters:
      +
      featureName - The name of the feature.
      +
      position - The position of the variant call.
      +
      Returns:
      +
      The string representation of the variant call at the specified position, or Constants.CALL_INFO_NO_VARIANT if not present.
      +
      +
      +
    • +
    • +
      +

      isReferenceCallAt

      +
      public boolean isReferenceCallAt(String featureName, + int position)
      +
      Checks if the variant call at the specified position for the given feature is a reference call.
      +
      +
      Parameters:
      +
      featureName - The name of the feature.
      +
      position - The position of the variant call.
      +
      Returns:
      +
      true if the variant call at the specified position is a reference call, otherwise false.
      +
      +
      +
    • +
    • +
      +

      isAmbiguousCallAt

      +
      public boolean isAmbiguousCallAt(String featureName, + int position)
      +
      Checks if the variant call at the specified position for the given feature is ambiguous.
      +
      +
      Parameters:
      +
      featureName - The name of the feature.
      +
      position - The position of the variant call.
      Returns:
      -
      Set of key/value pairs; One for each annotation stored in annotations.
      +
      true if the variant call at the specified position is ambiguous, otherwise false.
    • diff --git a/doc/datastructure/SampleEntry.html b/doc/datastructure/SampleEntry.html index aff78bb..7ba6450 100644 --- a/doc/datastructure/SampleEntry.html +++ b/doc/datastructure/SampleEntry.html @@ -135,7 +135,7 @@

      Field Summary

      -htsjdk.variant.vcf.VCFFileReader +htsjdk.variantInformation.vcf.VCFFileReader vcfFileReader
      A VCFFileReader instance pointing to the `.vcf` file of the respective sample.
      @@ -223,7 +223,7 @@

      vcfFile

    • vcfFileReader

      -
      public transient htsjdk.variant.vcf.VCFFileReader vcfFileReader
      +
      public transient htsjdk.variantInformation.vcf.VCFFileReader vcfFileReader
      A VCFFileReader instance pointing to the `.vcf` file of the respective sample.
    • diff --git a/doc/datastructure/VariantAnnotation.html b/doc/datastructure/VariantAnnotation.html index 5f7564e..221b67a 100644 --- a/doc/datastructure/VariantAnnotation.html +++ b/doc/datastructure/VariantAnnotation.html @@ -72,13 +72,13 @@

      Class VariantAnnotation

      java.lang.Object -
      datastructure.VariantAnnotation
      +
      datastructure.VariantInformation

      public class VariantAnnotation extends Object
      -
      Container to store annotations of a single variant.
      +
      Container to store annotations of a single variantInformation.
      Since:
      2.1
      @@ -98,7 +98,7 @@

      Field Summary

      -
      ConcurrentSkipListMap of String key/value pairs specifying any information related to the variant.
      +
      ConcurrentSkipListMap of String key/value pairs specifying any information related to the variantInformation.
      @@ -182,7 +182,7 @@

      Field Details

      properties

      private final ConcurrentSkipListMap<String,String> properties
      -
      ConcurrentSkipListMap of String key/value pairs specifying any information related to the variant.
      +
      ConcurrentSkipListMap of String key/value pairs specifying any information related to the variantInformation.
    diff --git a/doc/datastructure/VariantInformation.html b/doc/datastructure/VariantInformation.html new file mode 100644 index 0000000..66de668 --- /dev/null +++ b/doc/datastructure/VariantInformation.html @@ -0,0 +1,177 @@ + + + + +VariantInformation + + + + + + + + + + + + + + + +
    + +
    +
    + +
    +
    Package datastructure
    +

    Class VariantInformation

    +
    + +
    +
    +
    public class VariantInformation +extends OccurrenceContainer
    +
    Container to store annotations and information of a single variant on a feature.
    +
    +
    Since:
    +
    2.1
    +
    +
    +
    + +
    +
    +
      + +
    • +
      +

      Field Details

      +
        +
      • +
        +

        referenceContent

        +
        public final String referenceContent
        +
        The reference base content of this variant.
        +
        +
      • +
      +
      +
    • + +
    • +
      +

      Constructor Details

      +
        +
      • +
        +

        VariantInformation

        +
        public VariantInformation(String referenceContent)
        +
        Constructor of VariantInformation.
        +
        +
      • +
      +
      +
    • +
    +
    + +
    +
    +
    + + diff --git a/doc/datastructure/VariantsDictionary.html b/doc/datastructure/VariantsDictionary.html index d2579da..d5bc61a 100644 --- a/doc/datastructure/VariantsDictionary.html +++ b/doc/datastructure/VariantsDictionary.html @@ -148,7 +148,7 @@

    Field Summary

    VariantsDictionaryParameters parameters -
    Set of parameters, a VariantsDictionaryParameters instance, used for variant filtering.
    +
    Set of parameters, a VariantsDictionaryParameters instance, used for variantInformation filtering.
    @@ -243,7 +243,7 @@

    Method Summary

    double coverage, double frequency)
    -
    Adds information about a variant to variants.
    +
    Adds information about a variantInformation to variants.
    @@ -252,7 +252,7 @@

    Method Summary

    java.lang.String content, java.util.Map<java.lang.String,​java.lang.String> annotations)
    -
    Adds annotations to an existing variant.
    +
    Adds annotations to an existing variantInformation.
    @@ -320,7 +320,7 @@

    Field Details

    parameters

    public final VariantsDictionaryParameters parameters
    -
    Set of parameters, a VariantsDictionaryParameters instance, used for variant filtering.
    +
    Set of parameters, a VariantsDictionaryParameters instance, used for variantInformation filtering.
  • @@ -363,7 +363,7 @@

    chromosome

    variants

    public final java.util.concurrent.ConcurrentSkipListMap<java.lang.Integer,​java.util.concurrent.ConcurrentSkipListMap<java.lang.String,​NucleotideVariantAnnotationEntry>> variants
    Hierarchical map structure to store variants wrt. maintained features and samples. The first layer represents the - position on the chromosome. The second layer represents the variant content.
    + position on the chromosome. The second layer represents the variantInformation content.
  • @@ -416,11 +416,11 @@

    VariantsDictionary

    Constructor of VariantsDictionary.
    Parameters:
    -
    minCoverage - Double; Minimal read coverage to use for variant filtering.
    -
    minFrequency - Double; Minimal form frequency to use for hom. variant filtering.
    -
    minHet - Double; Minimal form frequency to use for het. variant filtering.
    -
    maxHet - Double; Maximal form frequency to use for het. variant filtering.
    -
    minQuality - Double; Minimal Phred scaled genotyping call quality to use for variant filtering.
    +
    minCoverage - Double; Minimal read coverage to use for variantInformation filtering.
    +
    minFrequency - Double; Minimal form frequency to use for hom. variantInformation filtering.
    +
    minHet - Double; Minimal form frequency to use for het. variantInformation filtering.
    +
    maxHet - Double; Maximal form frequency to use for het. variantInformation filtering.
    +
    minQuality - Double; Minimal Phred scaled genotyping call quality to use for variantInformation filtering.
    chromosome - String; Name of the chromosome on which maintained FeatureEntrys are located; Has to reflect the value in the used input .vcf, .fasta and .gff files.
    @@ -447,19 +447,19 @@

    addVariant

    double quality, double coverage, double frequency) -
    Adds information about a variant to variants.
    +
    Adds information about a variantInformation to variants.
    Parameters:
    -
    featureId - String; The internal name of the feature for which this variant was detected.
    +
    featureId - String; The internal name of the feature for which this variantInformation was detected.
    referencePosition - Integer; The position on the reference chromosome (1-based indexing).
    -
    variantContent - String; The alternate content of the variant; Single letter contents reflect +
    variantContent - String; The alternate content of the variantInformation; Single letter contents reflect SNVs, multi letter contents reflect SVs.
    -
    referenceContent - String; The reference content of the variant; The length in relation to the +
    referenceContent - String; The reference content of the variantInformation; The length in relation to the variantContent parameter indicates whether a SV is a insertion or deletion.
    -
    sampleId - String; The internal name of the sample of which the variant was called.
    -
    isPrimary - Boolean; Whether the variant call is a primary call, i.e. if it is the variant +
    sampleId - String; The internal name of the sample of which the variantInformation was called.
    +
    isPrimary - Boolean; Whether the variantInformation call is a primary call, i.e. if it is the variantInformation with the highest frequency.
    -
    isRejected - Boolean; Whether the variant was rejected, i.e. if it failed any filtering +
    isRejected - Boolean; Whether the variantInformation was rejected, i.e. if it failed any filtering criteria.
    quality - Double; The Phred scaled GT quality of the call.
    coverage - Double; The depth of coverage of the call.
    @@ -473,11 +473,11 @@

    addVariantAnnotation

    public void addVariantAnnotation​(int position, java.lang.String content, java.util.Map<java.lang.String,​java.lang.String> annotations)
    -
    Adds annotations to an existing variant.
    +
    Adds annotations to an existing variantInformation.
    Parameters:
    -
    position - Integer; The position at which the variant is stored.
    -
    content - String; The content of the variant.
    +
    position - Integer; The position at which the variantInformation is stored.
    +
    content - String; The content of the variantInformation.
    annotations - HashMap of String key/value pairs which reflect the annotations that shall be added.
    diff --git a/doc/datastructure/VariantsDictionaryParameters.html b/doc/datastructure/VariantsDictionaryParameters.html index be0d9a4..b02f637 100644 --- a/doc/datastructure/VariantsDictionaryParameters.html +++ b/doc/datastructure/VariantsDictionaryParameters.html @@ -76,7 +76,7 @@

    Class VariantsDicti
    public class VariantsDictionaryParameters
     extends java.lang.Object
    -
    Stores the main parameters used for variant filtering for a VariantsDictionary.
    +
    Stores the main parameters used for variantInformation filtering for a VariantsDictionary.
    Since:
    2.1
    @@ -107,35 +107,35 @@

    Field Summary

    double maxHetFrequency -
    The maximal hem. frequency of a variant to be accepted (extracted from the AF attribute of .vcf file format).
    +
    The maximal hem. frequency of a variantInformation to be accepted (extracted from the AF attribute of .vcf file format).
    double minCoverage -
    The minimal coverage of a variant to be accepted (extracted from the DP attribute of .vcf file format).
    +
    The minimal coverage of a variantInformation to be accepted (extracted from the DP attribute of .vcf file format).
    double minFrequency -
    The minimal hom. frequency of a variant to be accepted (extracted from the AF attribute of .vcf file format).
    +
    The minimal hom. frequency of a variantInformation to be accepted (extracted from the AF attribute of .vcf file format).
    double minHetFrequency -
    The minimal het. frequency of a variant to be accepted (extracted from the AF attribute of .vcf file format).
    +
    The minimal het. frequency of a variantInformation to be accepted (extracted from the AF attribute of .vcf file format).
    double minQuality -
    The minimal quality a variant to be accepted (extracted from the Phred scaled GQ attribute of .vcf file format).
    +
    The minimal quality a variantInformation to be accepted (extracted from the Phred scaled GQ attribute of .vcf file format).
    @@ -194,35 +194,35 @@

    Field Details

    minCoverage

    public final double minCoverage
    -
    The minimal coverage of a variant to be accepted (extracted from the DP attribute of .vcf file format).
    +
    The minimal coverage of a variantInformation to be accepted (extracted from the DP attribute of .vcf file format).

  • minFrequency

    public final double minFrequency
    -
    The minimal hom. frequency of a variant to be accepted (extracted from the AF attribute of .vcf file format).
    +
    The minimal hom. frequency of a variantInformation to be accepted (extracted from the AF attribute of .vcf file format).
  • minHetFrequency

    public final double minHetFrequency
    -
    The minimal het. frequency of a variant to be accepted (extracted from the AF attribute of .vcf file format).
    +
    The minimal het. frequency of a variantInformation to be accepted (extracted from the AF attribute of .vcf file format).
  • maxHetFrequency

    public final double maxHetFrequency
    -
    The maximal hem. frequency of a variant to be accepted (extracted from the AF attribute of .vcf file format).
    +
    The maximal hem. frequency of a variantInformation to be accepted (extracted from the AF attribute of .vcf file format).
  • minQuality

    public final double minQuality
    -
    The minimal quality a variant to be accepted (extracted from the Phred scaled GQ attribute of .vcf file format).
    +
    The minimal quality a variantInformation to be accepted (extracted from the Phred scaled GQ attribute of .vcf file format).
  • @@ -244,11 +244,11 @@

    VariantsDictionaryParameters

    Parameters:
    -
    minCoverage - Double; Minimal read coverage to use for variant filtering.
    -
    minFrequency - Double; Minimal form frequency to use for hom. variant filtering.
    -
    minHet - Double; Minimal form frequency to use for het. variant filtering.
    -
    maxHet - Double; Maximal form frequency to use for het. variant filtering.
    -
    minQuality - Double; Minimal Phred scaled genotyping call quality to use for variant filtering.
    +
    minCoverage - Double; Minimal read coverage to use for variantInformation filtering.
    +
    minFrequency - Double; Minimal form frequency to use for hom. variantInformation filtering.
    +
    minHet - Double; Minimal form frequency to use for het. variantInformation filtering.
    +
    maxHet - Double; Maximal form frequency to use for het. variantInformation filtering.
    +
    minQuality - Double; Minimal Phred scaled genotyping call quality to use for variantInformation filtering.
    diff --git a/doc/datastructure/package-summary.html b/doc/datastructure/package-summary.html index 1ff2c73..8b87c99 100644 --- a/doc/datastructure/package-summary.html +++ b/doc/datastructure/package-summary.html @@ -1,11 +1,11 @@ - + datastructure - + @@ -83,21 +83,33 @@

    Package datastructure

    Container to store a biological variation of a feature, i.e., an allele of a gene or proteoform of a protein.
    - +
    +
    Interface for meta-information storage.
    +
    + +
    Main data structure to store information about variants wrt. features and samples.
    + +
    +
    Factory class for MusialStorage instances.
    +
    Stores parameters used for variant call filtering.
    - +
    -
    Internal representation of a sample, i.e., a set of variant calls from a single biological sample.
    +
    Interface for sample occurrence storage.
    - +
    -
    Container to store annotations of a single variant.
    +
    Representation of a sample, i.e., variant calls from a single biological sample.
    +
    + +
    +
    Container to store annotations and information of a single variant on a feature.
    diff --git a/doc/datastructure/package-tree.html b/doc/datastructure/package-tree.html index 80b8cab..fd13c66 100644 --- a/doc/datastructure/package-tree.html +++ b/doc/datastructure/package-tree.html @@ -1,11 +1,11 @@ - + datastructure Class Hierarchy - + @@ -59,16 +59,25 @@

    Class Hierarchy

    diff --git a/doc/element-list b/doc/element-list index b246928..08e9295 100644 --- a/doc/element-list +++ b/doc/element-list @@ -2,5 +2,4 @@ cli datastructure exceptions main -runnables utility diff --git a/doc/exceptions/MusialException.html b/doc/exceptions/MusialException.html index feff44d..1a86cd0 100644 --- a/doc/exceptions/MusialException.html +++ b/doc/exceptions/MusialException.html @@ -1,11 +1,11 @@ - + MusialException - + @@ -107,7 +107,7 @@

    Constructor Summary

    Description
    -
    Constructor that accepts a String message.
    +
    Constructor that accepts a string message.
    @@ -137,7 +137,7 @@

    Constructor Details

    MusialException

    public MusialException(String message)
    -
    Constructor that accepts a String message.
    +
    Constructor that accepts a string message.
    Parameters:
    message - The message comprised by the exception.
    diff --git a/doc/exceptions/package-summary.html b/doc/exceptions/package-summary.html index 9a53b73..d07d67a 100644 --- a/doc/exceptions/package-summary.html +++ b/doc/exceptions/package-summary.html @@ -1,11 +1,11 @@ - + exceptions - + diff --git a/doc/exceptions/package-tree.html b/doc/exceptions/package-tree.html index 1e476e3..3c0e90f 100644 --- a/doc/exceptions/package-tree.html +++ b/doc/exceptions/package-tree.html @@ -1,11 +1,11 @@ - + exceptions Class Hierarchy - + diff --git a/doc/help-doc.html b/doc/help-doc.html index 3dbba03..fe44277 100644 --- a/doc/help-doc.html +++ b/doc/help-doc.html @@ -1,11 +1,11 @@ - + API Help - + diff --git a/doc/index-files/index-1.html b/doc/index-files/index-1.html index 0165ee4..200665c 100644 --- a/doc/index-files/index-1.html +++ b/doc/index-files/index-1.html @@ -1,11 +1,11 @@ - + A-Index - + @@ -50,37 +50,29 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    A

    -
    AA1_PAM250_INDEX - Static variable in class utility.Bio
    +
    AA1_PAM250_INDEX - Static variable in class utility.SequenceOperations
    Hash map mapping amino-acid one letter symbols to indices used to access substitution matrix values.
    -
    AA1TO3 - Static variable in class utility.Bio
    +
    AA1TO3 - Static variable in class utility.SequenceOperations
    Hash map mapping amino-acid one to three-letter codes.
    +
    acceptedSites - Static variable in class utility.SampleAnalyzer
    +
    +
    Container of all accepted variant sites to infer alleles.
    +
    addAllele(Form) - Method in class datastructure.Feature
    Adds an allele, i.e., a Form instance to Feature.alleles if it not already exists.
    -
    addAminoacidVariant(int, String) - Method in class datastructure.FeatureCoding
    +
    addAminoacidVariant(int, String, String) - Method in class datastructure.FeatureCoding
    Adds an aminoacid variant to this FeatureCoding.aminoacidVariants.
    -
    addAnnotation(String, String) - Method in class datastructure.Feature
    -
    -
    Adds an annotation specified by the provided key and value to this instances Feature.annotations.
    -
    -
    addAnnotation(String, String) - Method in class datastructure.Form
    -
    -
    Add an annotation to this Form.annotations.
    -
    -
    addAnnotation(String, String) - Method in class datastructure.Sample
    -
    -
    Add an annotation to this Sample.annotations.
    -
    addBuildOptions(Options) - Method in class cli.CLIParser
    Fills in cli options of the build task.
    @@ -97,22 +89,20 @@

    A

    Add an entry to this MusialStorage.features.
    -
    addFeature(String, String, String, File, boolean, Map<String, String>) - Method in class cli.BuildConfiguration
    +
    addFeature(String, String, String, boolean, Map<String, String>) - Method in class cli.BuildConfiguration
    Initializes a Feature object with the specified parameters and adds it to the features list.
    -
    addNucleotideVariant(int, String) - Method in class datastructure.Feature
    +
    addInfo(String, String) - Method in class datastructure.InfoContainer
    -
    Adds a nucleotide variant to this Feature.nucleotideVariants.
    +
    Add meta information (key: value) to this instance.
    -
    addOccurrence(String) - Method in class datastructure.Form
    +
    addNucleotideVariant(int, String, String) - Method in class datastructure.Feature
    -
    Add an entry to this Form.occurrence.
    -
    -
    addProperty(String, String) - Method in class datastructure.VariantAnnotation
    -
    -
    Puts a meta-information key/value pair into this properties.
    +
    Adds a nucleotide variant to this Feature.nucleotideVariants.
    +
    addOccurrence(String) - Method in class datastructure.OccurrenceContainer
    +
     
    addProteoform(Form) - Method in class datastructure.FeatureCoding
    Adds a proteoform, i.e., a Form instance to FeatureCoding.proteoforms if it not already exists.
    @@ -125,9 +115,9 @@

    A

    Initializes a Sample object with the specified parameters and adds it to the samples list.
    -
    addVariantCall(int, int, int, boolean, String, String, double, double, double) - Method in class runnables.SampleAnalyzer
    +
    addVariantCall(String, int, Tuple<String, Integer>, List<Tuple<String, Integer>>) - Method in class datastructure.Sample
    -
    Add information about a variant call to SampleAnalyzer.variantCalls.
    +
    Adds a variant call for the specified feature at the given position.
    addViewFeaturesOptions(Options) - Method in class cli.CLIParser
    @@ -141,62 +131,52 @@

    A

    Fills in cli options of the view variants task.
    -
    allele - Variable in class runnables.AlleleAnalyzer
    +
    allele - Variable in class datastructure.Sample
    -
    The Form to be analyzed.
    +
    HashMap that assigns features to alleles (names).
    -
    ALLELE_ANNOTATION_PROTEOFORM - Static variable in class main.MusialConstants
    -
     
    -
    AlleleAnalyzer - Class in runnables
    +
    allele - Static variable in class utility.AlleleAnalyzer
    -
    Implementation of the Runnable interface to execute threaded allele analysis to infer proteoforms.
    +
    The current allele being analyzed.
    -
    AlleleAnalyzer(FeatureCoding, Form, MusialStorage) - Constructor for class runnables.AlleleAnalyzer
    +
    AlleleAnalyzer - Class in utility
    -
    Constructor of the AlleleAnalyzer class.
    +
    Implements static methods for allele analysis to infer proteoforms.
    +
    AlleleAnalyzer() - Constructor for class utility.AlleleAnalyzer
    +
     
    alleles - Variable in class datastructure.Feature
    LinkedHashMap storing all Form instances, i.e. alleles, associated with this feature.
    -
    aminoacidVariants - Variable in class datastructure.FeatureCoding
    -
    -
    Hierarchical map structure to store variants wrt. proteoforms.
    -
    -
    annotations - Variable in class datastructure.Feature
    +
    allocateVariantsInformation() - Static method in class utility.AlleleAnalyzer
    -
    A LinkedHashMap yielding any meta-information String key-value pairs about this Feature.
    +
    Allocates variant information for the analyzed allele.
    -
    annotations - Variable in class datastructure.Form
    +
    allocateVariantsInformation() - Static method in class utility.SampleAnalyzer
    -
    Stores meta-information as key-value pairs about this instance.
    +
    Allocates variant information for the analyzed sample.
    -
    annotations - Variable in class datastructure.Sample
    -
    -
    A HashMap yielding any meta-information String key-value pairs about this Sample.
    -
    -
    ANY_AA1 - Static variable in class utility.Bio
    -
    -
    One-letter code character used to indicate the translation of an incomplete codon.
    -
    -
    ANY_AA3 - Static variable in class utility.Bio
    -
    -
    Three-letter code string used to indicate the translation of an incomplete codon.
    -
    -
    ANY_NUC - Static variable in class utility.Bio
    -
    -
    One-letter code character used to indicate any nucleotide.
    -
    -
    appendProperty(String, String) - Method in class datastructure.VariantAnnotation
    +
    aminoacidVariants - Variable in class datastructure.FeatureCoding
    -
    Appends an existing or puts a meta-information key/value pair into this properties.
    +
    Hierarchical map structure to store variants wrt. proteoforms.
    +
    ANY_AMINOACID_CHAR - Static variable in class main.Constants
    +
     
    +
    ANY_AMINOACID_STRING - Static variable in class main.Constants
    +
     
    +
    ANY_AMINOACID3_STRING - Static variable in class main.Constants
    +
     
    +
    ANY_NUCLEOTiDE_CHAR - Static variable in class main.Constants
    +
     
    +
    ANY_NUCLEOTIDE_STRING - Static variable in class main.Constants
    +
     
    arguments - Variable in class cli.CLIParser
    Arguments parsed from command line.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-10.html b/doc/index-files/index-10.html index 55c8bf6..0f70571 100644 --- a/doc/index-files/index-10.html +++ b/doc/index-files/index-10.html @@ -1,11 +1,11 @@ - + K-Index - + @@ -50,7 +50,7 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    K

    killVcfFileReader() - Method in class datastructure.Sample
    @@ -58,7 +58,7 @@

    K

    Closes and removes the VCFFileReader of this instance, if imputed.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-11.html b/doc/index-files/index-11.html index 7ba9954..5684ecf 100644 --- a/doc/index-files/index-11.html +++ b/doc/index-files/index-11.html @@ -1,11 +1,11 @@ - + L-Index - + @@ -50,7 +50,7 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    L

    LICENSE - Static variable in class main.Musial
    @@ -61,7 +61,7 @@

    L

    OS dependent line separator
    -
    load(File) - Static method in class utility.MusialStorageFactory
    +
    load(File) - Static method in class datastructure.MusialStorageFactory
    Parses an existing MusialStorage instance from a .json(.br) file.
    @@ -92,7 +92,7 @@

    L

    Print warning message with time-stamp.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-12.html b/doc/index-files/index-12.html index 7149460..736dad7 100644 --- a/doc/index-files/index-12.html +++ b/doc/index-files/index-12.html @@ -1,11 +1,11 @@ - + M-Index - + @@ -50,7 +50,7 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    M

    main - package main
    @@ -61,45 +61,21 @@

    M

    Main method of MUSIAL; loads meta-information and invokes methods dependent on the command line arguments.
    -
    maximalHeterozygousFrequency - Variable in class cli.BuildConfiguration
    -
    -
    Maximum allele frequency (with respect to reads) in order to call heterozygous SNVs.
    -
    -
    maximalHeterozygousFrequency - Variable in class datastructure.MusialStorageParameters
    -
    -
    The maximal het. frequency of a nucleotide variant to be accepted (extracted from the AF attribute of .vcf file format).
    -
    minimalCoverage - Variable in class cli.BuildConfiguration
    -
    Minimum (read) coverage in order to call an SNV.
    +
    Minimum (read) coverage in order to accept an allele.
    minimalCoverage - Variable in class datastructure.MusialStorageParameters
    -
    The minimal coverage of a nucleotide variant to be accepted (extracted from the DP attribute of .vcf file format).
    -
    -
    minimalHeterozygousFrequency - Variable in class cli.BuildConfiguration
    -
    -
    Minimum allele frequency (with respect to reads) in order to call heterozygous SNVs.
    -
    -
    minimalHeterozygousFrequency - Variable in class datastructure.MusialStorageParameters
    -
    -
    The minimal het. frequency of a nucleotide variant to be accepted (extracted from the AF attribute of .vcf file format).
    -
    -
    minimalHomozygousFrequency - Variable in class cli.BuildConfiguration
    -
    -
    Minimum allele frequency (with respect to reads) in order to call an SNV.
    -
    -
    minimalHomozygousFrequency - Variable in class datastructure.MusialStorageParameters
    -
    -
    The minimal hom. frequency of a nucleotide variant to be accepted (extracted from the AF attribute of .vcf file format).
    +
    The minimal coverage of an allele to be accepted (extracted from the DP attribute of .vcf file format).
    -
    minimalQuality - Variable in class cli.BuildConfiguration
    +
    minimalFrequency - Variable in class cli.BuildConfiguration
    -
    Minimum quality, i.e. the value given in the QUAL field of .vcf files, in order to call an SNV.
    +
    Minimum allele frequency (with respect to reads) in order to accept an allele.
    -
    minimalQuality - Variable in class datastructure.MusialStorageParameters
    +
    minimalFrequency - Variable in class datastructure.MusialStorageParameters
    -
    The minimal quality of a nucleotide variant to be accepted (extracted from the Phred scaled GQ attribute of .vcf file format).
    +
    The minimal frequency of an allele to be accepted (extracted from the AF attribute of .vcf file format).
    Musial - Class in main
    @@ -108,12 +84,6 @@

    M

    Musial() - Constructor for class main.Musial
     
    -
    MusialConstants - Class in main
    -
    -
    Collection of common property keys used for annotations.
    -
    -
    MusialConstants() - Constructor for class main.MusialConstants
    -
     
    MusialException - Exception in exceptions
    Exception thrown if any data generation or storage process is incorrect in the context of the software, e.g. gene @@ -121,37 +91,35 @@

    M

    MusialException(String) - Constructor for exception exceptions.MusialException
    -
    Constructor that accepts a String message.
    +
    Constructor that accepts a string message.
    -
    musialStorage - Variable in class runnables.AlleleAnalyzer
    +
    musialStorage - Variable in class utility.SnpEffAnnotator
    -
    The MusialStorage to transfer proteoform information to.
    +
    The MusialStorage instance to transfer annotations to.
    -
    musialStorage - Variable in class runnables.SampleAnalyzer
    -
    -
    The MusialStorage instance the sample and feature originate from.
    -
    -
    musialStorage - Variable in class runnables.SnpEffAnnotator
    -
     
    MusialStorage - Class in datastructure
    Main data structure to store information about variants wrt. features and samples.
    -
    MusialStorage(IndexedFastaSequenceFile, Double, Double, Double, Double, Double) - Constructor for class datastructure.MusialStorage
    +
    MusialStorage(IndexedFastaSequenceFile, Double, Double) - Constructor for class datastructure.MusialStorage
    Constructor of MusialStorage.
    -
    MusialStorageFactory - Class in utility
    +
    MusialStorage(IndexedFastaSequenceFile, Double, Double, Collection<Feature>, Collection<Sample>, HashMap<String, TreeSet<Integer>>) - Constructor for class datastructure.MusialStorage
    -
    Comprises static methods to analyze samples in order to build a MUSIAL storage.
    +
    Constructor of MusialStorage.
    +
    +
    MusialStorageFactory - Class in datastructure
    +
    +
    Factory class for MusialStorage instances.
    -
    MusialStorageFactory() - Constructor for class utility.MusialStorageFactory
    +
    MusialStorageFactory() - Constructor for class datastructure.MusialStorageFactory
     
    MusialStorageParameters - Class in datastructure
    Stores parameters used for variant call filtering.
    -
    MusialStorageParameters(Double, Double, Double, Double, Double) - Constructor for class datastructure.MusialStorageParameters
    +
    MusialStorageParameters(Double, Double) - Constructor for class datastructure.MusialStorageParameters
    Constructor of MusialStorageParameters.
    @@ -159,14 +127,8 @@

    M

    Description of single MUSIAL tasks used to construct help message.
    -
    MusialTasks - Enum Class in main
    -
    -
    Enum specifying tasks of MUSIAL to choose from.
    -
    -
    MusialTasks() - Constructor for enum class main.MusialTasks
    -
     
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-13.html b/doc/index-files/index-13.html index b2642a9..fb1b1c6 100644 --- a/doc/index-files/index-13.html +++ b/doc/index-files/index-13.html @@ -1,11 +1,11 @@ - + N-Index - + @@ -50,7 +50,7 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    N

    name - Variable in class datastructure.Feature
    @@ -59,28 +59,34 @@

    N

    name - Variable in class datastructure.Form
    -
    The internal name to use for this form.
    +
    The internal name to use for this object.
    name - Variable in class datastructure.Sample
    -
    The internal name of the sample.
    +
    Internal name of the sample.
    NAME - Static variable in class main.Musial
    String representing the name of the software; parsed from `/src/main/resources/info.properties`.
    +
    novelTerminations - Static variable in class utility.AlleleAnalyzer
    +
    +
    List of positions where novel terminations are found.
    +
    nucleotideVariants - Variable in class datastructure.Feature
    Hierarchical map structure to store variants wrt. the nucleotide sequences.
    -
    NUMBER_DELETIONS - Static variable in class main.MusialConstants
    +
    NUMBER_OF_AMBIGUOUS - Static variable in class main.Constants
    +
     
    +
    NUMBER_OF_DELETIONS - Static variable in class main.Constants
     
    -
    NUMBER_INSERTIONS - Static variable in class main.MusialConstants
    +
    NUMBER_OF_INSERTIONS - Static variable in class main.Constants
     
    -
    NUMBER_SUBSTITUTIONS - Static variable in class main.MusialConstants
    +
    NUMBER_OF_SUBSTITUTIONS - Static variable in class main.Constants
     
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-14.html b/doc/index-files/index-14.html index 7f6219e..889e015 100644 --- a/doc/index-files/index-14.html +++ b/doc/index-files/index-14.html @@ -1,11 +1,11 @@ - + O-Index - + @@ -50,16 +50,20 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    O

    -
    occurrence - Variable in class datastructure.Form
    +
    occurrence - Variable in class datastructure.OccurrenceContainer
    -
    Stores all occurrences of this form in, e.g., variant call sets (samples) or alleles.
    +
    Set of all samples, represented by their internal name, allocated to this instance.
    -
    ORIGINAL_ERR_STREAM - Static variable in class main.Musial
    +
    OccurrenceContainer - Class in datastructure
    -
    Original system error stream.
    +
    Interface for sample occurrence storage.
    +
    +
    OccurrenceContainer() - Constructor for class datastructure.OccurrenceContainer
    +
    +
    Constructor of OccurrenceContainer.
    ORIGINAL_OUT_STREAM - Static variable in class main.Musial
    @@ -74,7 +78,7 @@

    O

    Internal method to output view_x tasks of MUSIAL.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-15.html b/doc/index-files/index-15.html index 1cb07f4..12c1ba3 100644 --- a/doc/index-files/index-15.html +++ b/doc/index-files/index-15.html @@ -1,11 +1,11 @@ - + P-Index - + @@ -50,10 +50,10 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    P

    -
    PAM250 - Static variable in class utility.Bio
    +
    PAM250 - Static variable in class utility.SequenceOperations
    The PAM250 matrix used for alignment computation.
    @@ -61,7 +61,7 @@

    P

    Set of parameters used for filtering variant calls.
    -
    PENALIZE - Enum constant in enum class utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    +
    PENALIZE - Enum constant in enum class utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    Gaps at the end are penalized normally.
    @@ -69,24 +69,20 @@

    P

    Print CL text yielding software information.
    -
    processVariantCall(int, double, double, double, Allele, Allele, int, int) - Method in class runnables.SampleAnalyzer
    +
    processVariantContext() - Static method in class utility.SampleAnalyzer
    -
    Process a single variant call.
    +
    Processes a single variant call within the sample analysis.
    -
    properties - Variable in class datastructure.VariantAnnotation
    +
    proteoform - Variable in class datastructure.Sample
    -
    ConcurrentSkipListMap of String key/value pairs specifying any information related to the variant.
    +
    HashMap that assigns features to proteoforms (names).
    -
    PROTEOFORM_DIFFERENTIAL_SEQUENCE - Static variable in class main.MusialConstants
    -
     
    -
    PROTEOFORM_NOVEL_STOPS - Static variable in class main.MusialConstants
    -
     
    proteoforms - Variable in class datastructure.FeatureCoding
    LinkedHashMap storing all Form instances, i.e. proteoforms, associated with this feature.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-16.html b/doc/index-files/index-16.html index 474105d..a0864b7 100644 --- a/doc/index-files/index-16.html +++ b/doc/index-files/index-16.html @@ -1,11 +1,11 @@ - + R-Index - + @@ -50,31 +50,31 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    R

    readLinesFromFile(String) - Static method in class utility.IO
    Reads a file and returns its content line-wise as list.
    -
    readStructure(File) - Static method in class utility.IO
    -
    -
    Parses a Structure instance from a File pointing to a pdb file.
    -
    reference - Variable in class datastructure.MusialStorage
    -
    Indexed reference genome.
    +
    Indexed reference sequences.
    -
    REFERENCE_CONTENT - Static variable in class main.MusialConstants
    -
     
    -
    REFERENCE_ID - Static variable in class main.MusialConstants
    +
    REFERENCE_FORM_NAME - Static variable in class main.Constants
     
    +
    referenceContent - Variable in class datastructure.VariantInformation
    +
    +
    The reference base content of this variant.
    +
    referenceFeatures - Variable in class cli.BuildConfiguration
    FeatureList object specifying the reference genome features.
    -
    referenceFeatures - Variable in class runnables.SnpEffAnnotator
    -
     
    +
    referenceFeatures - Variable in class utility.SnpEffAnnotator
    +
    +
    The reference sequence features of the target .vcf file in .gff format.
    +
    referenceFeaturesFile - Variable in class cli.BuildConfiguration
    File object pointing to the reference features file.
    @@ -87,64 +87,48 @@

    R

    File object pointing to the reference genome sequence file.
    -
    referenceSequences - Variable in class runnables.SnpEffAnnotator
    -
     
    -
    removeAllele(String) - Method in class datastructure.Feature
    -
    -
    Removes the Form, i.e., allele, with alleleName from Feature.alleles if it exists.
    -
    -
    removeAnnotation(String) - Method in class datastructure.Feature
    -
    -
    Removes the annotation stored at key from this instances Feature.annotations.
    -
    -
    removeAnnotation(String) - Method in class datastructure.Form
    +
    referenceSequences - Variable in class utility.SnpEffAnnotator
    -
    Remove an annotation from Form.annotations, if it exists.
    +
    The reference sequences of the target .vcf file in .fasta format.
    -
    removeAnnotation(String) - Method in class datastructure.Sample
    +
    removeAllele(String) - Method in class datastructure.Feature
    -
    Remove an annotation from Sample.annotations, if it exists.
    +
    Removes the Form, i.e., allele, with alleleName from Feature.alleles if it exists.
    removeFeature(String) - Method in class datastructure.MusialStorage
    Removes a feature from the currently stored features.
    -
    removeOccurrence(String) - Method in class datastructure.Form
    -
    -
    Remove an entry from Form.occurrence, if it exists.
    -
    -
    removeProperty(String) - Method in class datastructure.VariantAnnotation
    +
    removeInfo(String) - Method in class datastructure.InfoContainer
    -
    Removes a meta-information key/value pair into this properties.
    +
    Remove meta information stored at key from this instance.
    removeProteoform(String) - Method in class datastructure.FeatureCoding
    Removes the Form, i.e., proteoform, with proteoformName from FeatureCoding.proteoforms if it exists.
    -
    reverseComplement(String) - Static method in class utility.Bio
    +
    reverseComplement(String) - Static method in class utility.SequenceOperations
    Returns the reverse complement of the passed nucleotide sequence.
    -
    run() - Method in class runnables.AlleleAnalyzer
    -
     
    -
    run() - Method in class runnables.SampleAnalyzer
    +
    run() - Method in class utility.SnpEffAnnotator
    -
    Run sample variant call analysis.
    +
    Runs the SnpEff variant call annotation process.
    -
    run() - Method in class runnables.SnpEffAnnotator
    +
    run(FeatureCoding, MusialStorage) - Static method in class utility.AlleleAnalyzer
    -
    Run SnpEff variant call annotation.
    +
    Runs the allele analysis for a given FeatureCoding and MusialStorage.
    -
    runCommand(String[], String, String, String) - Static method in class utility.CL
    +
    run(Sample, Iterator<String>, MusialStorage) - Static method in class utility.SampleAnalyzer
    -
    Runs a command line command from within the application.
    +
    Runs the sample analysis for a given Sample, iterator of feature names, and MusialStorage.
    -
    runnables - package runnables
    +
    runCommand(String[], String, String, String) - Static method in class utility.CL
    -
    Comprises classes that implement the Runnable interface and are used to execute multithreaded tasks.
    +
    Runs a command line command from within the application.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-17.html b/doc/index-files/index-17.html index 98daa51..f1690ce 100644 --- a/doc/index-files/index-17.html +++ b/doc/index-files/index-17.html @@ -1,11 +1,11 @@ - + S-Index - + @@ -50,64 +50,72 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    S

    -
    sample - Variable in class runnables.SampleAnalyzer
    -
    -
    The Sample to be analyzed.
    -
    Sample - Class in datastructure
    -
    Internal representation of a sample, i.e., a set of variant calls from a single biological sample.
    +
    Representation of a sample, i.e., variant calls from a single biological sample.
    -
    Sample(File, String) - Constructor for class datastructure.Sample
    +
    Sample(File, String, int) - Constructor for class datastructure.Sample
    Constructor of Sample.
    -
    SAMPLE_ANNOTATION_ALLELE_PREFIX - Static variable in class main.MusialConstants
    -
     
    -
    SAMPLE_ANNOTATION_PROTEOFORM_PREFIX - Static variable in class main.MusialConstants
    -
     
    -
    SampleAnalyzer - Class in runnables
    +
    SampleAnalyzer - Class in utility
    -
    Implementation of the Runnable interface to execute threaded sample analysis.
    -
    -
    SampleAnalyzer(Sample, Iterator<String>, MusialStorage) - Constructor for class runnables.SampleAnalyzer
    -
    -
    Constructor of the SampleAnalyzer class.
    +
    Implements static methods to run sample/.vcf analysis.
    +
    SampleAnalyzer() - Constructor for class utility.SampleAnalyzer
    +
     
    samples - Variable in class cli.BuildConfiguration
    - +
    samples - Variable in class datastructure.MusialStorage
    Container to store samples, i.e., variant call sets from one biological sample.
    +
    SequenceOperations - Class in utility
    +
    +
    Implements static methods for sequence operations, such as inversion, translation, and alignment.
    +
    +
    SequenceOperations() - Constructor for class utility.SequenceOperations
    +
     
    +
    SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES - Enum Class in utility
    +
    +
    Enum to store different modes to handle prefix gaps for global sequence alignment.
    +
    +
    setAllele(String, String) - Method in class datastructure.Sample
    +
    +
    Sets the allele allocation of this sample for feature featureName to alleleName.
    +
    setCodingSequence(String) - Method in class datastructure.FeatureCoding
    Sets the specified string as the coding sequence of this instance.
    +
    setProteoform(String, String) - Method in class datastructure.Sample
    +
    +
    Sets the proteoform allocation of this sample for feature featureName to alleleName.
    +
    setReference(IndexedFastaSequenceFile) - Method in class datastructure.MusialStorage
    Sets the reference sequence associated with this instance to the passed indexed reference feature file.
    -
    setStructure(File) - Method in class datastructure.FeatureCoding
    +
    sites - Static variable in class utility.AlleleAnalyzer
    -
    Sets the protein structure from a pdb format file.
    +
    Container of all called sites to infer alleles.
    -
    SNP_EFF_PROPERTIES - Static variable in class main.MusialConstants
    +
    SNP_EFF_INFO_KEYS - Static variable in class main.Constants
     
    -
    SNP_EFF_PROPERTY_PREFIX - Static variable in class main.MusialConstants
    +
    SNP_EFF_INFO_PREFIX - Static variable in class main.Constants
     
    -
    SnpEffAnnotator - Class in runnables
    +
    SnpEffAnnotator - Class in utility
    -
    Runs SnpEff locally via command line.
    +
    Implements static methods to run SnpEff locally via command line.
    -
    SnpEffAnnotator(File, File, File, File, MusialStorage) - Constructor for class runnables.SnpEffAnnotator
    +
    SnpEffAnnotator(File, File, File, File, MusialStorage) - Constructor for class utility.SnpEffAnnotator
    -
    Constructor of SnpEffAnnotator class.
    +
    Constructor of SnpEffAnnotator class.
    start - Variable in class datastructure.Feature
    @@ -117,12 +125,16 @@

    S

    Store start of execution time.
    -
    structure - Variable in class datastructure.FeatureCoding
    +
    storage - Static variable in class utility.AlleleAnalyzer
    +
    +
    The MusialStorage instance containing genetic variant data.
    +
    +
    storage - Static variable in class utility.SampleAnalyzer
    -
    The protein's structure in .pdb format, if this feature is a coding sequence.
    +
    The MusialStorage instance containing genetic variant data.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-18.html b/doc/index-files/index-18.html index 8e29023..80b7cc6 100644 --- a/doc/index-files/index-18.html +++ b/doc/index-files/index-18.html @@ -1,11 +1,11 @@ - + T-Index - + @@ -50,58 +50,54 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    T

    -
    targetDirectory - Variable in class runnables.SnpEffAnnotator
    -
     
    -
    targetVcf - Variable in class runnables.SnpEffAnnotator
    -
     
    -
    TASK - Static variable in class main.Musial
    +
    targetDirectory - Variable in class utility.SnpEffAnnotator
    -
    Specifies the task to execute.
    +
    The target directory for SnpEff annotation.
    -
    TERMINATION_AA1 - Static variable in class utility.Bio
    +
    targetVcf - Variable in class utility.SnpEffAnnotator
    -
    One-letter code character used to indicate a translated stop codon.
    +
    The target .vcf format file to annotate.
    -
    TERMINATION_AA3 - Static variable in class utility.Bio
    +
    TASK - Static variable in class main.Musial
    -
    Three-letter code String used to indicate a translated stop codon.
    +
    Specifies the task to execute.
    -
    THREADS - Static variable in class main.Musial
    +
    Tasks - Enum Class in main
    -
    The number of threads to use.
    +
    Enum specifying tasks of MUSIAL to choose from.
    +
    Tasks() - Constructor for enum class main.Tasks
    +
     
    +
    TERMINATION_AMINOACID_CHAR - Static variable in class main.Constants
    +
     
    +
    TERMINATION_AMINOACID_STRING - Static variable in class main.Constants
    +
     
    +
    TERMINATION_AMINOACID3_STRING - Static variable in class main.Constants
    +
     
    toVcf() - Method in class datastructure.MusialStorage
    Constructs a dummy vcf file from all variants stored in this instance.
    -
    transferAnnotation() - Method in class runnables.SnpEffAnnotator
    +
    transferAnnotation() - Method in class utility.SnpEffAnnotator
    -
    Transfer all annotations to MusialStorage.
    +
    Transfers all annotations to the MusialStorage instance.
    -
    transferAnnotation(LinkedHashMap<String, ArrayList<String>>, int, HashSet<String>, String, String) - Static method in class main.Musial
    +
    transferContent(LinkedHashMap<String, ArrayList<String>>, String, String, int) - Static method in class main.Musial
    -
    Internal method to transfers an annotation value to a container map.
    +
    Internal method to transfers a value to a container that represents column vectors of a table like object to output.
    -
    transferVariantCall(String[]) - Method in class runnables.SampleAnalyzer
    -
    -
    Transfer a single variant call to SampleAnalyzer.feature.
    -
    -
    transferVariantCalls() - Method in class runnables.SampleAnalyzer
    -
    -
    Transfer all collected variant calls to SampleAnalyzer.feature.
    -
    -
    translateCodon(String, boolean, boolean, boolean) - Static method in class utility.Bio
    +
    translateCodon(String, boolean, boolean, boolean) - Static method in class utility.SequenceOperations
    Returns an amino-acid representation of the passed `codon`.
    -
    translateNucSequence(Iterable<String>, boolean, boolean) - Static method in class utility.Bio
    +
    translateNucSequence(Iterable<String>, boolean, boolean) - Static method in class utility.SequenceOperations
    Translates a nucleotide sequence, split into codons of length three, into a single-letter amino acid sequence.
    -
    translateNucSequence(String, boolean, boolean, boolean) - Static method in class utility.Bio
    +
    translateNucSequence(String, boolean, boolean, boolean) - Static method in class utility.SequenceOperations
    Translates a nucleotide sequence into a single-letter amino acid sequence.
    @@ -109,8 +105,18 @@

    T

    The type of this feature; Either coding or non_coding.
    +
    TYPE - Static variable in class main.Constants
    +
     
    +
    TYPE_AMBIGUOUS_PREFIX - Static variable in class main.Constants
    +
     
    +
    TYPE_DELETION - Static variable in class main.Constants
    +
     
    +
    TYPE_INSERTION - Static variable in class main.Constants
    +
     
    +
    TYPE_SUBSTITUTION - Static variable in class main.Constants
    +
     
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-19.html b/doc/index-files/index-19.html index 00aea24..39e8a3b 100644 --- a/doc/index-files/index-19.html +++ b/doc/index-files/index-19.html @@ -1,11 +1,11 @@ - + U-Index - + @@ -50,15 +50,19 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    U

    +
    updateStatistics(MusialStorage) - Static method in class main.Musial
    +
    +
    Updates the statistics related to genetic variants and allele frequencies based on the data stored in the provided MusialStorage.
    +
    utility - package utility
    Comprises classes that mainly implement static methods, which are used by MUSIAL modules.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-2.html b/doc/index-files/index-2.html index 8251ac0..a5dc052 100644 --- a/doc/index-files/index-2.html +++ b/doc/index-files/index-2.html @@ -1,11 +1,11 @@ - + B-Index - + @@ -50,19 +50,9 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    B

    -
    Bio - Class in utility
    -
    -
    Comprises static methods used to solve specifically bioinformatics problems.
    -
    -
    Bio() - Constructor for class utility.Bio
    -
     
    -
    Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES - Enum Class in utility
    -
    -
    Enum to store different modes to handle prefix gaps for global sequence alignment.
    -
    brotliDecodeBytes(byte[]) - Static method in class utility.Compression
    Decompress and decode `brotli` compressed byte content.
    @@ -80,15 +70,15 @@

    B

    Compress and encode the byte content of a String using `brotli` compression and returns the byte content of the compressed data.
    -
    build(BuildConfiguration) - Static method in class main.Musial
    +
    build(BuildConfiguration) - Static method in class datastructure.MusialStorageFactory
    -
    Generates a new or updates an existing MUSIAL storage JSON file based on the specifications parsed from a build configuration JSON file.
    +
    Constructs and returns a new MusialStorage instance from the information specified by the BuildConfiguration instance.
    -
    build(BuildConfiguration) - Static method in class utility.MusialStorageFactory
    +
    build(BuildConfiguration) - Static method in class main.Musial
    -
    Constructs and returns a new MusialStorage instance from the information specified by the BuildConfiguration instance.
    +
    Generates a new or updates an existing MUSIAL storage JSON file based on the specifications parsed from a build configuration JSON file.
    -
    BUILD - Enum constant in enum class main.MusialTasks
    +
    BUILD - Enum constant in enum class main.Tasks
     
    buildConfiguration - Variable in class cli.CLIParser
    @@ -96,14 +86,14 @@

    B

    BuildConfiguration - Class in cli
    -
    Parse parameters for the `build` task from a HashMap.
    +
    Parse parameters for `build` task.
    BuildConfiguration(HashMap<String, Object>) - Constructor for class cli.BuildConfiguration
    Constructor of the BuildConfiguration class.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-20.html b/doc/index-files/index-20.html index c7440f8..f7a58b6 100644 --- a/doc/index-files/index-20.html +++ b/doc/index-files/index-20.html @@ -1,11 +1,11 @@ - + V-Index - + @@ -50,7 +50,7 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    V

    validateBuildOptions() - Method in class cli.CLIParser
    @@ -79,53 +79,53 @@

    V

    Validation - Class in utility
    -
    This class comprises static methods used for validating input data.
    +
    Implements static methods used for validating input parameters.
    Validation() - Constructor for class utility.Validation
     
    -
    valueOf(String) - Static method in enum class main.MusialTasks
    +
    valueOf(String) - Static method in enum class main.Tasks
    Returns the enum constant of this class with the specified name.
    -
    valueOf(String) - Static method in enum class utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    +
    valueOf(String) - Static method in enum class utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    Returns the enum constant of this class with the specified name.
    -
    values() - Static method in enum class main.MusialTasks
    +
    values() - Static method in enum class main.Tasks
    Returns an array containing the constants of this enum class, in the order they are declared.
    -
    values() - Static method in enum class utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    +
    values() - Static method in enum class utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    Returns an array containing the constants of this enum class, in the order they are declared.
    -
    VARIABLE_POSITIONS - Static variable in class main.MusialConstants
    +
    VARIABLE_POSITIONS_PERCENTAGE - Static variable in class main.Constants
     
    -
    VARIANT_OCCURRENCE_SAMPLE_PREFIX - Static variable in class main.MusialConstants
    -
     
    -
    VariantAnnotation - Class in datastructure
    +
    variantContext - Static variable in class utility.SampleAnalyzer
    -
    Container to store annotations of a single variant.
    +
    The VariantContext representing a genetic variant.
    -
    VariantAnnotation() - Constructor for class datastructure.VariantAnnotation
    +
    VariantInformation - Class in datastructure
    -
    Constructor of VariantAnnotation.
    +
    Container to store annotations and information of a single variant on a feature.
    -
    variantCalls - Variable in class runnables.SampleAnalyzer
    +
    VariantInformation(String) - Constructor for class datastructure.VariantInformation
    -
    A ConcurrentSkipListMap to temporarily store novel variant calls.
    +
    Constructor of VariantInformation.
    -
    variantFingerprint - Variable in class runnables.SampleAnalyzer
    +
    variantPosition - Static variable in class utility.SampleAnalyzer
    -
    Concatenation of all accepted variants of rank one to infer alleles (see Form).
    +
    The position of the genetic variant.
    +
    +
    variants - Variable in class datastructure.Form
    +
    +
    Variants that occur for this form in the format POS:ALT;....
    -
    VARIANTS - Static variable in class main.MusialConstants
    -
     
    vcfFile - Variable in class datastructure.Sample
    -
    The vcf file that is associated with this sample from which all variant calls are parsed.
    +
    .vcf file that is associated with this sample.
    vcfFileReader - Variable in class datastructure.Sample
    @@ -135,11 +135,11 @@

    V

    String representing the name of the software; parsed from `/src/main/resources/info.properties`.
    -
    VIEW_FEATURES - Enum constant in enum class main.MusialTasks
    +
    VIEW_FEATURES - Enum constant in enum class main.Tasks
     
    -
    VIEW_SAMPLES - Enum constant in enum class main.MusialTasks
    +
    VIEW_SAMPLES - Enum constant in enum class main.Tasks
     
    -
    VIEW_VARIANTS - Enum constant in enum class main.MusialTasks
    +
    VIEW_VARIANTS - Enum constant in enum class main.Tasks
     
    viewFeatures(CommandLine) - Static method in class main.Musial
    @@ -154,7 +154,7 @@

    V

    Views all variants of an existing MUSIAL storage as tsv formatted table.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-21.html b/doc/index-files/index-21.html index e0af34b..354046e 100644 --- a/doc/index-files/index-21.html +++ b/doc/index-files/index-21.html @@ -1,11 +1,11 @@ - + W-Index - + @@ -50,19 +50,15 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    W

    -
    writeFasta(File, ArrayList<Tuple<String, String>>) - Static method in class utility.IO
    -
    -
    // TODO: Fix comment.
    -
    writeFile(File, String) - Static method in class utility.IO
    Function to write a generic file with any line content.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-22.html b/doc/index-files/index-22.html new file mode 100644 index 0000000..80fedff --- /dev/null +++ b/doc/index-files/index-22.html @@ -0,0 +1,69 @@ + + + + +_-Index + + + + + + + + + + + + + + + +
    + +
    +
    +
    +

    Index

    +
    +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +

    _

    +
    +
    _featureCoding - Static variable in class utility.AlleleAnalyzer
    +
    +
    The current FeatureCoding instance to be analyzed.
    +
    +
    _sample - Static variable in class utility.SampleAnalyzer
    +
    +
    The current Sample being analyzed.
    +
    +
    +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form
    +
    +
    + + diff --git a/doc/index-files/index-3.html b/doc/index-files/index-3.html index b4d5741..92e7675 100644 --- a/doc/index-files/index-3.html +++ b/doc/index-files/index-3.html @@ -1,11 +1,11 @@ - + C-Index - + @@ -50,16 +50,22 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    C

    -
    chromosome - Variable in class datastructure.Feature
    +
    CALL_INFO_NO_INFO - Static variable in class main.Constants
    +
     
    +
    CALL_INFO_NO_VARIANT - Static variable in class main.Constants
    +
     
    +
    CALL_INFO_REJECTED - Static variable in class main.Constants
    +
     
    +
    calls - Variable in class datastructure.Sample
    -
    The chromosome/location of the entry on the reference, i.e., the contig or chromosome the feature is located on.
    +
    Hierarchical map structure to store variant calls wrt. features.
    CL - Class in utility
    -
    This class comprises static methods used for calling command line commands.
    +
    Implements static methods to run command line commands.
    CL() - Constructor for class utility.CL
     
    @@ -83,7 +89,7 @@

    C

    The translated reference DNA sequence of the entry.
    -
    CODON_MAP - Static variable in class utility.Bio
    +
    CODON_MAP - Static variable in class utility.SequenceOperations
    Hash map mapping nucleotide codons to single-letter amino acids.
    @@ -93,28 +99,34 @@

    C

    compressFile(File) - Static method in class utility.IO
    -
    Compress a target file using brotli.
    +
    DEPRECATED Compress a target file using brotli.
    Compression - Class in utility
    -
    Comprises static methods to compress String content using the `brotli4j` library.
    +
    Implements static methods to compress String content using the `brotli4j` library.
    Compression() - Constructor for class utility.Compression
     
    -
    constructVariantsTable(MusialStorage, String, HashSet<String>, String, boolean, boolean) - Static method in class main.Musial
    +
    Constants - Class in main
    -
    Internal method to construct a two-layer map structure used for export of tables and sequences.
    +
    Collection of common property keys used for annotations.
    +
    Constants() - Constructor for class main.Constants
    +
     
    CONTACT - Static variable in class main.Musial
    String representing author contact of the software; parsed from `/src/main/resources/info.properties`.
    -
    copyFile(File, File) - Static method in class utility.IO
    +
    CONTENT_MODE_AMINOACID - Static variable in class main.Constants
    +
     
    +
    CONTENT_MODE_NUCLEOTIDE - Static variable in class main.Constants
    +
     
    +
    contig - Variable in class datastructure.Feature
    -
    Copies the file pointed to with file to the file pointed to with target.
    +
    The chromosome/location of the entry on the reference, i.e., the contig or chromosome the feature is located on.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-4.html b/doc/index-files/index-4.html index 4be87e6..7c20e31 100644 --- a/doc/index-files/index-4.html +++ b/doc/index-files/index-4.html @@ -1,11 +1,11 @@ - + D-Index - + @@ -50,7 +50,7 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    D

    datastructure - package datastructure
    @@ -69,16 +69,18 @@

    D

    Accepts a File object representing a directory that is subject to deletion.
    -
    DELETION_AA1 - Static variable in class utility.Bio
    -
    -
    One-letter code character used to indicate the deletion of an amino-acid.
    -
    -
    dump(File, boolean) - Method in class datastructure.MusialStorage
    +
    DELETION_OR_GAP_3_STRING - Static variable in class main.Constants
    +
     
    +
    DELETION_OR_GAP_CHAR - Static variable in class main.Constants
    +
     
    +
    DELETION_OR_GAP_STRING - Static variable in class main.Constants
    +
     
    +
    dump(String, boolean) - Method in class datastructure.MusialStorage
    Dumps this MusialStorage instance into a .json(.br) format file.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-5.html b/doc/index-files/index-5.html index eb78216..1cb56a1 100644 --- a/doc/index-files/index-5.html +++ b/doc/index-files/index-5.html @@ -1,11 +1,11 @@ - + E-Index - + @@ -50,7 +50,7 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    E

    EMPTY_STREAM - Static variable in class main.Musial
    @@ -69,8 +69,10 @@

    E

    Prefix to use for exception messages.
    -
    EXCEPTION_PREFIX - Variable in class runnables.SnpEffAnnotator
    -
     
    +
    EXCEPTION_PREFIX - Variable in class utility.SnpEffAnnotator
    +
    +
    Prefix for exceptions thrown by the SnpEff Annotation process.
    +
    exceptions - package exceptions
    Comprises classes that extend the Exception class.
    @@ -87,9 +89,9 @@

    E

    Exits the program, if an unknown task was specified.
    -
    EXPORT_SEQUENCE - Enum constant in enum class main.MusialTasks
    +
    EXPORT_SEQUENCE - Enum constant in enum class main.Tasks
     
    -
    EXPORT_TABLE - Enum constant in enum class main.MusialTasks
    +
    EXPORT_TABLE - Enum constant in enum class main.Tasks
     
    exportSequence(CommandLine) - Static method in class main.Musial
    @@ -100,7 +102,7 @@

    E

    Exports a variant table in tsv format wrt. a single feature.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-6.html b/doc/index-files/index-6.html index c614bca..d37a0a5 100644 --- a/doc/index-files/index-6.html +++ b/doc/index-files/index-6.html @@ -1,11 +1,11 @@ - + F-Index - + @@ -50,12 +50,12 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    F

    -
    feature - Variable in class runnables.SampleAnalyzer
    +
    feature - Static variable in class utility.SampleAnalyzer
    -
    The current Feature to be analyzed.
    +
    The current Feature being analyzed.
    Feature - Class in datastructure
    @@ -65,10 +65,6 @@

    F

    Constructor of Feature.
    -
    featureCoding - Variable in class runnables.AlleleAnalyzer
    -
    -
    The FeatureCoding to be analyzed.
    -
    FeatureCoding - Class in datastructure
    Extension of the Feature class to represent coding features.
    @@ -77,23 +73,19 @@

    F

    Constructor of FeatureCoding.
    -
    featureNames - Variable in class runnables.SampleAnalyzer
    -
    -
    The names of the Features to be analyzed.
    -
    features - Variable in class cli.BuildConfiguration
    - +
    features - Variable in class datastructure.MusialStorage
    Container to store maintained genomic features.
    -
    FIELD_SEPARATOR_1 - Static variable in class main.MusialConstants
    +
    FIELD_SEPARATOR_1 - Static variable in class main.Constants
     
    -
    FIELD_SEPARATOR_2 - Static variable in class main.MusialConstants
    +
    FIELD_SEPARATOR_2 - Static variable in class main.Constants
     
    -
    FORBID - Enum constant in enum class utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    +
    FORBID - Enum constant in enum class utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    Gaps at the end are not allowed.
    @@ -101,18 +93,22 @@

    F

    Container to store a biological variation of a feature, i.e., an allele of a gene or proteoform of a protein.
    -
    Form(String) - Constructor for class datastructure.Form
    +
    Form(String, String) - Constructor for class datastructure.Form
    Constructor of Form.
    -
    FREE - Enum constant in enum class utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    +
    formNameCodes - Variable in class datastructure.MusialStorage
    +
    +
    Stores already seen variants to avoid redundant form names.
    +
    +
    FREE - Enum constant in enum class utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    Gaps at the end are not penalized.
    -
    FREQUENCY - Static variable in class main.MusialConstants
    +
    FREQUENCY - Static variable in class main.Constants
     
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-7.html b/doc/index-files/index-7.html index ffcd416..5107f36 100644 --- a/doc/index-files/index-7.html +++ b/doc/index-files/index-7.html @@ -1,11 +1,11 @@ - + G-Index - + @@ -50,13 +50,9 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    G

    -
    GAP - Static variable in class utility.Bio
    -
    -
    One-letter character used to indicate an alignment gap.
    -
    generateDirectory(File) - Static method in class utility.IO
    Tries to generate the directory specified by the passed File object.
    @@ -69,47 +65,35 @@

    G

    Returns the Form, i.e., allele, stored with alleleName from Feature.alleles or null if it does not exist.
    +
    getAllele(String) - Method in class datastructure.Sample
    +
    +
    Returns the value set for featureName in Sample.allele or null if not set.
    +
    getAlleleCount() - Method in class datastructure.Feature
    Returns the number of alleles stored for this feature.
    getAlleleNameIterator() - Method in class datastructure.Feature
     
    -
    getAminoacidVariantAnnotation(int, String) - Method in class datastructure.FeatureCoding
    +
    getAminoacidVariant(int, String) - Method in class datastructure.FeatureCoding
    -
    Returns the VariantAnnotation stored at this instances FeatureCoding.aminoacidVariants at position and content.
    +
    Returns the VariantInformation stored at this instances FeatureCoding.aminoacidVariants at position and content.
    getAminoacidVariantPositions() - Method in class datastructure.FeatureCoding
    Retrieves a set of all variant positions of this FeatureCoding.
    -
    getAminoacidVariants(int) - Method in class datastructure.FeatureCoding
    -
    -
    Returns all VariantAnnotations stored at this instances FeatureCoding.aminoacidVariants at position.
    -
    -
    getAminoacidVariants(String) - Method in class datastructure.FeatureCoding
    -
    -
    Returns a map representation of all variants of a single proteoform of this FeatureCoding.
    -
    -
    getAnnotation(String) - Method in class datastructure.Feature
    -
    -
    Returns the value stored under key in Feature.annotations.
    -
    -
    getAnnotation(String) - Method in class datastructure.Form
    -
    -
    Query an annotation value from Form.annotations or null, if it does not exist.
    -
    -
    getAnnotation(String) - Method in class datastructure.Sample
    +
    getAminoacidVariantsAt(int) - Method in class datastructure.FeatureCoding
    -
    Query an annotation value from Sample.annotations or null, if it does not exist.
    +
    Returns all VariantInformations stored at this instances FeatureCoding.aminoacidVariants at position.
    -
    getAnnotations() - Method in class datastructure.Feature
    +
    getCallAt(String, int) - Method in class datastructure.Sample
    -
    Returns all annotations of this instance.
    +
    Retrieves the variant call at the specified position for the given feature.
    -
    getAnnotations() - Method in class datastructure.Sample
    +
    getCallVariantsStringAt(String, int) - Method in class datastructure.Sample
    -
    Queries all annotation values from Sample.annotations.
    +
    Retrieves the string representation of the variant call at the specified position for the given feature.
    getCodingSequence() - Method in class datastructure.FeatureCoding
     
    @@ -121,40 +105,52 @@

    G

     
    getFeatureNameIterator(int) - Method in class datastructure.MusialStorage
     
    -
    getNucleotideVariantAnnotation(int, String) - Method in class datastructure.Feature
    +
    getFormName(int, String) - Method in class datastructure.MusialStorage
    -
    Returns the VariantAnnotation stored at this instances Feature.nucleotideVariants at position and content.
    +
    Used to collide form names based on mapping stored in MusialStorage.formNameCodes.
    -
    getNucleotideVariantPositions() - Method in class datastructure.Feature
    +
    getInfo(String) - Method in class datastructure.InfoContainer
    -
    Retrieves a set of all variant positions of this Feature.
    +
    Returns the value stored at key in this instance.
    +
    +
    getInfoKeys() - Method in class datastructure.InfoContainer
    +
     
    +
    getInfoSet() - Method in class datastructure.InfoContainer
    +
     
    +
    getNucleotideVariant(int, String) - Method in class datastructure.Feature
    +
    +
    Returns the VariantInformation stored at this instances Feature.nucleotideVariants at position and content.
    -
    getNucleotideVariants(int) - Method in class datastructure.Feature
    +
    getNucleotideVariantPositions() - Method in class datastructure.Feature
    -
    Returns all VariantAnnotations stored at this instances Feature.nucleotideVariants at position.
    +
    Retrieves a set of all variant positions of this Feature.
    getNucleotideVariants(String) - Method in class datastructure.Feature
    Returns a map representation of all variants of a single allele of this Feature.
    +
    getNucleotideVariantsAt(int) - Method in class datastructure.Feature
    +
    +
    Returns all VariantInformations stored at this instances Feature.nucleotideVariants at position.
    +
    getNumberOfSamples() - Method in class datastructure.MusialStorage
    Getter method for MusialStorage.samples size.
    -
    getOccurrence() - Method in class datastructure.Form
    +
    getOccurrenceCount() - Method in class datastructure.OccurrenceContainer
    +
     
    +
    getOccurrenceIterator() - Method in class datastructure.OccurrenceContainer
    +
     
    +
    getOccurrenceSet() - Method in class datastructure.OccurrenceContainer
     
    -
    getProperty(String) - Method in class datastructure.VariantAnnotation
    -
    -
    Retrieves the value stored under key in this properties.
    -
    -
    getPropertyKeys() - Method in class datastructure.VariantAnnotation
    -
    -
    Retrieves the keys stored in this properties.
    -
    getProteoform(String) - Method in class datastructure.FeatureCoding
    Returns the Form, i.e., proteoform, stored with proteoformName from FeatureCoding.proteoforms or null if it does not exist.
    +
    getProteoform(String) - Method in class datastructure.Sample
    +
    +
    Returns the value set for featureName in Sample.proteoform or null if not set.
    +
    getProteoformCount() - Method in class datastructure.FeatureCoding
    Returns the number of proteoforms stored for this feature.
    @@ -171,40 +167,36 @@

    G

    getSampleNameIterator() - Method in class datastructure.MusialStorage
     
    -
    getSequencesFromPdbStructure(Structure) - Static method in class utility.IO
    -
    -
    Returns the chains sequences from a Structure instance parsed from a .pdb file.
    -
    -
    getStructure() - Method in class datastructure.FeatureCoding
    -
     
    getTimestampDayTime() - Static method in class utility.Logger
    Generates, formats and returns a String representing the current date and time.
    -
    getVariantCallsIterator() - Method in class runnables.SampleAnalyzer
    -
     
    -
    getVariantsOfAlignedSequences(String, String) - Static method in class utility.Bio
    +
    getVariantCalls(String) - Method in class datastructure.Sample
    +
    +
    Retrieves the variant calls associated with the specified feature.
    +
    +
    getVariantsOfAlignedSequences(String, String) - Static method in class utility.SequenceOperations
    Computes variants from two aligned sequences.
    -
    GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES() - Constructor for enum class utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    +
    GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES() - Constructor for enum class utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
     
    -
    globalAminoAcidSequenceAlignment(String, String, int, int, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer) - Static method in class utility.Bio
    +
    globalAminoAcidSequenceAlignment(String, String, int, int, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer) - Static method in class utility.SequenceOperations
    -
    -
    globalNucleotideSequenceAlignment(String, String, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer) - Static method in class utility.Bio
    +
    globalNucleotideSequenceAlignment(String, String, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer) - Static method in class utility.SequenceOperations
    -
    -
    globalSequenceAlignment(String, String, HashMap<Character, Integer>, int[][], int, int, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer) - Static method in class utility.Bio
    +
    globalSequenceAlignment(String, String, HashMap<Character, Integer>, int[][], int, int, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer) - Static method in class utility.SequenceOperations
    Computes a global sequence alignment using the gap-affine Needleman-Wunsch algorithm.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-8.html b/doc/index-files/index-8.html index 5e7224d..19a1bd9 100644 --- a/doc/index-files/index-8.html +++ b/doc/index-files/index-8.html @@ -1,11 +1,11 @@ - + H-Index - + @@ -50,31 +50,31 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    H

    hasAllele(String) - Method in class datastructure.Feature
    Checks whether a Form, i.e., allele is stored with alleleName in Feature.alleles.
    -
    hasAnnotation(String) - Method in class datastructure.Form
    +
    hasFeature(String) - Method in class datastructure.MusialStorage
    -
    Check if an annotation in Form.annotations exists.
    -
    -
    hasOccurrence(String) - Method in class datastructure.Form
    -
    -
    Check if an entry in Form.occurrence exists.
    -
    -
    hasProperty(String) - Method in class datastructure.VariantAnnotation
    -
    -
    Check if element is contained in this properties.
    +
    Query whether a feature is stored in this instance by its name.
    +
    hasInfoKey(String) - Method in class datastructure.InfoContainer
    +
     
    +
    hasOccurrence(String) - Method in class datastructure.OccurrenceContainer
    +
     
    hasProteoform(String) - Method in class datastructure.FeatureCoding
    Checks whether a Form, i.e., proteoform is stored with proteoformName in FeatureCoding.proteoforms.
    +
    hasSample(String) - Method in class datastructure.MusialStorage
    +
    +
    Query whether a sample is stored in this instance by its name.
    +
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index-files/index-9.html b/doc/index-files/index-9.html index 5a46a7d..b266394 100644 --- a/doc/index-files/index-9.html +++ b/doc/index-files/index-9.html @@ -1,11 +1,11 @@ - + I-Index - + @@ -50,14 +50,26 @@

    Index

    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

    I

    imputeVcfFileReader() - Method in class datastructure.Sample
    Initialize a VCFFileReader instance pointing to the .vcf file associated with this instance.
    -
    invertBase(char) - Static method in class utility.Bio
    +
    info - Variable in class datastructure.InfoContainer
    +
    +
    Stores arbitrary meta information.
    +
    +
    InfoContainer - Class in datastructure
    +
    +
    Interface for meta-information storage.
    +
    +
    InfoContainer() - Constructor for class datastructure.InfoContainer
    +
    +
    Constructor of InfoContainer.
    +
    +
    invertBase(char) - Static method in class utility.SequenceOperations
    Returns the complement of a nucleotide base, i.e. switches A to T, C to G and vice versa.
    @@ -67,9 +79,13 @@

    I

    IO() - Constructor for class utility.IO
     
    +
    isAmbiguousCallAt(String, int) - Method in class datastructure.Sample
    +
    +
    Checks if the variant call at the specified position for the given feature is ambiguous.
    +
    isCoding() - Method in class datastructure.Feature
    -
    Checks whether this instance of Feature is an instance of FeatureCoding, i.e., declared as a coding feature.
    +
    Return whether this instance of Feature is declared as a coding feature.
    isDirectory(File) - Static method in class utility.Validation
    @@ -83,6 +99,10 @@

    I

    Check if a String represents a percentage.
    +
    isPositionExcluded(String, int) - Method in class datastructure.MusialStorage
    +
    +
    Checks whether position is excluded on contig of MusialStorage.reference.
    +
    isPositiveDouble(String) - Static method in class utility.Validation
    Check if a String represents a positive double.
    @@ -91,12 +111,16 @@

    I

    Check if a String represents a positive integer.
    +
    isReferenceCallAt(String, int) - Method in class datastructure.Sample
    +
    +
    Checks if the variant call at the specified position for the given feature is a reference call.
    +
    isSense - Variable in class datastructure.Feature
    Indicates if the feature is located on the sense strand.
    -A B C D E F G H I K L M N O P R S T U V W 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form +A B C D E F G H I K L M N O P R S T U V W _ 
    All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form diff --git a/doc/index.html b/doc/index.html index 8c1ab68..462dbff 100644 --- a/doc/index.html +++ b/doc/index.html @@ -1,11 +1,11 @@ - + Overview - + @@ -68,12 +68,8 @@
    Comprises the main class of MUSIAL.
    - +
    -
    Comprises classes that implement the Runnable interface and are used to execute multithreaded tasks.
    -
    - -
    Comprises classes that mainly implement static methods, which are used by MUSIAL modules.
    diff --git a/doc/main/Constants.html b/doc/main/Constants.html new file mode 100644 index 0000000..6c40aa4 --- /dev/null +++ b/doc/main/Constants.html @@ -0,0 +1,688 @@ + + + + +Constants + + + + + + + + + + + + + + + +
    + +
    +
    + +
    +
    Package main
    +

    Class Constants

    +
    +
    java.lang.Object +
    main.Constants
    +
    +
    +
    +
    public class Constants +extends Object
    +
    Collection of common property keys used for annotations.
    +
    +
    Since:
    +
    2.2
    +
    +
    +
    + +
    +
    + +
    + +
    +
    +
    + + diff --git a/doc/main/Musial.html b/doc/main/Musial.html index 589b303..d5837a5 100644 --- a/doc/main/Musial.html +++ b/doc/main/Musial.html @@ -1,11 +1,11 @@ - + Musial - + @@ -101,7 +101,7 @@

    Field Summary

    Program wide accessor to command line interface parser.
    -
    private static boolean
    +
    private static final boolean
    Whether to compress output.
    @@ -137,29 +137,19 @@

    Field Summary

    String representing the name of the software; parsed from `/src/main/resources/info.properties`.
    static final PrintStream
    - +
    -
    Original system error stream.
    -
    -
    static final PrintStream
    - -
    Original system output stream.
    -
    private static long
    - -
    -
    Store start of execution time.
    -
    -
    static String
    - +
    private static long
    +
    -
    Specifies the task to execute.
    +
    Store start of execution time.
    -
    static int
    - +
    static String
    +
    -
    The number of threads to use.
    +
    Specifies the task to execute.
    static String
    @@ -198,51 +188,45 @@

    Method Summary

    Generates a new or updates an existing MUSIAL storage JSON file based on the specifications parsed from a build configuration JSON file.
    - -
    constructVariantsTable(MusialStorage musialStorage, - String featureName, - HashSet<String> sampleNames, - String contentMode, - boolean rejectedAsReference, - boolean conservedSites)
    +
    private static void
    +
    exportSequence(org.apache.commons.cli.CommandLine parameters)
    -
    Internal method to construct a two-layer map structure used for export of tables and sequences.
    +
    Exports sequences in fasta format wrt. a single feature.
    private static void
    -
    exportSequence(org.apache.commons.cli.CommandLine parameters)
    +
    exportTable(org.apache.commons.cli.CommandLine parameters)
    -
    Exports sequences in fasta format wrt. a single feature.
    +
    Exports a variant table in tsv format wrt. a single feature.
    private static void
    -
    exportTable(org.apache.commons.cli.CommandLine parameters)
    +
    -
    Exports a variant table in tsv format wrt. a single feature.
    +
    Load and store metadata, such as the software title and version from `/src/main/resources/info.properties` and prints the information to stdout.
    -
    private static void
    - +
    static void
    +
    main(String[] args)
    -
    Load and store metadata, such as the software title and version from `/src/main/resources/info.properties` and prints the information to stdout.
    +
    Main method of MUSIAL; loads meta-information and invokes methods dependent on the command line arguments.
    -
    static void
    -
    main(String[] args)
    +
    private static void
    +
    outputView(LinkedHashMap<String,ArrayList<String>> content, + int noEntries, + String output)
    -
    Main method of MUSIAL; loads meta-information and invokes methods dependent on the command line arguments.
    +
    Internal method to output view_x tasks of MUSIAL.
    private static void
    -
    outputView(LinkedHashMap<String,ArrayList<String>> content, - int entryIndex, - String output)
    +
    transferContent(LinkedHashMap<String,ArrayList<String>> container, + String key, + String value, + int noEntries)
    -
    Internal method to output view_x tasks of MUSIAL.
    +
    Internal method to transfers a value to a container that represents column vectors of a table like object to output.
    private static void
    -
    transferAnnotation(LinkedHashMap<String,ArrayList<String>> annotations, - int entryIndex, - HashSet<String> entryAnnotationKeys, - String annotationKey, - String annotationValue)
    +
    -
    Internal method to transfers an annotation value to a container map.
    +
    Updates the statistics related to genetic variants and allele frequencies based on the data stored in the provided MusialStorage.
    private static void
    viewFeatures(org.apache.commons.cli.CommandLine parameters)
    @@ -277,6 +261,42 @@

    Methods inherited from cl

    Field Details

    • +
      +

      ORIGINAL_OUT_STREAM

      +
      public static final PrintStream ORIGINAL_OUT_STREAM
      +
      Original system output stream.
      +
      +
    • +
    • +
      +

      EMPTY_STREAM

      +
      public static final PrintStream EMPTY_STREAM
      +
      Alternative output stream to ignore logging.
      +
      +
    • +
    • +
      +

      DECIMAL_FORMATTER

      +
      public static final DecimalFormat DECIMAL_FORMATTER
      +
      Project wide formatter to convert decimal numbers to strings.
      +
      +
    • +
    • +
      +

      COMPRESS

      +
      private static final boolean COMPRESS
      +
      Whether to compress output. This can not be set by the user and is for debugging purposes only.
      +
      +
      See Also:
      +
      + +
      +
      +
      +
    • +
    • NAME

      public static String NAME
      @@ -312,48 +332,6 @@

      TASK

    • -
      -

      ORIGINAL_OUT_STREAM

      -
      public static final PrintStream ORIGINAL_OUT_STREAM
      -
      Original system output stream.
      -
      -
    • -
    • -
      -

      ORIGINAL_ERR_STREAM

      -
      public static final PrintStream ORIGINAL_ERR_STREAM
      -
      Original system error stream.
      -
      -
    • -
    • -
      -

      EMPTY_STREAM

      -
      public static final PrintStream EMPTY_STREAM
      -
      Alternative output stream to ignore logging.
      -
      -
    • -
    • -
      -

      THREADS

      -
      public static int THREADS
      -
      The number of threads to use.
      -
      -
    • -
    • -
      -

      COMPRESS

      -
      private static boolean COMPRESS
      -
      Whether to compress output.
      -
      -
    • -
    • -
      -

      DECIMAL_FORMATTER

      -
      public static final DecimalFormat DECIMAL_FORMATTER
      -
      Project wide formatter to convert decimal numbers to strings.
      -
      -
    • -
    • CLI_PARSER

      private static CLIParser CLI_PARSER
      @@ -423,30 +401,28 @@

      loadMetadata

      build

      private static void build(BuildConfiguration parameters) - throws InterruptedException, -MusialException, + throws MusialException, IOException
      Generates a new or updates an existing MUSIAL storage JSON file based on the specifications parsed from a build configuration JSON file.
      Parameters:
      parameters - BuildConfiguration instance yielding parameter specification for the MUSIAL build task.
      Throws:
      -
      InterruptedException - Thrown if any Runnable implementing class instance is interrupted by the user.
      IOException - Thrown if any input or output file is missing or unable to being generated (caused by any native Java method).
      MusialException - If any method fails wrt. biological context, i.e. parsing of unknown symbols; If any method fails wrt. internal logic, i.e. assignment of proteins to genomes; If any input or output file is missing or unable to being generated.
    • -
      -

      viewFeatures

      -
      private static void viewFeatures(org.apache.commons.cli.CommandLine parameters) +
      +

      viewVariants

      +
      private static void viewVariants(org.apache.commons.cli.CommandLine parameters) throws IOException, MusialException
      -
      Views all features of an existing MUSIAL storage as tsv formatted table.
      +
      Views all variants of an existing MUSIAL storage as tsv formatted table.
      Parameters:
      -
      parameters - CommandLine instance yielding parameter specification for the MUSIAL view_features task.
      +
      parameters - CommandLine instance yielding parameter specification for the MUSIAL view_variants task.
      Throws:
      IOException - If reading of the input MUSIAL storage fails.
      MusialException - If printing the output fails.
      @@ -470,15 +446,15 @@

      viewSamples

    • -
      -

      viewVariants

      -
      private static void viewVariants(org.apache.commons.cli.CommandLine parameters) +
      +

      viewFeatures

      +
      private static void viewFeatures(org.apache.commons.cli.CommandLine parameters) throws IOException, MusialException
      -
      Views all variants of an existing MUSIAL storage as tsv formatted table.
      +
      Views all features of an existing MUSIAL storage as tsv formatted table.
      Parameters:
      -
      parameters - CommandLine instance yielding parameter specification for the MUSIAL view_variants task.
      +
      parameters - CommandLine instance yielding parameter specification for the MUSIAL view_features task.
      Throws:
      IOException - If reading of the input MUSIAL storage fails.
      MusialException - If printing the output fails.
      @@ -521,14 +497,14 @@

      exportSequence

      outputView

      private static void outputView(LinkedHashMap<String,ArrayList<String>> content, - int entryIndex, + int noEntries, String output) throws MusialException
      Internal method to output view_x tasks of MUSIAL.
      Parameters:
      content - The content for which a tsv format string is to be built.
      -
      entryIndex - The number of entries to iterate over.
      +
      noEntries - The number of entries to iterate over.
      output - String representing a file path to write the output to; If set to null, output will be printed to console.
      Throws:
      MusialException - If I/O operation fails in case of a provided output file.
      @@ -536,48 +512,34 @@

      outputView

    • -
      -

      transferAnnotation

      -
      private static void transferAnnotation(LinkedHashMap<String,ArrayList<String>> annotations, - int entryIndex, - HashSet<String> entryAnnotationKeys, - String annotationKey, - String annotationValue)
      -
      Internal method to transfers an annotation value to a container map. This is used to supplement missing annotation values in any object to consider with null values.
      +
      +

      transferContent

      +
      private static void transferContent(LinkedHashMap<String,ArrayList<String>> container, + String key, + String value, + int noEntries)
      +
      Internal method to transfers a value to a container that represents column vectors of a table like object to output. +

      + This supplements missing values in any object to consider with JSON serializable 'null' entries.

      Parameters:
      -
      annotations - The container to add annotations to.
      -
      entryIndex - The number of existing entries in the container.
      -
      entryAnnotationKeys - Annotation keys of the entry to consider.
      -
      annotationKey - The key of the annotation.
      -
      annotationValue - The value of the annotation.
      +
      container - The container to add an entry to.
      +
      noEntries - The number of existing entries in the container.
      +
      key - The key of the entry.
      +
      value - The value of the entry.
    • -
      -

      constructVariantsTable

      -
      private static TreeMap<String,LinkedHashMap<String,String>> constructVariantsTable(MusialStorage musialStorage, - String featureName, - HashSet<String> sampleNames, - String contentMode, - boolean rejectedAsReference, - boolean conservedSites)
      -
      Internal method to construct a two-layer map structure used for export of tables and sequences. -
      - The first layer stores positions in the format x+y, where x represent true genomic positions and y represent insertion positions. -
      - The second layer stores sample names mapping to variant contents.
      +
      +

      updateStatistics

      +
      private static void updateStatistics(MusialStorage musialStorage)
      +
      Updates the statistics related to genetic variants and allele frequencies based on the data stored in the provided MusialStorage. + This method iterates over features, samples, and proteoforms, calculates statistics such as substitution count, insertion count, deletion count, + ambiguous count, and allele frequencies, and updates the information accordingly.
      Parameters:
      -
      musialStorage - MusialStorage to build from.
      -
      featureName - Name of the feature to build the table of; Should be accepted for MusialStorage.getFeature(String).
      -
      sampleNames - Set of sample names to restrict the construction to; Should be accepted for MusialStorage.getSample(String).
      -
      contentMode - Either `aminoacid` or `nucleotide`; Specifies the variants to query.
      -
      rejectedAsReference - If rejected variants should be added as reference or ambiguous base symbol.
      -
      conservedSites - If non-variant sites should be considered.
      -
      Returns:
      -
      Two-layer map structure.
      +
      musialStorage - The MusialStorage containing the genetic variant data.
    • diff --git a/doc/main/MusialConstants.html b/doc/main/MusialConstants.html index ba64973..9c8cce5 100644 --- a/doc/main/MusialConstants.html +++ b/doc/main/MusialConstants.html @@ -68,7 +68,7 @@

      Class MusialConstants

      java.lang.Object -
      main.MusialConstants
      +
      main.Constants

      @@ -187,7 +187,7 @@

      REFERENCE_ID

      See Also:
    @@ -201,7 +201,7 @@

    VARIANTS

    See Also:
    @@ -215,7 +215,7 @@

    PROTEOFORM_DIFFERENTIAL_SEQUENCE

    See Also:
    @@ -229,7 +229,7 @@

    PROTEOFORM_NOVEL_STOPS

    See Also:
    @@ -243,7 +243,7 @@

    NUMBER_SUBSTITUTIONS

    See Also:
    @@ -257,7 +257,7 @@

    NUMBER_INSERTIONS

    See Also:
    @@ -271,7 +271,7 @@

    NUMBER_DELETIONS

    See Also:
    @@ -285,7 +285,7 @@

    VARIABLE_POSITIONS

    See Also:
    @@ -299,7 +299,7 @@

    FREQUENCY

    See Also:
    @@ -313,7 +313,7 @@

    REFERENCE_CONTENT

    See Also:
    @@ -327,7 +327,7 @@

    SNP_EFF_PROPERTY_PREFIX

    See Also:
    @@ -347,7 +347,7 @@

    VARIANT_OCCURRENCE_SAMPLE_PREFIX

    See Also:
    @@ -361,7 +361,7 @@

    SAMPLE_ANNOTATION_ALLELE_PREFIX

    See Also:
    @@ -375,7 +375,7 @@

    SAMPLE_ANNOTATION_PROTEOFORM_PREFIX

    See Also:
    @@ -389,7 +389,7 @@

    ALLELE_ANNOTATION_PROTEOFORM

    See Also:
    @@ -403,7 +403,7 @@

    FIELD_SEPARATOR_1

    See Also:
    @@ -417,7 +417,7 @@

    FIELD_SEPARATOR_2

    See Also:
    diff --git a/doc/main/MusialModules.html b/doc/main/MusialModules.html index 42137be..1d2b6cc 100644 --- a/doc/main/MusialModules.html +++ b/doc/main/MusialModules.html @@ -77,7 +77,7 @@

    Enum MusialModules

    java.lang.Object
    java.lang.Enum<MusialModules> -
    main.MusialTasks
    +
    main.Tasks
    diff --git a/doc/main/MusialTasks.html b/doc/main/MusialTasks.html index cb6817d..20af7f2 100644 --- a/doc/main/MusialTasks.html +++ b/doc/main/MusialTasks.html @@ -73,7 +73,7 @@

    Enum Class MusialTasks

    java.lang.Object
    java.lang.Enum<MusialTasks> -
    main.MusialTasks
    +
    main.Tasks
    diff --git a/doc/main/Tasks.html b/doc/main/Tasks.html new file mode 100644 index 0000000..19878fc --- /dev/null +++ b/doc/main/Tasks.html @@ -0,0 +1,283 @@ + + + + +Tasks + + + + + + + + + + + + + + + +
    + +
    +
    + +
    +
    Package main
    +

    Enum Class Tasks

    +
    + +
    +
    +
    All Implemented Interfaces:
    +
    Serializable, Comparable<Tasks>, Constable
    +
    +
    +
    public enum Tasks +extends Enum<Tasks>
    +
    Enum specifying tasks of MUSIAL to choose from.
    +
    +
    Since:
    +
    2.1
    +
    +
    +
    + +
    +
    +
      + +
    • +
      +

      Enum Constant Details

      +
        +
      • +
        +

        BUILD

        +
        public static final Tasks BUILD
        +
        +
      • +
      • +
        +

        VIEW_FEATURES

        +
        public static final Tasks VIEW_FEATURES
        +
        +
      • +
      • +
        +

        VIEW_SAMPLES

        +
        public static final Tasks VIEW_SAMPLES
        +
        +
      • +
      • +
        +

        VIEW_VARIANTS

        +
        public static final Tasks VIEW_VARIANTS
        +
        +
      • +
      • +
        +

        EXPORT_TABLE

        +
        public static final Tasks EXPORT_TABLE
        +
        +
      • +
      • +
        +

        EXPORT_SEQUENCE

        +
        public static final Tasks EXPORT_SEQUENCE
        +
        +
      • +
      +
      +
    • + +
    • +
      +

      Constructor Details

      +
        +
      • +
        +

        Tasks

        +
        private Tasks()
        +
        +
      • +
      +
      +
    • + +
    • +
      +

      Method Details

      +
        +
      • +
        +

        values

        +
        public static Tasks[] values()
        +
        Returns an array containing the constants of this enum class, in +the order they are declared.
        +
        +
        Returns:
        +
        an array containing the constants of this enum class, in the order they are declared
        +
        +
        +
      • +
      • +
        +

        valueOf

        +
        public static Tasks valueOf(String name)
        +
        Returns the enum constant of this class with the specified name. +The string must match exactly an identifier used to declare an +enum constant in this class. (Extraneous whitespace characters are +not permitted.)
        +
        +
        Parameters:
        +
        name - the name of the enum constant to be returned.
        +
        Returns:
        +
        the enum constant with the specified name
        +
        Throws:
        +
        IllegalArgumentException - if this enum class has no constant with the specified name
        +
        NullPointerException - if the argument is null
        +
        +
        +
      • +
      +
      +
    • +
    +
    + +
    +
    +
    + + diff --git a/doc/main/package-summary.html b/doc/main/package-summary.html index c3b8775..cea598d 100644 --- a/doc/main/package-summary.html +++ b/doc/main/package-summary.html @@ -1,11 +1,11 @@ - + main - + @@ -76,16 +76,16 @@

    Package main

    Class
    Description
    - +
    -
    Main class of MUSIAL (MUlti Sample varIant AnaLysis), a tool to calculate SNV, gene, and whole genome alignments, - together with other relevant statistics based on vcf files.
    +
    Collection of common property keys used for annotations.
    - +
    -
    Collection of common property keys used for annotations.
    +
    Main class of MUSIAL (MUlti Sample varIant AnaLysis), a tool to calculate SNV, gene, and whole genome alignments, + together with other relevant statistics based on vcf files.
    - +
    Enum specifying tasks of MUSIAL to choose from.
    diff --git a/doc/main/package-tree.html b/doc/main/package-tree.html index 6ad378b..e583e7b 100644 --- a/doc/main/package-tree.html +++ b/doc/main/package-tree.html @@ -1,11 +1,11 @@ - + main Class Hierarchy - + @@ -59,8 +59,8 @@

    Class Hierarchy

    @@ -72,7 +72,7 @@

    Enum Class Hierarchy

    diff --git a/doc/member-search-index.js b/doc/member-search-index.js index c5e227a..787d895 100644 --- a/doc/member-search-index.js +++ b/doc/member-search-index.js @@ -1 +1 @@ -memberSearchIndex = [{"p":"utility","c":"Bio","l":"AA1_PAM250_INDEX"},{"p":"utility","c":"Bio","l":"AA1TO3"},{"p":"datastructure","c":"Feature","l":"addAllele(Form)","u":"addAllele(datastructure.Form)"},{"p":"datastructure","c":"FeatureCoding","l":"addAminoacidVariant(int, String)","u":"addAminoacidVariant(int,java.lang.String)"},{"p":"datastructure","c":"Feature","l":"addAnnotation(String, String)","u":"addAnnotation(java.lang.String,java.lang.String)"},{"p":"datastructure","c":"Form","l":"addAnnotation(String, String)","u":"addAnnotation(java.lang.String,java.lang.String)"},{"p":"datastructure","c":"Sample","l":"addAnnotation(String, String)","u":"addAnnotation(java.lang.String,java.lang.String)"},{"p":"cli","c":"CLIParser","l":"addBuildOptions(Options)","u":"addBuildOptions(org.apache.commons.cli.Options)"},{"p":"cli","c":"CLIParser","l":"addExportSequenceOptions(Options)","u":"addExportSequenceOptions(org.apache.commons.cli.Options)"},{"p":"cli","c":"CLIParser","l":"addExportTableOptions(Options)","u":"addExportTableOptions(org.apache.commons.cli.Options)"},{"p":"datastructure","c":"MusialStorage","l":"addFeature(Feature)","u":"addFeature(datastructure.Feature)"},{"p":"cli","c":"BuildConfiguration","l":"addFeature(String, String, String, File, boolean, Map)","u":"addFeature(java.lang.String,java.lang.String,java.lang.String,java.io.File,boolean,java.util.Map)"},{"p":"datastructure","c":"Feature","l":"addNucleotideVariant(int, String)","u":"addNucleotideVariant(int,java.lang.String)"},{"p":"datastructure","c":"Form","l":"addOccurrence(String)","u":"addOccurrence(java.lang.String)"},{"p":"datastructure","c":"VariantAnnotation","l":"addProperty(String, String)","u":"addProperty(java.lang.String,java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"addProteoform(Form)","u":"addProteoform(datastructure.Form)"},{"p":"datastructure","c":"MusialStorage","l":"addSample(Sample)","u":"addSample(datastructure.Sample)"},{"p":"cli","c":"BuildConfiguration","l":"addSample(String, File, Map)","u":"addSample(java.lang.String,java.io.File,java.util.Map)"},{"p":"runnables","c":"SampleAnalyzer","l":"addVariantCall(int, int, int, boolean, String, String, double, double, double)","u":"addVariantCall(int,int,int,boolean,java.lang.String,java.lang.String,double,double,double)"},{"p":"cli","c":"CLIParser","l":"addViewFeaturesOptions(Options)","u":"addViewFeaturesOptions(org.apache.commons.cli.Options)"},{"p":"cli","c":"CLIParser","l":"addViewSamplesOptions(Options)","u":"addViewSamplesOptions(org.apache.commons.cli.Options)"},{"p":"cli","c":"CLIParser","l":"addViewVariantsOptions(Options)","u":"addViewVariantsOptions(org.apache.commons.cli.Options)"},{"p":"runnables","c":"AlleleAnalyzer","l":"allele"},{"p":"main","c":"MusialConstants","l":"ALLELE_ANNOTATION_PROTEOFORM"},{"p":"runnables","c":"AlleleAnalyzer","l":"AlleleAnalyzer(FeatureCoding, Form, MusialStorage)","u":"%3Cinit%3E(datastructure.FeatureCoding,datastructure.Form,datastructure.MusialStorage)"},{"p":"datastructure","c":"Feature","l":"alleles"},{"p":"datastructure","c":"FeatureCoding","l":"aminoacidVariants"},{"p":"datastructure","c":"Feature","l":"annotations"},{"p":"datastructure","c":"Form","l":"annotations"},{"p":"datastructure","c":"Sample","l":"annotations"},{"p":"utility","c":"Bio","l":"ANY_AA1"},{"p":"utility","c":"Bio","l":"ANY_AA3"},{"p":"utility","c":"Bio","l":"ANY_NUC"},{"p":"datastructure","c":"VariantAnnotation","l":"appendProperty(String, String)","u":"appendProperty(java.lang.String,java.lang.String)"},{"p":"cli","c":"CLIParser","l":"arguments"},{"p":"utility","c":"Bio","l":"Bio()","u":"%3Cinit%3E()"},{"p":"utility","c":"Compression","l":"brotliDecodeBytes(byte[])"},{"p":"utility","c":"Compression","l":"brotliDecodeString(String)","u":"brotliDecodeString(java.lang.String)"},{"p":"utility","c":"Compression","l":"brotliEncodeString(String)","u":"brotliEncodeString(java.lang.String)"},{"p":"utility","c":"Compression","l":"brotliEncodeStringToBytes(String)","u":"brotliEncodeStringToBytes(java.lang.String)"},{"p":"main","c":"MusialTasks","l":"BUILD"},{"p":"main","c":"Musial","l":"build(BuildConfiguration)","u":"build(cli.BuildConfiguration)"},{"p":"utility","c":"MusialStorageFactory","l":"build(BuildConfiguration)","u":"build(cli.BuildConfiguration)"},{"p":"cli","c":"CLIParser","l":"buildConfiguration"},{"p":"cli","c":"BuildConfiguration","l":"BuildConfiguration(HashMap)","u":"%3Cinit%3E(java.util.HashMap)"},{"p":"datastructure","c":"Feature","l":"chromosome"},{"p":"utility","c":"CL","l":"CL()","u":"%3Cinit%3E()"},{"p":"main","c":"Musial","l":"CLI_PARSER"},{"p":"cli","c":"CLIParser","l":"CLIParser(String[])","u":"%3Cinit%3E(java.lang.String[])"},{"p":"datastructure","c":"FeatureCoding","l":"codingSequence"},{"p":"utility","c":"Bio","l":"CODON_MAP"},{"p":"main","c":"Musial","l":"COMPRESS"},{"p":"utility","c":"IO","l":"compressFile(File)","u":"compressFile(java.io.File)"},{"p":"utility","c":"Compression","l":"Compression()","u":"%3Cinit%3E()"},{"p":"main","c":"Musial","l":"constructVariantsTable(MusialStorage, String, HashSet, String, boolean, boolean)","u":"constructVariantsTable(datastructure.MusialStorage,java.lang.String,java.util.HashSet,java.lang.String,boolean,boolean)"},{"p":"main","c":"Musial","l":"CONTACT"},{"p":"utility","c":"IO","l":"copyFile(File, File)","u":"copyFile(java.io.File,java.io.File)"},{"p":"utility","c":"Logger","l":"DATE_FORMAT"},{"p":"main","c":"Musial","l":"DECIMAL_FORMATTER"},{"p":"utility","c":"IO","l":"deleteDirectory(File)","u":"deleteDirectory(java.io.File)"},{"p":"utility","c":"Bio","l":"DELETION_AA1"},{"p":"datastructure","c":"MusialStorage","l":"dump(File, boolean)","u":"dump(java.io.File,boolean)"},{"p":"main","c":"Musial","l":"EMPTY_STREAM"},{"p":"datastructure","c":"Feature","l":"end"},{"p":"main","c":"Musial","l":"END_TIME"},{"p":"cli","c":"BuildConfiguration","l":"EXCEPTION_PREFIX"},{"p":"runnables","c":"SnpEffAnnotator","l":"EXCEPTION_PREFIX"},{"p":"cli","c":"BuildConfiguration","l":"excludedPositions"},{"p":"datastructure","c":"MusialStorage","l":"excludedPositions"},{"p":"cli","c":"CLIParser","l":"exitNotRecognized(String)","u":"exitNotRecognized(java.lang.String)"},{"p":"main","c":"MusialTasks","l":"EXPORT_SEQUENCE"},{"p":"main","c":"MusialTasks","l":"EXPORT_TABLE"},{"p":"main","c":"Musial","l":"exportSequence(CommandLine)","u":"exportSequence(org.apache.commons.cli.CommandLine)"},{"p":"main","c":"Musial","l":"exportTable(CommandLine)","u":"exportTable(org.apache.commons.cli.CommandLine)"},{"p":"runnables","c":"SampleAnalyzer","l":"feature"},{"p":"datastructure","c":"Feature","l":"Feature(String, String, int, int, String)","u":"%3Cinit%3E(java.lang.String,java.lang.String,int,int,java.lang.String)"},{"p":"runnables","c":"AlleleAnalyzer","l":"featureCoding"},{"p":"datastructure","c":"FeatureCoding","l":"FeatureCoding(String, String, int, int, String)","u":"%3Cinit%3E(java.lang.String,java.lang.String,int,int,java.lang.String)"},{"p":"runnables","c":"SampleAnalyzer","l":"featureNames"},{"p":"cli","c":"BuildConfiguration","l":"features"},{"p":"datastructure","c":"MusialStorage","l":"features"},{"p":"main","c":"MusialConstants","l":"FIELD_SEPARATOR_1"},{"p":"main","c":"MusialConstants","l":"FIELD_SEPARATOR_2"},{"p":"utility","c":"Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"FORBID"},{"p":"datastructure","c":"Form","l":"Form(String)","u":"%3Cinit%3E(java.lang.String)"},{"p":"utility","c":"Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"FREE"},{"p":"main","c":"MusialConstants","l":"FREQUENCY"},{"p":"utility","c":"Bio","l":"GAP"},{"p":"utility","c":"IO","l":"generateDirectory(File)","u":"generateDirectory(java.io.File)"},{"p":"utility","c":"IO","l":"generateFile(File)","u":"generateFile(java.io.File)"},{"p":"datastructure","c":"Feature","l":"getAllele(String)","u":"getAllele(java.lang.String)"},{"p":"datastructure","c":"Feature","l":"getAlleleCount()"},{"p":"datastructure","c":"Feature","l":"getAlleleNameIterator()"},{"p":"datastructure","c":"FeatureCoding","l":"getAminoacidVariantAnnotation(int, String)","u":"getAminoacidVariantAnnotation(int,java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"getAminoacidVariantPositions()"},{"p":"datastructure","c":"FeatureCoding","l":"getAminoacidVariants(int)"},{"p":"datastructure","c":"FeatureCoding","l":"getAminoacidVariants(String)","u":"getAminoacidVariants(java.lang.String)"},{"p":"datastructure","c":"Feature","l":"getAnnotation(String)","u":"getAnnotation(java.lang.String)"},{"p":"datastructure","c":"Form","l":"getAnnotation(String)","u":"getAnnotation(java.lang.String)"},{"p":"datastructure","c":"Sample","l":"getAnnotation(String)","u":"getAnnotation(java.lang.String)"},{"p":"datastructure","c":"Feature","l":"getAnnotations()"},{"p":"datastructure","c":"Sample","l":"getAnnotations()"},{"p":"datastructure","c":"FeatureCoding","l":"getCodingSequence()"},{"p":"datastructure","c":"MusialStorage","l":"getFeature(String)","u":"getFeature(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"getFeatureNameIterator()"},{"p":"datastructure","c":"MusialStorage","l":"getFeatureNameIterator(int)"},{"p":"datastructure","c":"Feature","l":"getNucleotideVariantAnnotation(int, String)","u":"getNucleotideVariantAnnotation(int,java.lang.String)"},{"p":"datastructure","c":"Feature","l":"getNucleotideVariantPositions()"},{"p":"datastructure","c":"Feature","l":"getNucleotideVariants(int)"},{"p":"datastructure","c":"Feature","l":"getNucleotideVariants(String)","u":"getNucleotideVariants(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"getNumberOfSamples()"},{"p":"datastructure","c":"Form","l":"getOccurrence()"},{"p":"datastructure","c":"VariantAnnotation","l":"getProperty(String)","u":"getProperty(java.lang.String)"},{"p":"datastructure","c":"VariantAnnotation","l":"getPropertyKeys()"},{"p":"datastructure","c":"FeatureCoding","l":"getProteoform(String)","u":"getProteoform(java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"getProteoformCount()"},{"p":"datastructure","c":"FeatureCoding","l":"getProteoformNameIterator()"},{"p":"datastructure","c":"MusialStorage","l":"getReferenceSequenceOfFeature(String)","u":"getReferenceSequenceOfFeature(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"getSample(String)","u":"getSample(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"getSampleNameIterator()"},{"p":"utility","c":"IO","l":"getSequencesFromPdbStructure(Structure)","u":"getSequencesFromPdbStructure(org.biojava.nbio.structure.Structure)"},{"p":"datastructure","c":"FeatureCoding","l":"getStructure()"},{"p":"utility","c":"Logger","l":"getTimestampDayTime()"},{"p":"runnables","c":"SampleAnalyzer","l":"getVariantCallsIterator()"},{"p":"utility","c":"Bio","l":"getVariantsOfAlignedSequences(String, String)","u":"getVariantsOfAlignedSequences(java.lang.String,java.lang.String)"},{"p":"utility","c":"Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES()","u":"%3Cinit%3E()"},{"p":"utility","c":"Bio","l":"globalAminoAcidSequenceAlignment(String, String, int, int, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer)","u":"globalAminoAcidSequenceAlignment(java.lang.String,java.lang.String,int,int,utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,java.lang.Integer)"},{"p":"utility","c":"Bio","l":"globalNucleotideSequenceAlignment(String, String, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer)","u":"globalNucleotideSequenceAlignment(java.lang.String,java.lang.String,utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,java.lang.Integer)"},{"p":"utility","c":"Bio","l":"globalSequenceAlignment(String, String, HashMap, int[][], int, int, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer)","u":"globalSequenceAlignment(java.lang.String,java.lang.String,java.util.HashMap,int[][],int,int,utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,java.lang.Integer)"},{"p":"datastructure","c":"Feature","l":"hasAllele(String)","u":"hasAllele(java.lang.String)"},{"p":"datastructure","c":"Form","l":"hasAnnotation(String)","u":"hasAnnotation(java.lang.String)"},{"p":"datastructure","c":"Form","l":"hasOccurrence(String)","u":"hasOccurrence(java.lang.String)"},{"p":"datastructure","c":"VariantAnnotation","l":"hasProperty(String)","u":"hasProperty(java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"hasProteoform(String)","u":"hasProteoform(java.lang.String)"},{"p":"datastructure","c":"Sample","l":"imputeVcfFileReader()"},{"p":"utility","c":"Bio","l":"invertBase(char)"},{"p":"utility","c":"IO","l":"IO()","u":"%3Cinit%3E()"},{"p":"datastructure","c":"Feature","l":"isCoding()"},{"p":"utility","c":"Validation","l":"isDirectory(File)","u":"isDirectory(java.io.File)"},{"p":"utility","c":"Validation","l":"isFile(File)","u":"isFile(java.io.File)"},{"p":"utility","c":"Validation","l":"isPercentage(String)","u":"isPercentage(java.lang.String)"},{"p":"utility","c":"Validation","l":"isPositiveDouble(String)","u":"isPositiveDouble(java.lang.String)"},{"p":"utility","c":"Validation","l":"isPositiveInteger(String)","u":"isPositiveInteger(java.lang.String)"},{"p":"datastructure","c":"Feature","l":"isSense"},{"p":"datastructure","c":"Sample","l":"killVcfFileReader()"},{"p":"main","c":"Musial","l":"LICENSE"},{"p":"utility","c":"IO","l":"LINE_SEPARATOR"},{"p":"utility","c":"MusialStorageFactory","l":"load(File)","u":"load(java.io.File)"},{"p":"main","c":"Musial","l":"loadMetadata()"},{"p":"utility","c":"IO","l":"loadMusialDump(File)","u":"loadMusialDump(java.io.File)"},{"p":"utility","c":"Logger","l":"logError(String)","u":"logError(java.lang.String)"},{"p":"utility","c":"Logger","l":"Logger()","u":"%3Cinit%3E()"},{"p":"utility","c":"Logger","l":"logStatus(String)","u":"logStatus(java.lang.String)"},{"p":"utility","c":"Logger","l":"logWarning(String)","u":"logWarning(java.lang.String)"},{"p":"main","c":"Musial","l":"main(String[])","u":"main(java.lang.String[])"},{"p":"cli","c":"BuildConfiguration","l":"maximalHeterozygousFrequency"},{"p":"datastructure","c":"MusialStorageParameters","l":"maximalHeterozygousFrequency"},{"p":"cli","c":"BuildConfiguration","l":"minimalCoverage"},{"p":"datastructure","c":"MusialStorageParameters","l":"minimalCoverage"},{"p":"cli","c":"BuildConfiguration","l":"minimalHeterozygousFrequency"},{"p":"datastructure","c":"MusialStorageParameters","l":"minimalHeterozygousFrequency"},{"p":"cli","c":"BuildConfiguration","l":"minimalHomozygousFrequency"},{"p":"datastructure","c":"MusialStorageParameters","l":"minimalHomozygousFrequency"},{"p":"cli","c":"BuildConfiguration","l":"minimalQuality"},{"p":"datastructure","c":"MusialStorageParameters","l":"minimalQuality"},{"p":"main","c":"Musial","l":"Musial()","u":"%3Cinit%3E()"},{"p":"main","c":"MusialConstants","l":"MusialConstants()","u":"%3Cinit%3E()"},{"p":"exceptions","c":"MusialException","l":"MusialException(String)","u":"%3Cinit%3E(java.lang.String)"},{"p":"runnables","c":"AlleleAnalyzer","l":"musialStorage"},{"p":"runnables","c":"SampleAnalyzer","l":"musialStorage"},{"p":"runnables","c":"SnpEffAnnotator","l":"musialStorage"},{"p":"datastructure","c":"MusialStorage","l":"MusialStorage(IndexedFastaSequenceFile, Double, Double, Double, Double, Double)","u":"%3Cinit%3E(htsjdk.samtools.reference.IndexedFastaSequenceFile,java.lang.Double,java.lang.Double,java.lang.Double,java.lang.Double,java.lang.Double)"},{"p":"utility","c":"MusialStorageFactory","l":"MusialStorageFactory()","u":"%3Cinit%3E()"},{"p":"datastructure","c":"MusialStorageParameters","l":"MusialStorageParameters(Double, Double, Double, Double, Double)","u":"%3Cinit%3E(java.lang.Double,java.lang.Double,java.lang.Double,java.lang.Double,java.lang.Double)"},{"p":"cli","c":"CLIParser","l":"musialTaskDescription"},{"p":"main","c":"MusialTasks","l":"MusialTasks()","u":"%3Cinit%3E()"},{"p":"datastructure","c":"Feature","l":"name"},{"p":"datastructure","c":"Form","l":"name"},{"p":"datastructure","c":"Sample","l":"name"},{"p":"main","c":"Musial","l":"NAME"},{"p":"datastructure","c":"Feature","l":"nucleotideVariants"},{"p":"main","c":"MusialConstants","l":"NUMBER_DELETIONS"},{"p":"main","c":"MusialConstants","l":"NUMBER_INSERTIONS"},{"p":"main","c":"MusialConstants","l":"NUMBER_SUBSTITUTIONS"},{"p":"datastructure","c":"Form","l":"occurrence"},{"p":"main","c":"Musial","l":"ORIGINAL_ERR_STREAM"},{"p":"main","c":"Musial","l":"ORIGINAL_OUT_STREAM"},{"p":"cli","c":"BuildConfiguration","l":"output"},{"p":"main","c":"Musial","l":"outputView(LinkedHashMap>, int, String)","u":"outputView(java.util.LinkedHashMap,int,java.lang.String)"},{"p":"utility","c":"Bio","l":"PAM250"},{"p":"datastructure","c":"MusialStorage","l":"parameters"},{"p":"utility","c":"Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"PENALIZE"},{"p":"utility","c":"Logger","l":"printSoftwareInfo()"},{"p":"runnables","c":"SampleAnalyzer","l":"processVariantCall(int, double, double, double, Allele, Allele, int, int)","u":"processVariantCall(int,double,double,double,htsjdk.variant.variantcontext.Allele,htsjdk.variant.variantcontext.Allele,int,int)"},{"p":"datastructure","c":"VariantAnnotation","l":"properties"},{"p":"main","c":"MusialConstants","l":"PROTEOFORM_DIFFERENTIAL_SEQUENCE"},{"p":"main","c":"MusialConstants","l":"PROTEOFORM_NOVEL_STOPS"},{"p":"datastructure","c":"FeatureCoding","l":"proteoforms"},{"p":"utility","c":"IO","l":"readLinesFromFile(String)","u":"readLinesFromFile(java.lang.String)"},{"p":"utility","c":"IO","l":"readStructure(File)","u":"readStructure(java.io.File)"},{"p":"datastructure","c":"MusialStorage","l":"reference"},{"p":"main","c":"MusialConstants","l":"REFERENCE_CONTENT"},{"p":"main","c":"MusialConstants","l":"REFERENCE_ID"},{"p":"cli","c":"BuildConfiguration","l":"referenceFeatures"},{"p":"runnables","c":"SnpEffAnnotator","l":"referenceFeatures"},{"p":"cli","c":"BuildConfiguration","l":"referenceFeaturesFile"},{"p":"cli","c":"BuildConfiguration","l":"referenceSequence"},{"p":"cli","c":"BuildConfiguration","l":"referenceSequenceFile"},{"p":"runnables","c":"SnpEffAnnotator","l":"referenceSequences"},{"p":"datastructure","c":"Feature","l":"removeAllele(String)","u":"removeAllele(java.lang.String)"},{"p":"datastructure","c":"Feature","l":"removeAnnotation(String)","u":"removeAnnotation(java.lang.String)"},{"p":"datastructure","c":"Form","l":"removeAnnotation(String)","u":"removeAnnotation(java.lang.String)"},{"p":"datastructure","c":"Sample","l":"removeAnnotation(String)","u":"removeAnnotation(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"removeFeature(String)","u":"removeFeature(java.lang.String)"},{"p":"datastructure","c":"Form","l":"removeOccurrence(String)","u":"removeOccurrence(java.lang.String)"},{"p":"datastructure","c":"VariantAnnotation","l":"removeProperty(String)","u":"removeProperty(java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"removeProteoform(String)","u":"removeProteoform(java.lang.String)"},{"p":"utility","c":"Bio","l":"reverseComplement(String)","u":"reverseComplement(java.lang.String)"},{"p":"runnables","c":"AlleleAnalyzer","l":"run()"},{"p":"runnables","c":"SampleAnalyzer","l":"run()"},{"p":"runnables","c":"SnpEffAnnotator","l":"run()"},{"p":"utility","c":"CL","l":"runCommand(String[], String, String, String)","u":"runCommand(java.lang.String[],java.lang.String,java.lang.String,java.lang.String)"},{"p":"runnables","c":"SampleAnalyzer","l":"sample"},{"p":"main","c":"MusialConstants","l":"SAMPLE_ANNOTATION_ALLELE_PREFIX"},{"p":"main","c":"MusialConstants","l":"SAMPLE_ANNOTATION_PROTEOFORM_PREFIX"},{"p":"datastructure","c":"Sample","l":"Sample(File, String)","u":"%3Cinit%3E(java.io.File,java.lang.String)"},{"p":"runnables","c":"SampleAnalyzer","l":"SampleAnalyzer(Sample, Iterator, MusialStorage)","u":"%3Cinit%3E(datastructure.Sample,java.util.Iterator,datastructure.MusialStorage)"},{"p":"cli","c":"BuildConfiguration","l":"samples"},{"p":"datastructure","c":"MusialStorage","l":"samples"},{"p":"datastructure","c":"FeatureCoding","l":"setCodingSequence(String)","u":"setCodingSequence(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"setReference(IndexedFastaSequenceFile)","u":"setReference(htsjdk.samtools.reference.IndexedFastaSequenceFile)"},{"p":"datastructure","c":"FeatureCoding","l":"setStructure(File)","u":"setStructure(java.io.File)"},{"p":"main","c":"MusialConstants","l":"SNP_EFF_PROPERTIES"},{"p":"main","c":"MusialConstants","l":"SNP_EFF_PROPERTY_PREFIX"},{"p":"runnables","c":"SnpEffAnnotator","l":"SnpEffAnnotator(File, File, File, File, MusialStorage)","u":"%3Cinit%3E(java.io.File,java.io.File,java.io.File,java.io.File,datastructure.MusialStorage)"},{"p":"datastructure","c":"Feature","l":"start"},{"p":"main","c":"Musial","l":"START_TIME"},{"p":"datastructure","c":"FeatureCoding","l":"structure"},{"p":"runnables","c":"SnpEffAnnotator","l":"targetDirectory"},{"p":"runnables","c":"SnpEffAnnotator","l":"targetVcf"},{"p":"main","c":"Musial","l":"TASK"},{"p":"utility","c":"Bio","l":"TERMINATION_AA1"},{"p":"utility","c":"Bio","l":"TERMINATION_AA3"},{"p":"main","c":"Musial","l":"THREADS"},{"p":"datastructure","c":"MusialStorage","l":"toVcf()"},{"p":"runnables","c":"SnpEffAnnotator","l":"transferAnnotation()"},{"p":"main","c":"Musial","l":"transferAnnotation(LinkedHashMap>, int, HashSet, String, String)","u":"transferAnnotation(java.util.LinkedHashMap,int,java.util.HashSet,java.lang.String,java.lang.String)"},{"p":"runnables","c":"SampleAnalyzer","l":"transferVariantCall(String[])","u":"transferVariantCall(java.lang.String[])"},{"p":"runnables","c":"SampleAnalyzer","l":"transferVariantCalls()"},{"p":"utility","c":"Bio","l":"translateCodon(String, boolean, boolean, boolean)","u":"translateCodon(java.lang.String,boolean,boolean,boolean)"},{"p":"utility","c":"Bio","l":"translateNucSequence(Iterable, boolean, boolean)","u":"translateNucSequence(java.lang.Iterable,boolean,boolean)"},{"p":"utility","c":"Bio","l":"translateNucSequence(String, boolean, boolean, boolean)","u":"translateNucSequence(java.lang.String,boolean,boolean,boolean)"},{"p":"datastructure","c":"Feature","l":"type"},{"p":"cli","c":"CLIParser","l":"validateBuildOptions()"},{"p":"cli","c":"CLIParser","l":"validateExportSequenceOptions()"},{"p":"cli","c":"CLIParser","l":"validateExportTableOptions()"},{"p":"cli","c":"CLIParser","l":"validateViewFeaturesOptions()"},{"p":"cli","c":"CLIParser","l":"validateViewSamplesOptions()"},{"p":"cli","c":"CLIParser","l":"validateViewVariantsOptions()"},{"p":"utility","c":"Validation","l":"Validation()","u":"%3Cinit%3E()"},{"p":"main","c":"MusialTasks","l":"valueOf(String)","u":"valueOf(java.lang.String)"},{"p":"utility","c":"Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"valueOf(String)","u":"valueOf(java.lang.String)"},{"p":"main","c":"MusialTasks","l":"values()"},{"p":"utility","c":"Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"values()"},{"p":"main","c":"MusialConstants","l":"VARIABLE_POSITIONS"},{"p":"main","c":"MusialConstants","l":"VARIANT_OCCURRENCE_SAMPLE_PREFIX"},{"p":"datastructure","c":"VariantAnnotation","l":"VariantAnnotation()","u":"%3Cinit%3E()"},{"p":"runnables","c":"SampleAnalyzer","l":"variantCalls"},{"p":"runnables","c":"SampleAnalyzer","l":"variantFingerprint"},{"p":"main","c":"MusialConstants","l":"VARIANTS"},{"p":"datastructure","c":"Sample","l":"vcfFile"},{"p":"datastructure","c":"Sample","l":"vcfFileReader"},{"p":"main","c":"Musial","l":"VERSION"},{"p":"main","c":"MusialTasks","l":"VIEW_FEATURES"},{"p":"main","c":"MusialTasks","l":"VIEW_SAMPLES"},{"p":"main","c":"MusialTasks","l":"VIEW_VARIANTS"},{"p":"main","c":"Musial","l":"viewFeatures(CommandLine)","u":"viewFeatures(org.apache.commons.cli.CommandLine)"},{"p":"main","c":"Musial","l":"viewSamples(CommandLine)","u":"viewSamples(org.apache.commons.cli.CommandLine)"},{"p":"main","c":"Musial","l":"viewVariants(CommandLine)","u":"viewVariants(org.apache.commons.cli.CommandLine)"},{"p":"utility","c":"IO","l":"writeFasta(File, ArrayList>)","u":"writeFasta(java.io.File,java.util.ArrayList)"},{"p":"utility","c":"IO","l":"writeFile(File, String)","u":"writeFile(java.io.File,java.lang.String)"}];updateSearchResults(); \ No newline at end of file +memberSearchIndex = [{"p":"utility","c":"AlleleAnalyzer","l":"_featureCoding"},{"p":"utility","c":"SampleAnalyzer","l":"_sample"},{"p":"utility","c":"SequenceOperations","l":"AA1_PAM250_INDEX"},{"p":"utility","c":"SequenceOperations","l":"AA1TO3"},{"p":"utility","c":"SampleAnalyzer","l":"acceptedSites"},{"p":"datastructure","c":"Feature","l":"addAllele(Form)","u":"addAllele(datastructure.Form)"},{"p":"datastructure","c":"FeatureCoding","l":"addAminoacidVariant(int, String, String)","u":"addAminoacidVariant(int,java.lang.String,java.lang.String)"},{"p":"cli","c":"CLIParser","l":"addBuildOptions(Options)","u":"addBuildOptions(org.apache.commons.cli.Options)"},{"p":"cli","c":"CLIParser","l":"addExportSequenceOptions(Options)","u":"addExportSequenceOptions(org.apache.commons.cli.Options)"},{"p":"cli","c":"CLIParser","l":"addExportTableOptions(Options)","u":"addExportTableOptions(org.apache.commons.cli.Options)"},{"p":"datastructure","c":"MusialStorage","l":"addFeature(Feature)","u":"addFeature(datastructure.Feature)"},{"p":"cli","c":"BuildConfiguration","l":"addFeature(String, String, String, boolean, Map)","u":"addFeature(java.lang.String,java.lang.String,java.lang.String,boolean,java.util.Map)"},{"p":"datastructure","c":"InfoContainer","l":"addInfo(String, String)","u":"addInfo(java.lang.String,java.lang.String)"},{"p":"datastructure","c":"Feature","l":"addNucleotideVariant(int, String, String)","u":"addNucleotideVariant(int,java.lang.String,java.lang.String)"},{"p":"datastructure","c":"OccurrenceContainer","l":"addOccurrence(String)","u":"addOccurrence(java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"addProteoform(Form)","u":"addProteoform(datastructure.Form)"},{"p":"datastructure","c":"MusialStorage","l":"addSample(Sample)","u":"addSample(datastructure.Sample)"},{"p":"cli","c":"BuildConfiguration","l":"addSample(String, File, Map)","u":"addSample(java.lang.String,java.io.File,java.util.Map)"},{"p":"datastructure","c":"Sample","l":"addVariantCall(String, int, Tuple, List>)","u":"addVariantCall(java.lang.String,int,htsjdk.samtools.util.Tuple,java.util.List)"},{"p":"cli","c":"CLIParser","l":"addViewFeaturesOptions(Options)","u":"addViewFeaturesOptions(org.apache.commons.cli.Options)"},{"p":"cli","c":"CLIParser","l":"addViewSamplesOptions(Options)","u":"addViewSamplesOptions(org.apache.commons.cli.Options)"},{"p":"cli","c":"CLIParser","l":"addViewVariantsOptions(Options)","u":"addViewVariantsOptions(org.apache.commons.cli.Options)"},{"p":"datastructure","c":"Sample","l":"allele"},{"p":"utility","c":"AlleleAnalyzer","l":"allele"},{"p":"utility","c":"AlleleAnalyzer","l":"AlleleAnalyzer()","u":"%3Cinit%3E()"},{"p":"datastructure","c":"Feature","l":"alleles"},{"p":"utility","c":"AlleleAnalyzer","l":"allocateVariantsInformation()"},{"p":"utility","c":"SampleAnalyzer","l":"allocateVariantsInformation()"},{"p":"datastructure","c":"FeatureCoding","l":"aminoacidVariants"},{"p":"main","c":"Constants","l":"ANY_AMINOACID_CHAR"},{"p":"main","c":"Constants","l":"ANY_AMINOACID_STRING"},{"p":"main","c":"Constants","l":"ANY_AMINOACID3_STRING"},{"p":"main","c":"Constants","l":"ANY_NUCLEOTiDE_CHAR"},{"p":"main","c":"Constants","l":"ANY_NUCLEOTIDE_STRING"},{"p":"cli","c":"CLIParser","l":"arguments"},{"p":"utility","c":"Compression","l":"brotliDecodeBytes(byte[])"},{"p":"utility","c":"Compression","l":"brotliDecodeString(String)","u":"brotliDecodeString(java.lang.String)"},{"p":"utility","c":"Compression","l":"brotliEncodeString(String)","u":"brotliEncodeString(java.lang.String)"},{"p":"utility","c":"Compression","l":"brotliEncodeStringToBytes(String)","u":"brotliEncodeStringToBytes(java.lang.String)"},{"p":"main","c":"Tasks","l":"BUILD"},{"p":"datastructure","c":"MusialStorageFactory","l":"build(BuildConfiguration)","u":"build(cli.BuildConfiguration)"},{"p":"main","c":"Musial","l":"build(BuildConfiguration)","u":"build(cli.BuildConfiguration)"},{"p":"cli","c":"CLIParser","l":"buildConfiguration"},{"p":"cli","c":"BuildConfiguration","l":"BuildConfiguration(HashMap)","u":"%3Cinit%3E(java.util.HashMap)"},{"p":"main","c":"Constants","l":"CALL_INFO_NO_INFO"},{"p":"main","c":"Constants","l":"CALL_INFO_NO_VARIANT"},{"p":"main","c":"Constants","l":"CALL_INFO_REJECTED"},{"p":"datastructure","c":"Sample","l":"calls"},{"p":"utility","c":"CL","l":"CL()","u":"%3Cinit%3E()"},{"p":"main","c":"Musial","l":"CLI_PARSER"},{"p":"cli","c":"CLIParser","l":"CLIParser(String[])","u":"%3Cinit%3E(java.lang.String[])"},{"p":"datastructure","c":"FeatureCoding","l":"codingSequence"},{"p":"utility","c":"SequenceOperations","l":"CODON_MAP"},{"p":"main","c":"Musial","l":"COMPRESS"},{"p":"utility","c":"IO","l":"compressFile(File)","u":"compressFile(java.io.File)"},{"p":"utility","c":"Compression","l":"Compression()","u":"%3Cinit%3E()"},{"p":"main","c":"Constants","l":"Constants()","u":"%3Cinit%3E()"},{"p":"main","c":"Musial","l":"CONTACT"},{"p":"main","c":"Constants","l":"CONTENT_MODE_AMINOACID"},{"p":"main","c":"Constants","l":"CONTENT_MODE_NUCLEOTIDE"},{"p":"datastructure","c":"Feature","l":"contig"},{"p":"utility","c":"Logger","l":"DATE_FORMAT"},{"p":"main","c":"Musial","l":"DECIMAL_FORMATTER"},{"p":"utility","c":"IO","l":"deleteDirectory(File)","u":"deleteDirectory(java.io.File)"},{"p":"main","c":"Constants","l":"DELETION_OR_GAP_3_STRING"},{"p":"main","c":"Constants","l":"DELETION_OR_GAP_CHAR"},{"p":"main","c":"Constants","l":"DELETION_OR_GAP_STRING"},{"p":"datastructure","c":"MusialStorage","l":"dump(String, boolean)","u":"dump(java.lang.String,boolean)"},{"p":"main","c":"Musial","l":"EMPTY_STREAM"},{"p":"datastructure","c":"Feature","l":"end"},{"p":"main","c":"Musial","l":"END_TIME"},{"p":"cli","c":"BuildConfiguration","l":"EXCEPTION_PREFIX"},{"p":"utility","c":"SnpEffAnnotator","l":"EXCEPTION_PREFIX"},{"p":"cli","c":"BuildConfiguration","l":"excludedPositions"},{"p":"datastructure","c":"MusialStorage","l":"excludedPositions"},{"p":"cli","c":"CLIParser","l":"exitNotRecognized(String)","u":"exitNotRecognized(java.lang.String)"},{"p":"main","c":"Tasks","l":"EXPORT_SEQUENCE"},{"p":"main","c":"Tasks","l":"EXPORT_TABLE"},{"p":"main","c":"Musial","l":"exportSequence(CommandLine)","u":"exportSequence(org.apache.commons.cli.CommandLine)"},{"p":"main","c":"Musial","l":"exportTable(CommandLine)","u":"exportTable(org.apache.commons.cli.CommandLine)"},{"p":"utility","c":"SampleAnalyzer","l":"feature"},{"p":"datastructure","c":"Feature","l":"Feature(String, String, int, int, String)","u":"%3Cinit%3E(java.lang.String,java.lang.String,int,int,java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"FeatureCoding(String, String, int, int, String)","u":"%3Cinit%3E(java.lang.String,java.lang.String,int,int,java.lang.String)"},{"p":"cli","c":"BuildConfiguration","l":"features"},{"p":"datastructure","c":"MusialStorage","l":"features"},{"p":"main","c":"Constants","l":"FIELD_SEPARATOR_1"},{"p":"main","c":"Constants","l":"FIELD_SEPARATOR_2"},{"p":"utility","c":"SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"FORBID"},{"p":"datastructure","c":"Form","l":"Form(String, String)","u":"%3Cinit%3E(java.lang.String,java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"formNameCodes"},{"p":"utility","c":"SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"FREE"},{"p":"main","c":"Constants","l":"FREQUENCY"},{"p":"utility","c":"IO","l":"generateDirectory(File)","u":"generateDirectory(java.io.File)"},{"p":"utility","c":"IO","l":"generateFile(File)","u":"generateFile(java.io.File)"},{"p":"datastructure","c":"Feature","l":"getAllele(String)","u":"getAllele(java.lang.String)"},{"p":"datastructure","c":"Sample","l":"getAllele(String)","u":"getAllele(java.lang.String)"},{"p":"datastructure","c":"Feature","l":"getAlleleCount()"},{"p":"datastructure","c":"Feature","l":"getAlleleNameIterator()"},{"p":"datastructure","c":"FeatureCoding","l":"getAminoacidVariant(int, String)","u":"getAminoacidVariant(int,java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"getAminoacidVariantPositions()"},{"p":"datastructure","c":"FeatureCoding","l":"getAminoacidVariantsAt(int)"},{"p":"datastructure","c":"Sample","l":"getCallAt(String, int)","u":"getCallAt(java.lang.String,int)"},{"p":"datastructure","c":"Sample","l":"getCallVariantsStringAt(String, int)","u":"getCallVariantsStringAt(java.lang.String,int)"},{"p":"datastructure","c":"FeatureCoding","l":"getCodingSequence()"},{"p":"datastructure","c":"MusialStorage","l":"getFeature(String)","u":"getFeature(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"getFeatureNameIterator()"},{"p":"datastructure","c":"MusialStorage","l":"getFeatureNameIterator(int)"},{"p":"datastructure","c":"MusialStorage","l":"getFormName(int, String)","u":"getFormName(int,java.lang.String)"},{"p":"datastructure","c":"InfoContainer","l":"getInfo(String)","u":"getInfo(java.lang.String)"},{"p":"datastructure","c":"InfoContainer","l":"getInfoKeys()"},{"p":"datastructure","c":"InfoContainer","l":"getInfoSet()"},{"p":"datastructure","c":"Feature","l":"getNucleotideVariant(int, String)","u":"getNucleotideVariant(int,java.lang.String)"},{"p":"datastructure","c":"Feature","l":"getNucleotideVariantPositions()"},{"p":"datastructure","c":"Feature","l":"getNucleotideVariants(String)","u":"getNucleotideVariants(java.lang.String)"},{"p":"datastructure","c":"Feature","l":"getNucleotideVariantsAt(int)"},{"p":"datastructure","c":"MusialStorage","l":"getNumberOfSamples()"},{"p":"datastructure","c":"OccurrenceContainer","l":"getOccurrenceCount()"},{"p":"datastructure","c":"OccurrenceContainer","l":"getOccurrenceIterator()"},{"p":"datastructure","c":"OccurrenceContainer","l":"getOccurrenceSet()"},{"p":"datastructure","c":"FeatureCoding","l":"getProteoform(String)","u":"getProteoform(java.lang.String)"},{"p":"datastructure","c":"Sample","l":"getProteoform(String)","u":"getProteoform(java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"getProteoformCount()"},{"p":"datastructure","c":"FeatureCoding","l":"getProteoformNameIterator()"},{"p":"datastructure","c":"MusialStorage","l":"getReferenceSequenceOfFeature(String)","u":"getReferenceSequenceOfFeature(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"getSample(String)","u":"getSample(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"getSampleNameIterator()"},{"p":"utility","c":"Logger","l":"getTimestampDayTime()"},{"p":"datastructure","c":"Sample","l":"getVariantCalls(String)","u":"getVariantCalls(java.lang.String)"},{"p":"utility","c":"SequenceOperations","l":"getVariantsOfAlignedSequences(String, String)","u":"getVariantsOfAlignedSequences(java.lang.String,java.lang.String)"},{"p":"utility","c":"SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES()","u":"%3Cinit%3E()"},{"p":"utility","c":"SequenceOperations","l":"globalAminoAcidSequenceAlignment(String, String, int, int, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer)","u":"globalAminoAcidSequenceAlignment(java.lang.String,java.lang.String,int,int,utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,java.lang.Integer)"},{"p":"utility","c":"SequenceOperations","l":"globalNucleotideSequenceAlignment(String, String, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer)","u":"globalNucleotideSequenceAlignment(java.lang.String,java.lang.String,utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,java.lang.Integer)"},{"p":"utility","c":"SequenceOperations","l":"globalSequenceAlignment(String, String, HashMap, int[][], int, int, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES, Integer)","u":"globalSequenceAlignment(java.lang.String,java.lang.String,java.util.HashMap,int[][],int,int,utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES,java.lang.Integer)"},{"p":"datastructure","c":"Feature","l":"hasAllele(String)","u":"hasAllele(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"hasFeature(String)","u":"hasFeature(java.lang.String)"},{"p":"datastructure","c":"InfoContainer","l":"hasInfoKey(String)","u":"hasInfoKey(java.lang.String)"},{"p":"datastructure","c":"OccurrenceContainer","l":"hasOccurrence(String)","u":"hasOccurrence(java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"hasProteoform(String)","u":"hasProteoform(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"hasSample(String)","u":"hasSample(java.lang.String)"},{"p":"datastructure","c":"Sample","l":"imputeVcfFileReader()"},{"p":"datastructure","c":"InfoContainer","l":"info"},{"p":"datastructure","c":"InfoContainer","l":"InfoContainer()","u":"%3Cinit%3E()"},{"p":"utility","c":"SequenceOperations","l":"invertBase(char)"},{"p":"utility","c":"IO","l":"IO()","u":"%3Cinit%3E()"},{"p":"datastructure","c":"Sample","l":"isAmbiguousCallAt(String, int)","u":"isAmbiguousCallAt(java.lang.String,int)"},{"p":"datastructure","c":"Feature","l":"isCoding()"},{"p":"utility","c":"Validation","l":"isDirectory(File)","u":"isDirectory(java.io.File)"},{"p":"utility","c":"Validation","l":"isFile(File)","u":"isFile(java.io.File)"},{"p":"utility","c":"Validation","l":"isPercentage(String)","u":"isPercentage(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"isPositionExcluded(String, int)","u":"isPositionExcluded(java.lang.String,int)"},{"p":"utility","c":"Validation","l":"isPositiveDouble(String)","u":"isPositiveDouble(java.lang.String)"},{"p":"utility","c":"Validation","l":"isPositiveInteger(String)","u":"isPositiveInteger(java.lang.String)"},{"p":"datastructure","c":"Sample","l":"isReferenceCallAt(String, int)","u":"isReferenceCallAt(java.lang.String,int)"},{"p":"datastructure","c":"Feature","l":"isSense"},{"p":"datastructure","c":"Sample","l":"killVcfFileReader()"},{"p":"main","c":"Musial","l":"LICENSE"},{"p":"utility","c":"IO","l":"LINE_SEPARATOR"},{"p":"datastructure","c":"MusialStorageFactory","l":"load(File)","u":"load(java.io.File)"},{"p":"main","c":"Musial","l":"loadMetadata()"},{"p":"utility","c":"IO","l":"loadMusialDump(File)","u":"loadMusialDump(java.io.File)"},{"p":"utility","c":"Logger","l":"logError(String)","u":"logError(java.lang.String)"},{"p":"utility","c":"Logger","l":"Logger()","u":"%3Cinit%3E()"},{"p":"utility","c":"Logger","l":"logStatus(String)","u":"logStatus(java.lang.String)"},{"p":"utility","c":"Logger","l":"logWarning(String)","u":"logWarning(java.lang.String)"},{"p":"main","c":"Musial","l":"main(String[])","u":"main(java.lang.String[])"},{"p":"cli","c":"BuildConfiguration","l":"minimalCoverage"},{"p":"datastructure","c":"MusialStorageParameters","l":"minimalCoverage"},{"p":"cli","c":"BuildConfiguration","l":"minimalFrequency"},{"p":"datastructure","c":"MusialStorageParameters","l":"minimalFrequency"},{"p":"main","c":"Musial","l":"Musial()","u":"%3Cinit%3E()"},{"p":"exceptions","c":"MusialException","l":"MusialException(String)","u":"%3Cinit%3E(java.lang.String)"},{"p":"utility","c":"SnpEffAnnotator","l":"musialStorage"},{"p":"datastructure","c":"MusialStorage","l":"MusialStorage(IndexedFastaSequenceFile, Double, Double)","u":"%3Cinit%3E(htsjdk.samtools.reference.IndexedFastaSequenceFile,java.lang.Double,java.lang.Double)"},{"p":"datastructure","c":"MusialStorage","l":"MusialStorage(IndexedFastaSequenceFile, Double, Double, Collection, Collection, HashMap>)","u":"%3Cinit%3E(htsjdk.samtools.reference.IndexedFastaSequenceFile,java.lang.Double,java.lang.Double,java.util.Collection,java.util.Collection,java.util.HashMap)"},{"p":"datastructure","c":"MusialStorageFactory","l":"MusialStorageFactory()","u":"%3Cinit%3E()"},{"p":"datastructure","c":"MusialStorageParameters","l":"MusialStorageParameters(Double, Double)","u":"%3Cinit%3E(java.lang.Double,java.lang.Double)"},{"p":"cli","c":"CLIParser","l":"musialTaskDescription"},{"p":"datastructure","c":"Feature","l":"name"},{"p":"datastructure","c":"Form","l":"name"},{"p":"datastructure","c":"Sample","l":"name"},{"p":"main","c":"Musial","l":"NAME"},{"p":"utility","c":"AlleleAnalyzer","l":"novelTerminations"},{"p":"datastructure","c":"Feature","l":"nucleotideVariants"},{"p":"main","c":"Constants","l":"NUMBER_OF_AMBIGUOUS"},{"p":"main","c":"Constants","l":"NUMBER_OF_DELETIONS"},{"p":"main","c":"Constants","l":"NUMBER_OF_INSERTIONS"},{"p":"main","c":"Constants","l":"NUMBER_OF_SUBSTITUTIONS"},{"p":"datastructure","c":"OccurrenceContainer","l":"occurrence"},{"p":"datastructure","c":"OccurrenceContainer","l":"OccurrenceContainer()","u":"%3Cinit%3E()"},{"p":"main","c":"Musial","l":"ORIGINAL_OUT_STREAM"},{"p":"cli","c":"BuildConfiguration","l":"output"},{"p":"main","c":"Musial","l":"outputView(LinkedHashMap>, int, String)","u":"outputView(java.util.LinkedHashMap,int,java.lang.String)"},{"p":"utility","c":"SequenceOperations","l":"PAM250"},{"p":"datastructure","c":"MusialStorage","l":"parameters"},{"p":"utility","c":"SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"PENALIZE"},{"p":"utility","c":"Logger","l":"printSoftwareInfo()"},{"p":"utility","c":"SampleAnalyzer","l":"processVariantContext()"},{"p":"datastructure","c":"Sample","l":"proteoform"},{"p":"datastructure","c":"FeatureCoding","l":"proteoforms"},{"p":"utility","c":"IO","l":"readLinesFromFile(String)","u":"readLinesFromFile(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"reference"},{"p":"main","c":"Constants","l":"REFERENCE_FORM_NAME"},{"p":"datastructure","c":"VariantInformation","l":"referenceContent"},{"p":"cli","c":"BuildConfiguration","l":"referenceFeatures"},{"p":"utility","c":"SnpEffAnnotator","l":"referenceFeatures"},{"p":"cli","c":"BuildConfiguration","l":"referenceFeaturesFile"},{"p":"cli","c":"BuildConfiguration","l":"referenceSequence"},{"p":"cli","c":"BuildConfiguration","l":"referenceSequenceFile"},{"p":"utility","c":"SnpEffAnnotator","l":"referenceSequences"},{"p":"datastructure","c":"Feature","l":"removeAllele(String)","u":"removeAllele(java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"removeFeature(String)","u":"removeFeature(java.lang.String)"},{"p":"datastructure","c":"InfoContainer","l":"removeInfo(String)","u":"removeInfo(java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"removeProteoform(String)","u":"removeProteoform(java.lang.String)"},{"p":"utility","c":"SequenceOperations","l":"reverseComplement(String)","u":"reverseComplement(java.lang.String)"},{"p":"utility","c":"SnpEffAnnotator","l":"run()"},{"p":"utility","c":"AlleleAnalyzer","l":"run(FeatureCoding, MusialStorage)","u":"run(datastructure.FeatureCoding,datastructure.MusialStorage)"},{"p":"utility","c":"SampleAnalyzer","l":"run(Sample, Iterator, MusialStorage)","u":"run(datastructure.Sample,java.util.Iterator,datastructure.MusialStorage)"},{"p":"utility","c":"CL","l":"runCommand(String[], String, String, String)","u":"runCommand(java.lang.String[],java.lang.String,java.lang.String,java.lang.String)"},{"p":"datastructure","c":"Sample","l":"Sample(File, String, int)","u":"%3Cinit%3E(java.io.File,java.lang.String,int)"},{"p":"utility","c":"SampleAnalyzer","l":"SampleAnalyzer()","u":"%3Cinit%3E()"},{"p":"cli","c":"BuildConfiguration","l":"samples"},{"p":"datastructure","c":"MusialStorage","l":"samples"},{"p":"utility","c":"SequenceOperations","l":"SequenceOperations()","u":"%3Cinit%3E()"},{"p":"datastructure","c":"Sample","l":"setAllele(String, String)","u":"setAllele(java.lang.String,java.lang.String)"},{"p":"datastructure","c":"FeatureCoding","l":"setCodingSequence(String)","u":"setCodingSequence(java.lang.String)"},{"p":"datastructure","c":"Sample","l":"setProteoform(String, String)","u":"setProteoform(java.lang.String,java.lang.String)"},{"p":"datastructure","c":"MusialStorage","l":"setReference(IndexedFastaSequenceFile)","u":"setReference(htsjdk.samtools.reference.IndexedFastaSequenceFile)"},{"p":"utility","c":"AlleleAnalyzer","l":"sites"},{"p":"main","c":"Constants","l":"SNP_EFF_INFO_KEYS"},{"p":"main","c":"Constants","l":"SNP_EFF_INFO_PREFIX"},{"p":"utility","c":"SnpEffAnnotator","l":"SnpEffAnnotator(File, File, File, File, MusialStorage)","u":"%3Cinit%3E(java.io.File,java.io.File,java.io.File,java.io.File,datastructure.MusialStorage)"},{"p":"datastructure","c":"Feature","l":"start"},{"p":"main","c":"Musial","l":"START_TIME"},{"p":"utility","c":"AlleleAnalyzer","l":"storage"},{"p":"utility","c":"SampleAnalyzer","l":"storage"},{"p":"utility","c":"SnpEffAnnotator","l":"targetDirectory"},{"p":"utility","c":"SnpEffAnnotator","l":"targetVcf"},{"p":"main","c":"Musial","l":"TASK"},{"p":"main","c":"Tasks","l":"Tasks()","u":"%3Cinit%3E()"},{"p":"main","c":"Constants","l":"TERMINATION_AMINOACID_CHAR"},{"p":"main","c":"Constants","l":"TERMINATION_AMINOACID_STRING"},{"p":"main","c":"Constants","l":"TERMINATION_AMINOACID3_STRING"},{"p":"datastructure","c":"MusialStorage","l":"toVcf()"},{"p":"utility","c":"SnpEffAnnotator","l":"transferAnnotation()"},{"p":"main","c":"Musial","l":"transferContent(LinkedHashMap>, String, String, int)","u":"transferContent(java.util.LinkedHashMap,java.lang.String,java.lang.String,int)"},{"p":"utility","c":"SequenceOperations","l":"translateCodon(String, boolean, boolean, boolean)","u":"translateCodon(java.lang.String,boolean,boolean,boolean)"},{"p":"utility","c":"SequenceOperations","l":"translateNucSequence(Iterable, boolean, boolean)","u":"translateNucSequence(java.lang.Iterable,boolean,boolean)"},{"p":"utility","c":"SequenceOperations","l":"translateNucSequence(String, boolean, boolean, boolean)","u":"translateNucSequence(java.lang.String,boolean,boolean,boolean)"},{"p":"datastructure","c":"Feature","l":"type"},{"p":"main","c":"Constants","l":"TYPE"},{"p":"main","c":"Constants","l":"TYPE_AMBIGUOUS_PREFIX"},{"p":"main","c":"Constants","l":"TYPE_DELETION"},{"p":"main","c":"Constants","l":"TYPE_INSERTION"},{"p":"main","c":"Constants","l":"TYPE_SUBSTITUTION"},{"p":"main","c":"Musial","l":"updateStatistics(MusialStorage)","u":"updateStatistics(datastructure.MusialStorage)"},{"p":"cli","c":"CLIParser","l":"validateBuildOptions()"},{"p":"cli","c":"CLIParser","l":"validateExportSequenceOptions()"},{"p":"cli","c":"CLIParser","l":"validateExportTableOptions()"},{"p":"cli","c":"CLIParser","l":"validateViewFeaturesOptions()"},{"p":"cli","c":"CLIParser","l":"validateViewSamplesOptions()"},{"p":"cli","c":"CLIParser","l":"validateViewVariantsOptions()"},{"p":"utility","c":"Validation","l":"Validation()","u":"%3Cinit%3E()"},{"p":"main","c":"Tasks","l":"valueOf(String)","u":"valueOf(java.lang.String)"},{"p":"utility","c":"SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"valueOf(String)","u":"valueOf(java.lang.String)"},{"p":"main","c":"Tasks","l":"values()"},{"p":"utility","c":"SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES","l":"values()"},{"p":"main","c":"Constants","l":"VARIABLE_POSITIONS_PERCENTAGE"},{"p":"utility","c":"SampleAnalyzer","l":"variantContext"},{"p":"datastructure","c":"VariantInformation","l":"VariantInformation(String)","u":"%3Cinit%3E(java.lang.String)"},{"p":"utility","c":"SampleAnalyzer","l":"variantPosition"},{"p":"datastructure","c":"Form","l":"variants"},{"p":"datastructure","c":"Sample","l":"vcfFile"},{"p":"datastructure","c":"Sample","l":"vcfFileReader"},{"p":"main","c":"Musial","l":"VERSION"},{"p":"main","c":"Tasks","l":"VIEW_FEATURES"},{"p":"main","c":"Tasks","l":"VIEW_SAMPLES"},{"p":"main","c":"Tasks","l":"VIEW_VARIANTS"},{"p":"main","c":"Musial","l":"viewFeatures(CommandLine)","u":"viewFeatures(org.apache.commons.cli.CommandLine)"},{"p":"main","c":"Musial","l":"viewSamples(CommandLine)","u":"viewSamples(org.apache.commons.cli.CommandLine)"},{"p":"main","c":"Musial","l":"viewVariants(CommandLine)","u":"viewVariants(org.apache.commons.cli.CommandLine)"},{"p":"utility","c":"IO","l":"writeFile(File, String)","u":"writeFile(java.io.File,java.lang.String)"}];updateSearchResults(); \ No newline at end of file diff --git a/doc/overview-summary.html b/doc/overview-summary.html index 6f48aaf..28be419 100644 --- a/doc/overview-summary.html +++ b/doc/overview-summary.html @@ -1,11 +1,11 @@ - + Generated Documentation (Untitled) - + diff --git a/doc/overview-tree.html b/doc/overview-tree.html index 1841202..94d479d 100644 --- a/doc/overview-tree.html +++ b/doc/overview-tree.html @@ -1,11 +1,11 @@ - + Class Hierarchy - + @@ -55,7 +55,6 @@

    Hierarchy For All Packages

  • datastructure,
  • exceptions,
  • main,
  • -
  • runnables,
  • utility
  • @@ -64,28 +63,37 @@

    Class Hierarchy

    @@ -108,8 +115,8 @@

    Enum Class Hierarchy

    diff --git a/doc/package-search-index.js b/doc/package-search-index.js index aec9811..e363c67 100644 --- a/doc/package-search-index.js +++ b/doc/package-search-index.js @@ -1 +1 @@ -packageSearchIndex = [{"l":"All Packages","u":"allpackages-index.html"},{"l":"cli"},{"l":"datastructure"},{"l":"exceptions"},{"l":"main"},{"l":"runnables"},{"l":"utility"}];updateSearchResults(); \ No newline at end of file +packageSearchIndex = [{"l":"All Packages","u":"allpackages-index.html"},{"l":"cli"},{"l":"datastructure"},{"l":"exceptions"},{"l":"main"},{"l":"utility"}];updateSearchResults(); \ No newline at end of file diff --git a/doc/runnables/AlleleAnalyzer.html b/doc/runnables/AlleleAnalyzer.html index 769d780..9df65ea 100644 --- a/doc/runnables/AlleleAnalyzer.html +++ b/doc/runnables/AlleleAnalyzer.html @@ -72,7 +72,7 @@

    Class AlleleAnalyzer

    java.lang.Object -
    runnables.AlleleAnalyzer
    +
    utility.AlleleAnalyzer
    diff --git a/doc/runnables/SampleAnalyzer.html b/doc/runnables/SampleAnalyzer.html index 7b64fb5..60ecda6 100644 --- a/doc/runnables/SampleAnalyzer.html +++ b/doc/runnables/SampleAnalyzer.html @@ -72,7 +72,7 @@

    Class SampleAnalyzer

    java.lang.Object -
    runnables.SampleAnalyzer
    +
    utility.SampleAnalyzer
    @@ -123,7 +123,7 @@

    Field Summary

    -
    A ConcurrentSkipListMap to temporarily store novel variant calls.
    +
    A ConcurrentSkipListMap to temporarily store novel variantInformation calls.
    @@ -172,37 +172,37 @@

    Method Summary

    double quality, double coverage)
    -
    Add information about a variant call to variantCalls.
    +
    Add information about a variantInformation call to variantCalls.
    private Iterator<String>
     
    private void
    -
    processVariantCall(int variantPosition, +
    processVariantCall(int variantPosition, double variantQuality, double variantCoverage, double variantFrequency, - htsjdk.variant.variantcontext.Allele variantAllele, - htsjdk.variant.variantcontext.Allele referenceAllele, + htsjdk.variantInformation.variantcontext.Allele variantAllele, + htsjdk.variantInformation.variantcontext.Allele referenceAllele, int rank, int maximalRank)
    -
    Process a single variant call.
    +
    Process a single variantInformation call.
    void
    run()
    -
    Run sample variant call analysis.
    +
    Run sample variantInformation call analysis.
    private void
    transferVariantCall(String[] variantCall)
    -
    Transfer a single variant call to feature.
    +
    Transfer a single variantInformation call to feature.
    private void
    -
    Transfer all collected variant calls to feature.
    +
    Transfer all collected variantInformation calls to feature.
    @@ -260,13 +260,13 @@

    variantFingerprint

    variantCalls

    public HashSet<String> variantCalls
    -
    A ConcurrentSkipListMap to temporarily store novel variant calls. +
    A ConcurrentSkipListMap to temporarily store novel variantInformation calls.

    Entries are stored as _:_ separated String values in the following order:

      -
    • position of the variant wrt. the reference genome
    • -
    • rank of the variant in case of multiple calls of the same sample at the same position
    • -
    • if the variant is rejected wrt. MusialStorage.parameters
    • +
    • position of the variantInformation wrt. the reference genome
    • +
    • rank of the variantInformation in case of multiple calls of the same sample at the same position
    • +
    • if the variantInformation is rejected wrt. MusialStorage.parameters
    • alt. base content of the call
    • ref. base content of the call
    • frequency of the call wrt. read support
    • @@ -310,7 +310,7 @@

      Method Details

      run

      public void run()
      -
      Run sample variant call analysis.
      +
      Run sample variantInformation call analysis.
      Specified by:
      run in interface Runnable
      @@ -318,17 +318,17 @@

      run

    • -
      +

      processVariantCall

      private void processVariantCall(int variantPosition, double variantQuality, double variantCoverage, double variantFrequency, - htsjdk.variant.variantcontext.Allele variantAllele, - htsjdk.variant.variantcontext.Allele referenceAllele, + htsjdk.variantInformation.variantcontext.Allele variantAllele, + htsjdk.variantInformation.variantcontext.Allele referenceAllele, int rank, int maximalRank)
      -
      Process a single variant call.
      +
      Process a single variantInformation call.
    • @@ -343,7 +343,7 @@

      addVariantCall

      double frequency, double quality, double coverage)
    -
    Add information about a variant call to variantCalls.
    +
    Add information about a variantInformation call to variantCalls.
  • @@ -352,7 +352,7 @@

    getVariantCallsIterator

    private Iterator<String> getVariantCallsIterator()
    Returns:
    -
    Iterator over all variant calls in variantCalls.
    +
    Iterator over all variantInformation calls in variantCalls.
  • @@ -361,10 +361,10 @@

    getVariantCallsIterator

    transferVariantCalls

    private void transferVariantCalls() throws IOException
    -
    Transfer all collected variant calls to feature.
    +
    Transfer all collected variantInformation calls to feature.
    Throws:
    -
    IOException - If variant encoding fails.
    +
    IOException - If variantInformation encoding fails.
    @@ -372,7 +372,7 @@

    transferVariantCalls

    transferVariantCall

    private void transferVariantCall(String[] variantCall)
    -
    Transfer a single variant call to feature. +
    Transfer a single variantInformation call to feature.

    See format of variantCalls for field access documentation.

    diff --git a/doc/runnables/SampleAnalyzerRunnable.html b/doc/runnables/SampleAnalyzerRunnable.html index dbb9dcd..133d770 100644 --- a/doc/runnables/SampleAnalyzerRunnable.html +++ b/doc/runnables/SampleAnalyzerRunnable.html @@ -76,7 +76,7 @@

    Class SampleAnalyzerRunnable

    java.lang.Object -
    runnables.SampleAnalyzer
    +
    utility.SampleAnalyzer
    @@ -195,16 +195,16 @@

    Method Summary

    private void -processVariantCall​(int variantPosition, +processVariantCall​(int variantPosition, double variantQuality, double variantCoverage, double variantFrequency, -htsjdk.variant.variantcontext.Allele variantAllele, -htsjdk.variant.variantcontext.Allele referenceAllele, +htsjdk.variantInformation.variantcontext.Allele variantAllele, +htsjdk.variantInformation.variantcontext.Allele referenceAllele, boolean isHetCall, boolean isPrimary) -
    Internal method to process a variant-call.
    +
    Internal method to process a variantInformation-call.
    @@ -305,28 +305,28 @@

    run

  • -
    +

    processVariantCall

    private void processVariantCall​(int variantPosition, double variantQuality, double variantCoverage, double variantFrequency, -htsjdk.variant.variantcontext.Allele variantAllele, -htsjdk.variant.variantcontext.Allele referenceAllele, +htsjdk.variantInformation.variantcontext.Allele variantAllele, +htsjdk.variantInformation.variantcontext.Allele referenceAllele, boolean isHetCall, boolean isPrimary)
    -
    Internal method to process a variant-call.
    +
    Internal method to process a variantInformation-call.
    Parameters:
    -
    variantPosition - String the position of the variant.
    -
    variantQuality - Double the quality of the variant.
    -
    variantCoverage - Double the coverage of the variant.
    -
    variantFrequency - Double the frequency of the variant.
    +
    variantPosition - String the position of the variantInformation.
    +
    variantQuality - Double the quality of the variantInformation.
    +
    variantCoverage - Double the coverage of the variantInformation.
    +
    variantFrequency - Double the frequency of the variantInformation.
    variantAllele - Allele the alternative form information.
    referenceAllele - Allele the reference form information.
    -
    isHetCall - Boolean to indicate if the variant originates from a het. call; necessary to +
    isHetCall - Boolean to indicate if the variantInformation originates from a het. call; necessary to apply the correct filter method.
    -
    isPrimary - Boolean to indicate if the variant originates from the most frequent form.
    +
    isPrimary - Boolean to indicate if the variantInformation originates from the most frequent form.
  • diff --git a/doc/runnables/SnpEffAnnotator.html b/doc/runnables/SnpEffAnnotator.html index c29d509..04c3376 100644 --- a/doc/runnables/SnpEffAnnotator.html +++ b/doc/runnables/SnpEffAnnotator.html @@ -72,7 +72,7 @@

    Class SnpEffAnnotator

    java.lang.Object -
    runnables.SnpEffAnnotator
    +
    utility.SnpEffAnnotator

    @@ -149,7 +149,7 @@

    Method Summary

    void
    run()
    -
    Run SnpEff variant call annotation.
    +
    Run SnpEff variantInformation call annotation.
    private void
    @@ -211,7 +211,7 @@

    EXCEPTION_PREFIX

    See Also:
    @@ -258,7 +258,7 @@

    run

    public void run() throws MusialException, IOException
    -
    Run SnpEff variant call annotation.
    +
    Run SnpEff variantInformation call annotation.
    Throws:
    MusialException
    diff --git a/doc/serialized-form.html b/doc/serialized-form.html index 61360dd..d7b3b06 100644 --- a/doc/serialized-form.html +++ b/doc/serialized-form.html @@ -1,11 +1,11 @@ - + Serialized Form - + diff --git a/doc/type-search-index.js b/doc/type-search-index.js index 35d89bc..a86b9fd 100644 --- a/doc/type-search-index.js +++ b/doc/type-search-index.js @@ -1 +1 @@ -typeSearchIndex = [{"l":"All Classes and Interfaces","u":"allclasses-index.html"},{"p":"runnables","l":"AlleleAnalyzer"},{"p":"utility","l":"Bio"},{"p":"cli","l":"BuildConfiguration"},{"p":"utility","l":"CL"},{"p":"cli","l":"CLIParser"},{"p":"utility","l":"Compression"},{"p":"datastructure","l":"Feature"},{"p":"datastructure","l":"FeatureCoding"},{"p":"datastructure","l":"Form"},{"p":"utility","l":"Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES"},{"p":"utility","l":"IO"},{"p":"utility","l":"Logger"},{"p":"main","l":"Musial"},{"p":"main","l":"MusialConstants"},{"p":"exceptions","l":"MusialException"},{"p":"datastructure","l":"MusialStorage"},{"p":"utility","l":"MusialStorageFactory"},{"p":"datastructure","l":"MusialStorageParameters"},{"p":"main","l":"MusialTasks"},{"p":"datastructure","l":"Sample"},{"p":"runnables","l":"SampleAnalyzer"},{"p":"runnables","l":"SnpEffAnnotator"},{"p":"utility","l":"Validation"},{"p":"datastructure","l":"VariantAnnotation"}];updateSearchResults(); \ No newline at end of file +typeSearchIndex = [{"l":"All Classes and Interfaces","u":"allclasses-index.html"},{"p":"utility","l":"AlleleAnalyzer"},{"p":"cli","l":"BuildConfiguration"},{"p":"utility","l":"CL"},{"p":"cli","l":"CLIParser"},{"p":"utility","l":"Compression"},{"p":"main","l":"Constants"},{"p":"datastructure","l":"Feature"},{"p":"datastructure","l":"FeatureCoding"},{"p":"datastructure","l":"Form"},{"p":"utility","l":"SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES"},{"p":"datastructure","l":"InfoContainer"},{"p":"utility","l":"IO"},{"p":"utility","l":"Logger"},{"p":"main","l":"Musial"},{"p":"exceptions","l":"MusialException"},{"p":"datastructure","l":"MusialStorage"},{"p":"datastructure","l":"MusialStorageFactory"},{"p":"datastructure","l":"MusialStorageParameters"},{"p":"datastructure","l":"OccurrenceContainer"},{"p":"datastructure","l":"Sample"},{"p":"utility","l":"SampleAnalyzer"},{"p":"utility","l":"SequenceOperations"},{"p":"utility","l":"SnpEffAnnotator"},{"p":"main","l":"Tasks"},{"p":"utility","l":"Validation"},{"p":"datastructure","l":"VariantInformation"}];updateSearchResults(); \ No newline at end of file diff --git a/doc/utility/AlleleAnalyzer.html b/doc/utility/AlleleAnalyzer.html new file mode 100644 index 0000000..2dd42e6 --- /dev/null +++ b/doc/utility/AlleleAnalyzer.html @@ -0,0 +1,267 @@ + + + + +AlleleAnalyzer + + + + + + + + + + + + + + + +
    + +
    +
    + +
    +
    Package utility
    +

    Class AlleleAnalyzer

    +
    +
    java.lang.Object +
    utility.AlleleAnalyzer
    +
    +
    +
    +
    public class AlleleAnalyzer +extends Object
    +
    Implements static methods for allele analysis to infer proteoforms. +

    + Analyzes alleles of features, aligns them with reference sequences, and derives variant information.

    +
    +
    Since:
    +
    2.2
    +
    +
    +
    + +
    +
    +
      + +
    • +
      +

      Field Details

      +
        +
      • +
        +

        storage

        +
        private static MusialStorage storage
        +
        The MusialStorage instance containing genetic variant data.
        +
        +
      • +
      • +
        +

        _featureCoding

        +
        private static FeatureCoding _featureCoding
        +
        The current FeatureCoding instance to be analyzed.
        +
        +
      • +
      • +
        +

        allele

        +
        private static Form allele
        +
        The current allele being analyzed.
        +
        +
      • +
      • +
        +

        sites

        +
        private static ArrayList<org.apache.commons.lang3.tuple.Triple<Integer,String,String>> sites
        +
        Container of all called sites to infer alleles.
        +
        +
      • +
      • +
        +

        novelTerminations

        +
        private static ArrayList<String> novelTerminations
        +
        List of positions where novel terminations are found.
        +
        +
      • +
      +
      +
    • + +
    • +
      +

      Constructor Details

      +
        +
      • +
        +

        AlleleAnalyzer

        +
        public AlleleAnalyzer()
        +
        +
      • +
      +
      +
    • + +
    • +
      +

      Method Details

      +
        +
      • +
        +

        run

        +
        public static void run(FeatureCoding featureCoding, + MusialStorage musialStorage)
        +
        Runs the allele analysis for a given FeatureCoding and MusialStorage.
        +
        +
        Parameters:
        +
        featureCoding - The FeatureCoding instance representing the feature to be analyzed.
        +
        musialStorage - The MusialStorage instance containing genetic variant data.
        +
        +
        +
      • +
      • +
        +

        allocateVariantsInformation

        +
        private static void allocateVariantsInformation()
        +
        Allocates variant information for the analyzed allele.
        +
        +
      • +
      +
      +
    • +
    +
    + +
    +
    +
    + + diff --git a/doc/utility/Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES.html b/doc/utility/Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES.html index a9afebf..bab12dc 100644 --- a/doc/utility/Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES.html +++ b/doc/utility/Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES.html @@ -73,7 +73,7 @@

    java.lang.Object
    java.lang.Enum<Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES> -
    utility.Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    +
    utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    diff --git a/doc/utility/Bio.html b/doc/utility/Bio.html index a54c7bd..58897f3 100644 --- a/doc/utility/Bio.html +++ b/doc/utility/Bio.html @@ -72,7 +72,7 @@

    Class Bio

    java.lang.Object -
    utility.Bio
    +
    utility.SequenceOperations

    @@ -201,7 +201,7 @@

    Method Summary

    Computes variants from two aligned sequences.
    static org.javatuples.Triplet<Integer,String,String>
    -
    globalAminoAcidSequenceAlignment(String aaSeq1, +
    globalAminoAcidSequenceAlignment(String aaSeq1, String aaSeq2, int gapOpenPenalty, int gapExtendPenalty, @@ -209,21 +209,21 @@

    Method Summary

    Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES right_mode, Integer bandWidth)
    -
    static org.javatuples.Triplet<Integer,String,String>
    -

    @@ -309,7 +309,7 @@

    TERMINATION_AA3

    See Also:
    @@ -324,7 +324,7 @@

    ANY_AA1

    See Also:
    @@ -339,7 +339,7 @@

    ANY_AA3

    See Also:
    @@ -354,7 +354,7 @@

    DELETION_AA1

    See Also:
    @@ -369,7 +369,7 @@

    ANY_NUC

    See Also:
    @@ -384,7 +384,7 @@

    GAP

    See Also:
    @@ -544,14 +544,14 @@

    invertBase

  • -
    +

    globalNucleotideSequenceAlignment

    public static org.javatuples.Triplet<Integer,String,String> globalNucleotideSequenceAlignment(String nucSeq1, String nucSeq2, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES left_mode, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES right_mode, Integer bandWidth)
    -
  • -
    +

    globalAminoAcidSequenceAlignment

    public static org.javatuples.Triplet<Integer,String,String> globalAminoAcidSequenceAlignment(String aaSeq1, String aaSeq2, @@ -578,7 +578,7 @@

    globalAminoAcidSequenceAlignment

    Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES left_mode, Bio.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES right_mode, Integer bandWidth)
    -
  • -
    +

    globalSequenceAlignment

    private static org.javatuples.Triplet<Integer,String,String> globalSequenceAlignment(String seq1, String seq2, @@ -632,7 +632,7 @@

    getVariantsOfAlignedSequences

    String querySequence)
    Computes variants from two aligned sequences.

    - Variants are extracted wrt. the query versus the target sequence and formatted as p:r:a, where p is the variant + Variants are extracted wrt. the query versus the target sequence and formatted as p:r:a, where p is the variantInformation position, r is the reference content and a is the single position alternate content.

    Parameters:
    diff --git a/doc/utility/CL.html b/doc/utility/CL.html index d7dd325..4d56726 100644 --- a/doc/utility/CL.html +++ b/doc/utility/CL.html @@ -1,11 +1,11 @@ - + CL - + @@ -78,7 +78,7 @@

    Class CL


    public class CL extends Object
    -
    This class comprises static methods used for calling command line commands.
    +
    Implements static methods to run command line commands.
    Since:
    2.0
    diff --git a/doc/utility/Compression.html b/doc/utility/Compression.html index fd601bf..dec3c55 100644 --- a/doc/utility/Compression.html +++ b/doc/utility/Compression.html @@ -1,11 +1,11 @@ - + Compression - + @@ -78,7 +78,7 @@

    Class Compression


    public class Compression extends Object
    -
    Comprises static methods to compress String content using the `brotli4j` library.
    +
    Implements static methods to compress String content using the `brotli4j` library.
    Since:
    2.2
    diff --git a/doc/utility/IO.html b/doc/utility/IO.html index aa352af..0cd09b4 100644 --- a/doc/utility/IO.html +++ b/doc/utility/IO.html @@ -1,11 +1,11 @@ - + IO - + @@ -130,34 +130,23 @@

    Method Summary

    static void
    -
    Compress a target file using brotli.
    +
    DEPRECATED Compress a target file using brotli.
    static void
    -
    copyFile(File file, - File target)
    +
    -
    Copies the file pointed to with file to the file pointed to with target.
    +
    Accepts a File object representing a directory that is subject to deletion.
    static void
    - +
    -
    Accepts a File object representing a directory that is subject to deletion.
    +
    Tries to generate the directory specified by the passed File object.
    static void
    - +
    -
    Tries to generate the directory specified by the passed File object.
    -
    -
    static void
    - -
    Tries to generate the file specified by the passed File object.
    - -
    getSequencesFromPdbStructure(org.biojava.nbio.structure.Structure structure)
    -
    -
    Returns the chains sequences from a Structure instance parsed from a .pdb file.
    -
    loadMusialDump(File dumpFile)
    @@ -168,17 +157,6 @@

    Method Summary

    Reads a file and returns its content line-wise as list.
    -
    static org.biojava.nbio.structure.Structure
    - -
    -
    Parses a Structure instance from a File pointing to a pdb file.
    -
    -
    static void
    -
    writeFasta(File outputFile, - ArrayList<htsjdk.samtools.util.Tuple<String,String>> sequences)
    -
    -
    // TODO: Fix comment.
    -
    static void
    writeFile(File outputFile, String fileContent)
    @@ -252,7 +230,8 @@

    readLinesFromFile

    loadMusialDump

    public static MusialStorage loadMusialDump(File dumpFile) - throws IOException
    + throws IOException, +MusialException
    Initializes a MusialStorage object from a variants dictionary JSON file.
    Parameters:
    @@ -261,6 +240,7 @@

    loadMusialDump

    MusialStorage instance.
    Throws:
    IOException - If any error occurs while parsing the variants dictionary JSON file.
    +
    MusialException
  • @@ -307,69 +287,6 @@

    generateFile

  • -
    -

    copyFile

    -
    public static void copyFile(File file, - File target) - throws MusialException
    -
    Copies the file pointed to with file to the file pointed to with target.
    -
    -
    Parameters:
    -
    file - File object, the source file.
    -
    target - File object, the target file.
    -
    Throws:
    -
    MusialException - If the copy procedure fails.
    -
    -
    -
  • -
  • -
    -

    getSequencesFromPdbStructure

    -
    public static HashMap<String,String> getSequencesFromPdbStructure(org.biojava.nbio.structure.Structure structure)
    -
    Returns the chains sequences from a Structure instance parsed from a .pdb file.
    -
    -
    Parameters:
    -
    structure - Structure instance to extract the chains sequences from.
    -
    Returns:
    -
    HashMap storing the .pdb files amino-acid sequences per chain.
    -
    -
    -
  • -
  • -
    -

    readStructure

    -
    public static org.biojava.nbio.structure.Structure readStructure(File pdbFile) - throws IOException
    -
    Parses a Structure instance from a File pointing to a pdb file.
    -
    -
    Parameters:
    -
    pdbFile - File instance pointing to a pdb file.
    -
    Returns:
    -
    Structure object parsed from specified pdb file.
    -
    Throws:
    -
    IOException - If any error occurs while parsing the pdb file.
    -
    -
    -
  • -
  • -
    -

    writeFasta

    -
    public static void writeFasta(File outputFile, - ArrayList<htsjdk.samtools.util.Tuple<String,String>> sequences)
    -
    // TODO: Fix comment. - Writes a fasta format file to the specified output file from a HashMap instance mapping sequences to - lists of identifiers (used to construct the fasta entry headers). -

    - Each key of the passed map will be used to build one fasta entry. The header of the respective entry is - constructed by joining all Strings of the value accessible via the (sequence) key with the `|` delimiter.

    -
    -
    Parameters:
    -
    outputFile - File object pointing to the output fasta file.
    -
    sequences - HashMap mapping sequences to ArrayList of strings.
    -
    -
    -
  • -
  • writeFile

    public static void writeFile(File outputFile, @@ -389,7 +306,7 @@

    writeFile

    compressFile

    public static void compressFile(File target)
    -
    Compress a target file using brotli.
    +
    DEPRECATED Compress a target file using brotli.
    Parameters:
    target - File target to compress.
    diff --git a/doc/utility/Logger.html b/doc/utility/Logger.html index 89845a2..1a40e58 100644 --- a/doc/utility/Logger.html +++ b/doc/utility/Logger.html @@ -1,11 +1,11 @@ - + Logger - + diff --git a/doc/utility/MusialStorageFactory.html b/doc/utility/MusialStorageFactory.html index 33a7bc1..123ea9a 100644 --- a/doc/utility/MusialStorageFactory.html +++ b/doc/utility/MusialStorageFactory.html @@ -72,7 +72,7 @@

    Class MusialStorageFactory

    java.lang.Object -
    utility.MusialStorageFactory
    +
    datastructure.MusialStorageFactory

    diff --git a/doc/utility/SampleAnalyzer.html b/doc/utility/SampleAnalyzer.html new file mode 100644 index 0000000..28cf62e --- /dev/null +++ b/doc/utility/SampleAnalyzer.html @@ -0,0 +1,292 @@ + + + + +SampleAnalyzer + + + + + + + + + + + + + + + +
    + +
    +
    + +
    +
    Package utility
    +

    Class SampleAnalyzer

    +
    +
    java.lang.Object +
    utility.SampleAnalyzer
    +
    +
    +
    +
    public final class SampleAnalyzer +extends Object
    +
    Implements static methods to run sample/.vcf analysis.
    +
    +
    Since:
    +
    2.0
    +
    +
    +
    +
      + +
    • +
      +

      Field Summary

      +
      Fields
      +
      +
      Modifier and Type
      +
      Field
      +
      Description
      +
      private static Sample
      + +
      +
      The current Sample being analyzed.
      +
      +
      private static ArrayList<org.apache.commons.lang3.tuple.Triple<Integer,String,String>>
      + +
      +
      Container of all accepted variant sites to infer alleles.
      +
      +
      private static Feature
      + +
      +
      The current Feature being analyzed.
      +
      +
      private static MusialStorage
      + +
      +
      The MusialStorage instance containing genetic variant data.
      +
      +
      private static htsjdk.variant.variantcontext.VariantContext
      + +
      +
      The VariantContext representing a genetic variant.
      +
      +
      private static int
      + +
      +
      The position of the genetic variant.
      +
      +
      +
      +
    • + +
    • +
      +

      Constructor Summary

      +
      Constructors
      +
      +
      Constructor
      +
      Description
      + +
       
      +
      +
      +
    • + +
    • +
      +

      Method Summary

      +
      +
      +
      +
      +
      Modifier and Type
      +
      Method
      +
      Description
      +
      private static void
      + +
      +
      Allocates variant information for the analyzed sample.
      +
      +
      private static void
      + +
      +
      Processes a single variant call within the sample analysis.
      +
      +
      static void
      +
      run(Sample sample, + Iterator<String> featureNames, + MusialStorage musialStorage)
      +
      +
      Runs the sample analysis for a given Sample, iterator of feature names, and MusialStorage.
      +
      +
      +
      +
      +
      +

      Methods inherited from class java.lang.Object

      +clone, equals, getClass, hashCode, notify, notifyAll, toString, wait, wait, wait
      +
      +
    • +
    +
    +
    +
      + +
    • +
      +

      Field Details

      +
        +
      • +
        +

        storage

        +
        private static MusialStorage storage
        +
        The MusialStorage instance containing genetic variant data.
        +
        +
      • +
      • +
        +

        feature

        +
        private static Feature feature
        +
        The current Feature being analyzed.
        +
        +
      • +
      • +
        +

        _sample

        +
        private static Sample _sample
        +
        The current Sample being analyzed.
        +
        +
      • +
      • +
        +

        acceptedSites

        +
        private static ArrayList<org.apache.commons.lang3.tuple.Triple<Integer,String,String>> acceptedSites
        +
        Container of all accepted variant sites to infer alleles.
        +
        +
      • +
      • +
        +

        variantContext

        +
        private static htsjdk.variant.variantcontext.VariantContext variantContext
        +
        The VariantContext representing a genetic variant.
        +
        +
      • +
      • +
        +

        variantPosition

        +
        private static int variantPosition
        +
        The position of the genetic variant.
        +
        +
      • +
      +
      +
    • + +
    • +
      +

      Constructor Details

      +
        +
      • +
        +

        SampleAnalyzer

        +
        public SampleAnalyzer()
        +
        +
      • +
      +
      +
    • + +
    • +
      +

      Method Details

      +
        +
      • +
        +

        run

        +
        public static void run(Sample sample, + Iterator<String> featureNames, + MusialStorage musialStorage)
        +
        Runs the sample analysis for a given Sample, iterator of feature names, and MusialStorage.
        +
        +
        Parameters:
        +
        sample - The Sample instance to be analyzed.
        +
        featureNames - An iterator of feature names to be analyzed.
        +
        musialStorage - The MusialStorage instance containing genetic variant data.
        +
        +
        +
      • +
      • +
        +

        processVariantContext

        +
        private static void processVariantContext()
        +
        Processes a single variant call within the sample analysis.
        +
        +
      • +
      • +
        +

        allocateVariantsInformation

        +
        private static void allocateVariantsInformation()
        +
        Allocates variant information for the analyzed sample.
        +
        +
      • +
      +
      +
    • +
    +
    + +
    +
    +
    + + diff --git a/doc/utility/SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES.html b/doc/utility/SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES.html new file mode 100644 index 0000000..136e8f2 --- /dev/null +++ b/doc/utility/SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES.html @@ -0,0 +1,268 @@ + + + + +SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES + + + + + + + + + + + + + + + +
    + +
    +
    + +
    +
    Package utility
    +

    Enum Class SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES

    +
    +
    java.lang.Object +
    java.lang.Enum<SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES> +
    utility.SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES
    +
    +
    +
    +
    +
    All Implemented Interfaces:
    +
    Serializable, Comparable<SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES>, Constable
    +
    +
    +
    Enclosing class:
    +
    SequenceOperations
    +
    +
    +
    public static enum SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES +extends Enum<SequenceOperations.GLOBAL_SEQUENCE_ALIGNMENT_MARGIN_GAP_MODES>
    +
    Enum to store different modes to handle prefix gaps for global sequence alignment.
    +
    +
    + +
    +
    + +
    + +
    +
    +
    + + diff --git a/doc/utility/SequenceOperations.html b/doc/utility/SequenceOperations.html new file mode 100644 index 0000000..813ac2a --- /dev/null +++ b/doc/utility/SequenceOperations.html @@ -0,0 +1,516 @@ + + + + +SequenceOperations + + + + + + + + + + + + + + + +
    + +
    +
    + +
    +
    Package utility
    +

    Class SequenceOperations

    +
    +
    java.lang.Object +
    utility.SequenceOperations
    +
    +
    +
    +
    public final class SequenceOperations +extends Object
    +
    Implements static methods for sequence operations, such as inversion, translation, and alignment.
    +
    +
    Since:
    +
    2.0
    +
    +
    +
    + +
    +
    + +
    + +
    +
    +
    + + diff --git a/doc/utility/SnpEffAnnotator.html b/doc/utility/SnpEffAnnotator.html new file mode 100644 index 0000000..99abbd9 --- /dev/null +++ b/doc/utility/SnpEffAnnotator.html @@ -0,0 +1,304 @@ + + + + +SnpEffAnnotator + + + + + + + + + + + + + + + +
    + +
    +
    + +
    +
    Package utility
    +

    Class SnpEffAnnotator

    +
    +
    java.lang.Object +
    utility.SnpEffAnnotator
    +
    +
    +
    +
    public final class SnpEffAnnotator +extends Object
    +
    Implements static methods to run SnpEff locally via command line.
    +
    +
    Since:
    +
    2.0
    +
    +
    +
    +
      + +
    • +
      +

      Field Summary

      +
      Fields
      +
      +
      Modifier and Type
      +
      Field
      +
      Description
      +
      private final String
      + +
      +
      Prefix for exceptions thrown by the SnpEff Annotation process.
      +
      +
      private final MusialStorage
      + +
      +
      The MusialStorage instance to transfer annotations to.
      +
      +
      private final File
      + +
      +
      The reference sequence features of the target .vcf file in .gff format.
      +
      +
      private final File
      + +
      +
      The reference sequences of the target .vcf file in .fasta format.
      +
      +
      private final File
      + +
      +
      The target directory for SnpEff annotation.
      +
      +
      private final File
      + +
      +
      The target .vcf format file to annotate.
      +
      +
      +
      +
    • + +
    • +
      +

      Constructor Summary

      +
      Constructors
      +
      +
      Constructor
      +
      Description
      +
      SnpEffAnnotator(File targetDirectory, + File targetVcf, + File referenceSequences, + File referenceFeatures, + MusialStorage musialStorage)
      +
      +
      Constructor of SnpEffAnnotator class.
      +
      +
      +
      +
    • + +
    • +
      +

      Method Summary

      +
      +
      +
      +
      +
      Modifier and Type
      +
      Method
      +
      Description
      +
      void
      +
      run()
      +
      +
      Runs the SnpEff variant call annotation process.
      +
      +
      private void
      + +
      +
      Transfers all annotations to the MusialStorage instance.
      +
      +
      +
      +
      +
      +

      Methods inherited from class java.lang.Object

      +clone, equals, getClass, hashCode, notify, notifyAll, toString, wait, wait, wait
      +
      +
    • +
    +
    +
    +
      + +
    • +
      +

      Field Details

      +
        +
      • +
        +

        targetDirectory

        +
        private final File targetDirectory
        +
        The target directory for SnpEff annotation.
        +
        +
      • +
      • +
        +

        targetVcf

        +
        private final File targetVcf
        +
        The target .vcf format file to annotate.
        +
        +
      • +
      • +
        +

        referenceSequences

        +
        private final File referenceSequences
        +
        The reference sequences of the target .vcf file in .fasta format.
        +
        +
      • +
      • +
        +

        referenceFeatures

        +
        private final File referenceFeatures
        +
        The reference sequence features of the target .vcf file in .gff format.
        +
        +
      • +
      • +
        +

        musialStorage

        +
        private final MusialStorage musialStorage
        +
        The MusialStorage instance to transfer annotations to.
        +
        +
      • +
      • +
        +

        EXCEPTION_PREFIX

        +
        private final String EXCEPTION_PREFIX
        +
        Prefix for exceptions thrown by the SnpEff Annotation process.
        +
        +
        See Also:
        +
        + +
        +
        +
        +
      • +
      +
      +
    • + +
    • +
      +

      Constructor Details

      +
        +
      • +
        +

        SnpEffAnnotator

        +
        public SnpEffAnnotator(File targetDirectory, + File targetVcf, + File referenceSequences, + File referenceFeatures, + MusialStorage musialStorage)
        +
        Constructor of SnpEffAnnotator class.
        +
        +
        Parameters:
        +
        targetDirectory - The working directory of SnpEff.
        +
        targetVcf - The .vcf format file to annotate.
        +
        referenceSequences - The reference sequence of the target .vcf file in .fasta format.
        +
        referenceFeatures - The reference sequence features of the target .vcf file in .gff format.
        +
        musialStorage - The MusialStorage instance to transfer annotations to.
        +
        +
        +
      • +
      +
      +
    • + +
    • +
      +

      Method Details

      +
        +
      • +
        +

        run

        +
        public void run() + throws MusialException, +IOException
        +
        Runs the SnpEff variant call annotation process.
        +
        +
        Throws:
        +
        MusialException - If an error occurs during the annotation process.
        +
        IOException - If an I/O error occurs.
        +
        +
        +
      • +
      • +
        +

        transferAnnotation

        +
        private void transferAnnotation()
        +
        Transfers all annotations to the MusialStorage instance.
        +
        +
      • +
      +
      +
    • +
    +
    + +
    +
    +
    + + diff --git a/doc/utility/Validation.html b/doc/utility/Validation.html index f54bcf3..7529966 100644 --- a/doc/utility/Validation.html +++ b/doc/utility/Validation.html @@ -1,11 +1,11 @@ - + Validation - + @@ -78,7 +78,7 @@

    Class Validation


    public class Validation extends Object
    -
    This class comprises static methods used for validating input data.
    +
    Implements static methods used for validating input parameters.
    Since:
    2.0
    diff --git a/doc/utility/package-summary.html b/doc/utility/package-summary.html index 5a7bac1..439682d 100644 --- a/doc/utility/package-summary.html +++ b/doc/utility/package-summary.html @@ -1,11 +1,11 @@ - + utility - + @@ -76,37 +76,45 @@

    Package utility

    Class
    Description
    - +
    -
    Comprises static methods used to solve specifically bioinformatics problems.
    +
    Implements static methods for allele analysis to infer proteoforms.
    - -
    -
    Enum to store different modes to handle prefix gaps for global sequence alignment.
    + +
    +
    Implements static methods to run command line commands.
    - +
    -
    This class comprises static methods used for calling command line commands.
    +
    Implements static methods to compress String content using the `brotli4j` library.
    - +
    -
    Comprises static methods to compress String content using the `brotli4j` library.
    +
    This class comprises static methods used for reading and writing files.
    - +
    -
    This class comprises static methods used for reading and writing files.
    +
    Comprises static methods used for CL logging.
    - +
    -
    Comprises static methods used for CL logging.
    +
    Implements static methods to run sample/.vcf analysis.
    +
    + +
    +
    Implements static methods for sequence operations, such as inversion, translation, and alignment.
    +
    + +
    +
    Enum to store different modes to handle prefix gaps for global sequence alignment.
    - +
    -
    Comprises static methods to analyze samples in order to build a MUSIAL storage.
    +
    Implements static methods to run SnpEff locally via command line.
    -
    This class comprises static methods used for validating input data.
    +
    Implements static methods used for validating input parameters.
    diff --git a/doc/utility/package-tree.html b/doc/utility/package-tree.html index 57750df..59793d0 100644 --- a/doc/utility/package-tree.html +++ b/doc/utility/package-tree.html @@ -1,11 +1,11 @@ - + utility Class Hierarchy - + @@ -59,12 +59,14 @@

    Class Hierarchy