Difference between revisions of "Graham Reference Dataset Repository"

From SHARCNETHelp
Jump to navigationJump to search
Line 1,564: Line 1,564:


=== SVHN ===
=== SVHN ===
SVHN is a real-world image dataset for developing machine learning and object recognition algorithms with minimal requirement on data preprocessing and formatting. It can be seen as similar in flavor to MNIST (e.g., the images are of small cropped digits), but incorporates an order of magnitude more labeled data (over 600,000 digit images) and comes from a significantly harder, unsolved, real world problem (recognizing digits and numbers in natural scene images). SVHN is obtained from house numbers in Google Street View images.
In SHARCNET we provide the full SVHN dataset at <code>/datashare/SVHN</code> in Graham.
==== Directory Structure ====
The SVHN dataset folder on graham contains:
<pre>
/datashare/SVHN
├── extra
├── extra_32x32.mat
├── extra.tar.gz
├── housenumbers
├── test
├── test_32x32.mat
├── test.tar.gz
├── train
├── train_32x32.mat
└── train.tar.gz
4 directories, 6 files
</pre>
The folder extra contains 163728 png images, train 33402 images, and test 13068 images. For more information visit http://ufldl.stanford.edu/housenumbers/


=== VoxCeleb ===
=== VoxCeleb ===
See https://docs.computecanada.ca/wiki/VoxCeleb
See https://docs.computecanada.ca/wiki/VoxCeleb

Revision as of 10:20, 13 October 2021

Since May 2021 we have been testing a Network File System (NFS) data mount to provide our users with some commonly used datasets in Bioinformatics and AI. This data mount is provided in an effort to better serve our users and to lower the usage on their project accounts with commonly used datasets. These datasets are mounted on /datashare/. You can explore the top directories by listing the mount:

[user@gra-login1 ~]$ ls -lL /datashare/
total 848
drwxrwxr-x    9 jshleap sn_staff         4096 Jul  6 11:14 1000genomes
drwxrwxr-x    9 jshleap sn_staff          141 Sep 28 01:58 alphafold
drwxrwxr-x   36 jshleap sn_staff        98304 Sep 30 10:49 BLASTDB
drwxrwxr-x    2 jshleap sn_staff          107 Jun  4 15:30 BLAST_FASTA
drwxrwxr-x    5 jshleap sn_staff          229 Jun  4 18:49 CIFAR-10
drwxrwxr-x    5 jshleap sn_staff          221 Jun  4 18:49 CIFAR-100
drwxrwxr-x    6 jshleap sn_staff          115 Apr 27 10:00 COCO
drwxrwxr-x    2 jshleap sn_staff          135 Jun 10 18:23 DIAMONDDB_2.0.9
drwxrwxr-x    6 jshleap sn_staff          299 Jul 26 15:39 EggNog
drwxr-xr--    6 jshleap jshleap           143 Jul 28 15:45 GATK_resource_bundle
drwxrws---    9 jshleap imagenet-optin    244 Jun 16 09:22 ImageNet
dr-xr-xr-x   20 jshleap sn_staff         4096 Sep 20 14:04 kraken2_dbs
drwxrwxr-x    2 jshleap sn_staff          191 Jun  4 18:49 MNIST
drwxr-xr-x    4 jshleap jshleap            50 Aug 24 13:40 modulefiles
drwxrwxr-x    2 jshleap sn_staff           50 Jun  4 18:51 MPI_SINTEL
drwxrwxr-x 9546 jshleap sn_staff       581632 Aug  7 13:10 NCBI_taxonomy
drwxrwxr-x    6 jshleap sn_staff          145 Feb  4  2021 PANTHER
drwxrwxr-x   11 jshleap sn_staff          214 Aug 10 09:28 PFAM
drwxrwxr-x    6 jshleap sn_staff          213 Aug 25 10:50 SILVA
drwxrwxr-x    6 jshleap sn_staff          257 Feb  4  2021 SVHN
drwxrwxr-x    4 jshleap sn_staff          189 Apr 19 17:59 UNIPROT
drwxrwx---    5 jshleap voxceleb-optin     98 Apr 23 15:15 VoxCeleb


Below a detailed description of each dataset and how to access them.

Bioinformatics

Bioinformatics software often uses reference datasets (often referred to as databases) to work properly. In SHARCNET we are providing a set of these datasets for bioinformatics:

1000 Genomes

In human genetics, the 1000 genomes project (1KGP) was an effort to catalogue human genetic variation and has become a reference and a comparison point to many studies. We provide their data from their FTP site, and will be checked for updates twice a year (June and December).

Directory structure

1000 Genomes directory tree (up to level 2):

/datashare/1000genomes
├── CHANGELOG
├── data_collections
│   ├── 1000G_2504_high_coverage
│   ├── 1000G_2504_high_coverage_SV
│   ├── 1000_genomes_project
│   ├── gambian_genome_variation_project
│   ├── gambian_genome_variation_project_GRCh37
│   ├── geuvadis
│   ├── han_chinese_high_coverage
│   ├── HGDP
│   ├── HGSVC2
│   ├── hgsv_sv_discovery
│   ├── HLA_types
│   ├── illumina_platinum_pedigree
│   ├── index.html
│   ├── README_data_collections.md
│   └── simons_diversity_data
├── historical_data
│   ├── former_toplevel
│   ├── index.html
│   └── README_historical_data.md
├── index.html
├── phase1
│   ├── analysis_results
│   ├── data
│   ├── index.html
│   ├── phase1.alignment.index
│   ├── phase1.alignment.index.bas.gz
│   ├── phase1.exome.alignment.index
│   ├── phase1.exome.alignment.index.bas.gz
│   ├── phase1.exome.alignment.index.HsMetrics.gz
│   ├── phase1.exome.alignment.index.HsMetrics.stats
│   ├── phase1.exome.alignment.index_stats.csv
│   ├── README.phase1_alignment_data
│   └── technical
├── phase3
│   ├── 20130502.phase3.analysis.sequence.index
│   ├── 20130502.phase3.exome.alignment.index
│   ├── 20130502.phase3.low_coverage.alignment.index
│   ├── 20130502.phase3.sequence.index
│   ├── 20130725.phase3.cg_sra.index
│   ├── 20130820.phase3.cg_data_index
│   ├── 20131219.populations.tsv
│   ├── 20131219.superpopulations.tsv
│   ├── data
│   ├── index.html
│   ├── integrated_sv_map
│   ├── README_20150504_phase3_data
│   └── README_20160404_where_are_the_phase3_variants
├── pilot_data
│   ├── data
│   ├── index.html
│   ├── paper_data_sets
│   ├── pilot_data.alignment.index
│   ├── pilot_data.alignment.index.bas.gz
│   ├── pilot_data.sequence.index
│   ├── README.alignment.index
│   ├── README.bas
│   ├── README.sequence.index
│   ├── release
│   ├── SRP000031.sequence.index
│   ├── SRP000032.sequence.index
│   ├── SRP000033.sequence.index
│   └── technical
├── PRIVACY-NOTICE.txt
├── README_ebi_aspera_info.md
├── README_file_formats_and_descriptions.md
├── README_ftp_site_structure.md
├── README_missing_files.md
├── README_populations.md
├── README_using_1000genomes_cram.md
├── release
│   ├── 2008_12
│   ├── 2009_02
│   ├── 2009_04
│   ├── 2009_05
│   ├── 2009_08
│   ├── 20100804
│   ├── 2010_11
│   ├── 20101123
│   ├── 20110521
│   ├── 20130502
│   └── index.html
└── technical
    ├── browser
    ├── index.html
    ├── method_development
    ├── ncbi_varpipe_data
    ├── other_exome_alignments
    ├── other_exome_alignments.alignment_indices
    ├── phase3_EX_or_LC_only_alignment
    ├── pilot2_high_cov_GRCh37_bams
    ├── pilot3_exon_targetted_GRCh37_bams
    ├── qc
    ├── README.reference
    ├── reference
    ├── retired_reference
    ├── simulations
    ├── supporting
    └── working

As per their README, the directory structure is:

changelog_details

This directory contains a series of files detailing the changes made to the FTP site over time.

data_collections

The data_collections directory contains directories for various collections of data, typically generated by different projects. Among the data collections is the 1000 Genomes Project data.

For each collection of data, within the directory for that collection, README and index files provide information on the collection. Under each collection directory, there is a data directory, under which files are organised by population and then sample. Further information can be found in/datashare/1000genomes/data_collections/README_data_collections.md.

historical_data

This directory was created during a rearrangement of the FTP site in September 2015. It houses README and index files that were formerly present at the toplevel of this site, including dedicated index directories. Further information is available in /datashare/1000genomes/historical_data/README_historical_data.md.

phase1

This directory contains data that supports the publications associated with phase 1 of the 1000 Genomes Project.

phase3

This directory contains data that supports the publications associated with phase 3 of the 1000 Genomes Project.

pilot_data

This directory contains data that supports the publications associated with the pilot phase of the 1000 Genomes Project.

release

The release directory contains dated directories which contain analysis results sets plus README files explaining how those data sets were produced.

Originally, the date in release subdirectory names was the date on which the given release was made. Thereafter, the release subdirectory dates were based on the date in the name of the corresponding YYYYMMDD.sequence.index file. In future, the date in the directory name will be chosen in a manner appropriate to the data and the nature of the release.

Examples of release subdirectories are: - /datashare/1000genomes/release/2008_12/

In cases where release directories are named based on the date of the YYYYMMDD.sequence.index, the SNP calls, indel calls, etc. in these directories are based on alignments produced from data listed in the YYYYMMDD.sequence.index file.

For example, the directory /datashare/1000genomes/release/20100804/ contains the release versions of SNP and indel calls based on the /datashare/1000genomes/historical_data/former_toplevel/sequence_indices/20100804.sequence.index file.

technical

The technical directory contains subdirectories for other data sets such as simulations, files for method development, interim data sets, reference genomes, etc..

An example of data stored under technical is /datashare/1000genomes/datashare/1000genomes/technical/simulations/.

WARNING: /datashare/1000genomes/technical/working/
 The working directory under technical contains data that has experimental (non-public release) status
 and is suitable for internal project use only. Please use with caution.

AlphaFold

This space contains the data required by the AlphaFold sofware (more info here https://docs.computecanada.ca/wiki/AlphaFold). You can find more information about each dataset at https://github.com/deepmind/alphafold.

Directory structure

AlphaFold directory tree (up to level 2):

/datashare/alphafold
├── bfd
│   ├── bfd_metaclust_clu_complete_id30_c90_final_seq.sorted_opt_a3m.ffdata
│   ├── bfd_metaclust_clu_complete_id30_c90_final_seq.sorted_opt_a3m.ffindex
│   ├── bfd_metaclust_clu_complete_id30_c90_final_seq.sorted_opt_cs219.ffdata
│   ├── bfd_metaclust_clu_complete_id30_c90_final_seq.sorted_opt_cs219.ffindex
│   ├── bfd_metaclust_clu_complete_id30_c90_final_seq.sorted_opt_hhm.ffdata
│   └── bfd_metaclust_clu_complete_id30_c90_final_seq.sorted_opt_hhm.ffindex
├── mgnify
│   └── mgy_clusters_2018_12.fa
├── params
│   ├── LICENSE
│   ├── params_model_1.npz
│   ├── params_model_1_ptm.npz
│   ├── params_model_2.npz
│   ├── params_model_2_ptm.npz
│   ├── params_model_3.npz
│   ├── params_model_3_ptm.npz
│   ├── params_model_4.npz
│   ├── params_model_4_ptm.npz
│   ├── params_model_5.npz
│   └── params_model_5_ptm.npz
├── pdb70
│   ├── md5sum
│   ├── pdb70_a3m.ffdata
│   ├── pdb70_a3m.ffindex
│   ├── pdb70_clu.tsv
│   ├── pdb70_cs219.ffdata
│   ├── pdb70_cs219.ffindex
│   ├── pdb70_hhm.ffdata
│   ├── pdb70_hhm.ffindex
│   └── pdb_filter.dat
├── pdb_mmcif
│   ├── mmcif_files
│   └── obsolete.dat
├── uniclust30
│   └── uniclust30_2018_08
└── uniref90
    └── uniref90.fasta

9 directories, 29 files

To use this following the instruction in https://docs.computecanada.ca/wiki/AlphaFold, set the DOWNLOAD_DIR variable to /datashare/alphafold.


BLASTDB

BLAST uses a standard set of BLAST databases for nucleotide, protein, and translated BLAST searches. These databases contain the sequence information deposited in the NCBI and are made available here as pre-formatted databases with the same structure as the /db directory of the BLAST ftp site.

The pre-formatted databases offer the following advantages:

  • Pre-formatting removes the need to run makeblastdb
  • Species-level taxonomy ids are included for each database entry
  • Sequences in FASTA format can be generated from the pre-formatted databases by using the blastdbcmd utility
IMPORTANT: The BLAST databases found in this folder are version 5 (v5). Information on newly enabled features with the v5 databases can be find here.

All Pre-formatted databases available are located in Graham's /datashare/BLASTDB and will be updated every 3 months (Jan, Apr, Jul, Oct).

Directory structure

/datashare/BLASTDB contains all the pre-formatted without any subfolder. We include the Following:

Name Type Title
16S_ribosomal_RNA DNA 16S ribosomal RNA (Bacteria and Archaea type strains)
18S_fungal_sequences DNA 18S ribosomal RNA sequences (SSU) from Fungi type and reference material
28S_fungal_sequences DNA 28S ribosomal RNA sequences (LSU) from Fungi type and reference material
Betacoronavirus DNA Betacoronavirus
GCF_000001405.38_top_level DNA Homo sapiens GRCh38.p12 [GCF_000001405.38] chromosomes plus unplaced and unlocalized scaffolds
GCF_000001635.26_top_level DNA Mus musculus GRCm38.p6 [GCF_000001635.26] chromosomes plus unplaced and unlocalized scaffolds
ITS_RefSeq_Fungi DNA Internal transcribed spacer region (ITS) from Fungi type and reference material
ITS_eukaryote_sequences DNA ITS eukaryote BLAST
env_nt DNA environmental samples
nt DNA Nucleotide collection (nt)
patnt DNA Nucleotide sequences derived from the Patent division of GenBank
pdbnt DNA PDB nucleotide database
ref_euk_rep_genomes DNA RefSeq Eukaryotic Representative Genome Database
ref_prok_rep_genomes DNA Refseq prokaryote representative genomes (contains refseq assembly)
ref_viroids_rep_genomes DNA Refseq viroids representative genomes
ref_viruses_rep_genomes DNA Refseq viruses representative genomes
refseq_rna DNA NCBI Transcript Reference Sequences
refseq_select_rna DNA RefSeq Select RNA sequences
env_nr Protein Proteins from WGS metagenomic projects (env_nr)
landmark Protein Landmark database for SmartBLAST
nr Protein All non-redundant GenBank CDS translations+PDB+SwissProt+PIR+PRF excluding environmental samples from WGS projects
pdbaa Protein PDB protein database
pataa Protein Protein sequences derived from the Patent division of GenBank
refseq_protein Protein NCBI Protein Reference Sequences
refseq_select_prot Protein RefSeq Select proteins
swissprot Protein Non-redundant UniProtKB/SwissProt sequences
split-cdd Protein CDD split into 32 volumes
tsa_nr Protein Transcriptome Shotgun Assembly (TSA) sequences

Usage

The most efficient way to use these databases is to copy the specific database to $SLURM_TMPDIR at the begining of your sbatch script. This will add between 5 to 30 minutes (depending on the database you are moving), so use it only when you know that your blast run will take longer than one hour. For example, your sbatch script can look something like this:


   #!/bin/bash
   #SBATCH --time=02:00:00
   #SBATCH --mem=32G
   #SBATCH --cpus-per-task=8
   #SBATCH --account=def-someuser
   module load  StdEnv/2020  gcc/9.3.0 blast+/2.11.0 # load blast and dependencies
   tar cf - /datashare/BLASTDB/nr | (cd ${SLURM_TMPDIR}; tar xvf -) && # copy the required database (in this case nr) to $SLURM_TMPDIR
   blastp -db ${SLURM_TMPDIR}/nr -num_threads ${SLURM_CPUS_PER_TASK} -query myquery.fasta


Note that the example above assumes that you have launched the job from the same directory where myquery.fasta is located, that myquery.fasta is a set of protein sequences, and that nr is required as database.

You can also use /datashare/BLASTDB/nr (as per example), but it might be slower than having the databases in the local disk.

Other Compute Canada Sources

Blast databases can also be found in all cluster through a CVMFS repository (see https://docs.computecanada.ca/wiki/Genomics_data) unfortunately, these databases are based on the cloud ftp from NCBI which is out of date.

BLAST_FASTA

This directory contains the raw sequences located in the blast/db/FASTA/ of their directory of the NCBI FTP repository in compressed (by gzip) format:

  134M Apr 10 15:36 swissprot.gz
  96G  Apr 10 22:11 nr.gz
  108G Apr 12 07:55 nt.gz
  32M  Jun  4 15:30 pdbaa.gz

Similar to the pre-formatted databases (located in /datashare/BLASTDB), these fasta files can be found at /datashare/BLAST_FASTA and will be updated every 3 months (Jan, Apr, Jul, Oct).

DIAMONDDB_2.0.9

DIAMOND is a sequence aligner for protein and translated DNA searches, designed for high performance analysis of big sequence data. It works in a similar manner than blast but it has some optimizations done both at the database level and at the software level. In SHARCNET we provide pre-formatted databases for DIAMOND v.2.0.9 built using the following:

   diamond makedb --in <(gunzip -c /datashare/BLAST_FASTA/nr.gz) -d nr --taxonmap <(gunzip -c /datashare/NCBI_taxonomy/prot.accession2taxid.FUL.gz) --taxonnodes /datashare/NCBI_taxonomy/nodes.dmp

   diamond makedb --in <(gunzip -c /datashare/BLAST_FASTA/nt.gz) -d nt --taxonmap <(gunzip -c /datashare/NCBI_taxonomy/nucl_gb.accession2taxid.gz) --taxonnodes /datashare/NCBI_taxonomy/nodes.dmp

   diamond makedb --in <(gunzip -c /datashare/BLAST_FASTA/pdbaa.gz) -d pdbaa --taxonmap <(gunzip -c /datashare/NCBI_taxonomy/pdb.accession2taxid.gz) --taxonnodes /datashare/NCBI_taxonomy/nodes.dmp

   diamond makedb --in <(gunzip -c /datashare/BLAST_FASTA/swissprot.gz) -d swissprot --taxonmap <(gunzip -c /datashare/NCBI_taxonomy/prot.accession2taxid.FULL.gz) --taxonnodes /datashare/NCBI_taxonomy/nodes.dmp

As can be seen 4 databases are distributed in the /datashare/DIAMONDDB_2.0.9 directory representing blast's nt, nr, pdbaa, and swissprot. All of them contain taxonomic information. Since the source of these databases are the BLAST_FASTA, the updates of the databases will follow the same trimonthly schedule (Jan, Apr, Jul, Oct).

Consideration when using these databases

The Diamond program uses a lot of memory and temporary disk space, especially when dealing with big databases (like the ones we have here) and large query sequences (both in length and number). Should the program fail due to running out of either one, you need to set a lower value for the block size parameter -b.

Usage

The most efficient way to use these databases is to copy the specific database to $SLURM_TMPDIR at the begining of your sbatch script, just like with BLASTDB. This will add between 5 to 30 minutes (depending on the database you are moving), so use it only when you know that your blast run will take longer than one hour. In this case, different than with BLASTDB, only one file needs to be move, which means that cp is more efficient than tar moving the file. For example, your sbatch script can look something like this:


   #!/bin/bash
   #SBATCH --time=02:00:00
   #SBATCH --mem=32G
   #SBATCH --cpus-per-task=8
   #SBATCH --account=def-someuser
   module load  StdEnv/2020  diamond/2.0.9 # load blast and dependencies
   cp /datashare/DIAMONDDB_2.0.9/nr.dmnd ${SLURM_TMPDIR} # copy the required database (in this case nr) to $SLURM_TMPDIR
   diamond blastp -d /datashare/DIAMONDDB_2.0.9/nr -q YOURREADS.fasta -o AN_OUTPUT.tsv

Note that the example above assumes that you have launched the job from the same directory where YOURREADS.fasta is located, that YOURREADS.fasta is a set of protein sequences, and that nr is required as database.

You can also use /datashare/DIAMONDDB_2.0.9/nr (as per example), but it might be slower than having the databases in the local disk.

EggNog

The EggNOG database is a database of biological information hosted by the EMBL. It is based on the original idea of COGs and expands that idea to non-supervised orthologous groups constructed from numerous organisms.

This data mount contains a copy of latest EggNogg databases

Directory structure

EggNOG directory tree (up to level 2):

/datashare/EggNog
├── e5.level_info.tar.gz
├── e5.og_annotations.tsv
├── e5.proteomes.faa
├── e5.sequence_aliases.tsv
├── e5.taxid_info.tsv
├── e5.viruses.faa
├── gbff
│   ├── eutils_wgs_calledGenes
│   └── eutils_wgs_calledGenes_2
├── id_mappings
│   └── uniprot
├── per_tax_level
│   ├── 1
│   ├── 10
│   ├── 1016
│   ├── 10239
│   ├── 1028384
│   ├── 10404
│   ├── 104264
│   ├── 10474
│   ├── 10477
│   ├── 1060
│   ├── 10656
│   ├── 10662
│   ├── 10699
│   ├── 10744
│   ├── 10841
│   ├── 10860
│   ├── 1090
│   ├── 1100069
│   ├── 110618
│   ├── 11157
│   ├── 1117
│   ├── 112252
│   ├── 1129
│   ├── 1142
│   ├── 1150
│   ├── 1161
│   ├── 11632
│   ├── 1164882
│   ├── 117743
│   ├── 117747
│   ├── 118882
│   ├── 118884
│   ├── 1189
│   ├── 118969
│   ├── 119043
│   ├── 119045
│   ├── 119060
│   ├── 119065
│   ├── 119066
│   ├── 119069
│   ├── 119089
│   ├── 119603
│   ├── 11989
│   ├── 121069
│   ├── 1212
│   ├── 122277
│   ├── 1224
│   ├── 1236
│   ├── 1239
│   ├── 1268
│   ├── 1283313
│   ├── 129337
│   ├── 1297
│   ├── 1303
│   ├── 1305
│   ├── 1307
│   ├── 1313
│   ├── 135613
│   ├── 135614
│   ├── 135618
│   ├── 135619
│   ├── 135623
│   ├── 135624
│   ├── 135625
│   ├── 1357
│   ├── 136841
│   ├── 136843
│   ├── 136845
│   ├── 136846
│   ├── 136849
│   ├── 1386
│   ├── 142182
│   ├── 145357
│   ├── 147541
│   ├── 147545
│   ├── 147548
│   ├── 147550
│   ├── 150247
│   ├── 1506553
│   ├── 1511857
│   ├── 155619
│   ├── 1570339
│   ├── 157897
│   ├── 1653
│   ├── 167375
│   ├── 171550
│   ├── 171551
│   ├── 1762
│   ├── 178469
│   ├── 182709
│   ├── 183925
│   ├── 183939
│   ├── 183963
│   ├── 183967
│   ├── 183968
│   ├── 183980
│   ├── 186801
│   ├── 186804
│   ├── 186806
│   ├── 186807
│   ├── 186813
│   ├── 186818
│   ├── 186820
│   ├── 186821
│   ├── 186822
│   ├── 186823
│   ├── 186824
│   ├── 186827
│   ├── 186828
│   ├── 186928
│   ├── 189330
│   ├── 189775
│   ├── 191028
│   ├── 191675
│   ├── 2
│   ├── 200643
│   ├── 200783
│   ├── 200795
│   ├── 200918
│   ├── 200930
│   ├── 200940
│   ├── 201174
│   ├── 203494
│   ├── 203682
│   ├── 203691
│   ├── 204037
│   ├── 204428
│   ├── 204432
│   ├── 204441
│   ├── 204457
│   ├── 204458
│   ├── 2063
│   ├── 206350
│   ├── 206351
│   ├── 206389
│   ├── 213113
│   ├── 213115
│   ├── 213118
│   ├── 213462
│   ├── 213481
│   ├── 2157
│   ├── 216572
│   ├── 224756
│   ├── 225057
│   ├── 228398
│   ├── 2323
│   ├── 237
│   ├── 2433
│   ├── 244698
│   ├── 245186
│   ├── 246874
│   ├── 252301
│   ├── 252356
│   ├── 255475
│   ├── 256005
│   ├── 265
│   ├── 265975
│   ├── 267888
│   ├── 267889
│   ├── 267890
│   ├── 267893
│   ├── 267894
│   ├── 2759
│   ├── 28037
│   ├── 28211
│   ├── 28216
│   ├── 28221
│   ├── 2836
│   ├── 283735
│   ├── 285107
│   ├── 28883
│   ├── 28889
│   ├── 28890
│   ├── 289201
│   ├── 29
│   ├── 29000
│   ├── 290174
│   ├── 29258
│   ├── 29547
│   ├── 301297
│   ├── 302485
│   ├── 3041
│   ├── 308865
│   ├── 311790
│   ├── 314146
│   ├── 314294
│   ├── 31979
│   ├── 31993
│   ├── 32003
│   ├── 32061
│   ├── 32066
│   ├── 32199
│   ├── 326319
│   ├── 326457
│   ├── 33090
│   ├── 33154
│   ├── 33183
│   ├── 33208
│   ├── 33213
│   ├── 33342
│   ├── 33554
│   ├── 335928
│   ├── 33867
│   ├── 33958
│   ├── 34008
│   ├── 34037
│   ├── 34383
│   ├── 34384
│   ├── 34397
│   ├── 35237
│   ├── 35268
│   ├── 35278
│   ├── 35301
│   ├── 35325
│   ├── 35493
│   ├── 355688
│   ├── 35718
│   ├── 358033
│   ├── 363408
│   ├── 3699
│   ├── 38820
│   ├── 39782
│   ├── 400634
│   ├── 40117
│   ├── 40674
│   ├── 41294
│   ├── 414999
│   ├── 422676
│   ├── 423358
│   ├── 439488
│   ├── 43988
│   ├── 4447
│   ├── 451866
│   ├── 451867
│   ├── 451870
│   ├── 452284
│   ├── 45401
│   ├── 45404
│   ├── 45667
│   ├── 46205
│   ├── 464095
│   ├── 468
│   ├── 4751
│   ├── 4776
│   ├── 4890
│   ├── 4891
│   ├── 4893
│   ├── 5042
│   ├── 50557
│   ├── 506
│   ├── 508458
│   ├── 5125
│   ├── 5129
│   ├── 5139
│   ├── 5148
│   ├── 5151
│   ├── 52018
│   ├── 5204
│   ├── 5234
│   ├── 52604
│   ├── 526524
│   ├── 52959
│   ├── 53335
│   ├── 5338
│   ├── 53433
│   ├── 538999
│   ├── 539002
│   ├── 541000
│   ├── 544
│   ├── 544448
│   ├── 547
│   ├── 548681
│   ├── 551
│   ├── 554915
│   ├── 558415
│   ├── 561
│   ├── 5653
│   ├── 572511
│   ├── 57723
│   ├── 5794
│   ├── 5796
│   ├── 5809
│   ├── 5819
│   ├── 583
│   ├── 586
│   ├── 5863
│   ├── 5878
│   ├── 58840
│   ├── 590
│   ├── 59732
│   ├── 60136
│   ├── 613
│   ├── 61432
│   ├── 622450
│   ├── 6231
│   ├── 6236
│   ├── 629
│   ├── 629295
│   ├── 639021
│   ├── 651137
│   ├── 6656
│   ├── 671232
│   ├── 675063
│   ├── 68295
│   ├── 68298
│   ├── 68525
│   ├── 68892
│   ├── 69277
│   ├── 69541
│   ├── 69657
│   ├── 7088
│   ├── 71274
│   ├── 713636
│   ├── 7147
│   ├── 7148
│   ├── 7214
│   ├── 72273
│   ├── 72275
│   ├── 7399
│   ├── 74030
│   ├── 74201
│   ├── 74385
│   ├── 75682
│   ├── 766
│   ├── 766764
│   ├── 76804
│   ├── 76831
│   ├── 768503
│   ├── 7711
│   ├── 772
│   ├── 7742
│   ├── 7898
│   ├── 80864
│   ├── 815
│   ├── 81850
│   ├── 81852
│   ├── 82115
│   ├── 82117
│   ├── 82986
│   ├── 830
│   ├── 83612
│   ├── 84406
│   ├── 8459
│   ├── 84992
│   ├── 84995
│   ├── 84998
│   ├── 85004
│   ├── 85005
│   ├── 85008
│   ├── 85009
│   ├── 85010
│   ├── 85012
│   ├── 85013
│   ├── 85014
│   ├── 85016
│   ├── 85017
│   ├── 85018
│   ├── 85019
│   ├── 85020
│   ├── 85021
│   ├── 85023
│   ├── 85025
│   ├── 85026
│   ├── 8782
│   ├── 90964
│   ├── 909932
│   ├── 91061
│   ├── 91561
│   ├── 91835
│   ├── 9263
│   ├── 92860
│   ├── 93682
│   ├── 9397
│   ├── 9443
│   ├── 9604
│   ├── 97050
│   ├── 976
│   ├── 995019
│   └── 9989
└── raw_data
    ├── e5.best_hit_homology_matrix.tsv.gz
    └── speciation_events.tsv.gz

386 directories, 8 files

The top level directory includes the e5 release of the proteomes and its annotations. The gbff folder contain annotation in genebank format. The folder id_mappings contain the taxonomic information and the mappings with EggNog's taxids. In the per_tax_level contains a series of folders, labeled by taconomic ID. In each one of them, you can find *_annotations.tsv.gz *_hmms.tar *_hmms.tar.gz *_members.tsv.gz *_raw_algs.tar *_stats.tsv *_trees.tsv.gz *_trimmed_algs.tar with the Hidden Markov models alignments, annotations, profiles, and phylogenetic trees. Finally, the folder raw_data contains the homology/speciation events used in EggNog's clustering.

kraken2_dbs

Kraken 2 is the newest version of Kraken, a taxonomic classification system using exact k-mer matches to achieve high accuracy and fast classification speeds. This classifier matches each k-mer within a query sequence to the lowest common ancestor (LCA) of all genomes containing the given k-mer. The k-mer assignments inform the classification algorithm (kraken2). In SHARCNET, we provide some extra databases with expanded taxonomy for our users. These databases are Kraken2 ONLY, that means that it uses a compact hash table. With this structure, it has a <1% chance of returning the incorrect LCA or returning an LCA for a non-inserted minimizer. Users can compensate for this possibility by using Kraken's confidence scoring thresholds.

Directory structure

Kraken 2 is provided in the following structure:

/datashare/kraken2_dbs
├── 16S_Greengenes_k2db
├── 16S_RDP_k2db
├── 16S_SILVA132_k2db
├── 16S_SILVA138_k2db
├── archaea
├── bacteria
├── dl_log
├── eukaryota
├── fungi
├── human
├── is_my_taxa_there
├── krakendb_100G
├── midikraken_100GB
├── minikraken_8GB_20200312
├── minikraken_8GB_20200312_genomes.txt
├── minikraken_8GB_202003.tgz
├── plant
├── protozoa
├── UniVec_Core
└── viral

Usage

By providing the path to the database you are able to query the specific database of your choosing:

kraken2 --db /datashare/kraken2_dbs/eukaryota test.fa

For your convenience, we provide a simple script to query if your specific taxa is available in the database:

$ /datashare/kraken2_dbs/is_my_taxa_there -h
Usage: /datashare/kraken2_dbs/is_my_taxa_there [-t <taxa to look for>|[-d <database>|-h]
	-h	print usage and exit
	-t	desired taxa
	-d	Database to check in (full path)

NOTE: THE TAXA IS CASE SENSITIVE, for example, if you require arabidopsis genus in the plant database it returns nothing, but Arabidopsis will return the hits

For example, let's say that you want to check if the genus `Carcharodon` is included in the eukaryota database, then you do:

$ /datashare/kraken2_dbs/is_my_taxa_there -t Carcharodon -d /datashare/kraken2_dbs/eukaryota
Checking if Carcharodon is present in /datashare/kraken2_dbs/eukaryota

  0.03	569792	0	G	13396	                                        Carcharodon
  0.03	569792	569792	S	13397	                                          Carcharodon carcharias

The output of this script is in line with the inspect format. You can check out the Kraken2 Manual for more information.

NCBI_taxonomy

This dataset contains the NCBI taxonomy ftp. Is intended to work with multiple software (seqkit, kraken, blast, diamond, etc) as well as with direct search of accession numbers, taxonomic IDs and related information. It will be updated with the blast databases.

Directory structure

NCBI_taxonomy directory tree (up to level 2):

/datashare/NCBI_taxonomy
├── accession2taxid
│   ├── dead_nucl.accession2taxid.gz
│   ├── dead_nucl.accession2taxid.gz.md5
│   ├── dead_prot.accession2taxid.gz
│   ├── dead_prot.accession2taxid.gz.md5
│   ├── dead_wgs.accession2taxid.gz
│   ├── dead_wgs.accession2taxid.gz.md5
│   ├── index.html
│   ├── nucl_gb.accession2taxid.gz
│   ├── nucl_gb.accession2taxid.gz.md5
│   ├── nucl_wgs.accession2taxid.gz
│   ├── nucl_wgs.accession2taxid.gz.md5
│   ├── pdb.accession2taxid.gz
│   ├── pdb.accession2taxid.gz.md5
│   ├── prot.accession2taxid.FULL.gz
│   ├── prot.accession2taxid.FULL.gz.md5
│   ├── prot.accession2taxid.gz
│   ├── prot.accession2taxid.gz.md5
│   └── README
├── biocollections
│   ├── Collection_codes.txt
│   ├── index.html
│   ├── Institution_codes.txt
│   └── Unique_institution_codes.txt
├── categories.dmp
├── Ccode_dump.txt
├── citations.dmp
├── coll_dump.txt
├── Cowner_dump.txt
├── delnodes.dmp
├── division.dmp
├── gc.prt
├── gencode.dmp
├── Icode_dump.txt
├── index.html
├── merged.dmp
├── names.dmp
├── ncbi_taxonomy_genussp.txt
├── new_taxdump
│   ├── index.html
│   ├── new_taxdump.tar.gz
│   ├── new_taxdump.tar.gz.md5
│   └── taxdump_readme.txt
├── nodes.dmp
├── README
├── readme.txt
├── taxcat_readme.txt
├── taxcat.tar.gz
├── taxcat.tar.gz.md5
├── taxdump_archive
│   └── index.html
├── taxdump_readme.txt
├── taxdump.tar.gz
└── taxdump.tar.gz.md5

4 directories, 50 files

Usage with TaxonKit

In Compute Canada, we have a taxonomic manipulation software called [ TaxonKit]. You can load it by module load StdEnv/2020 taxonkit. It requires to have the NCBI taxonomy in a particular location. To set it up with this datashare, simply add a simbolic link to the .taxonkit folder:

mkdir -p ~/.taxonkit
ln -s /datashare/NCBI_taxonomy/*.dmp ~/.taxonkit/

Then you can use taxonkit directly

PANTHER

The PANTHER (protein analysis through evolutionary relationships) classification system is a large curated biological database of gene/protein families and their functionally related subfamilies that can be used to classify and identify the function of gene products. It is part of the Gene Ontology Reference Genome Project designed to classify proteins and their genes for high-throughput analysis.

In our data mount, we provide users with some of the relevant data found in the pantherdb ftp, namely: hmm_classifications, panther_library, pathway, and sequence_classifications.

Directory structure

PANTHER directory tree (up to level 2):

/datashare/PANTHER/
├── hmm_classifications
│   ├── LICENSE
│   ├── PANTHER15.0_HMM_classifications
│   ├── PANTHER16.0_HMM_classifications
│   └── README
├── panther_library
│   ├── ascii
│   ├── hmmscoring
│   ├── PANTHER15.0_ascii.tgz
│   ├── PANTHER15.0_fasta
│   ├── PANTHER15.0_fasta.tgz
│   ├── PANTHER15.0_hmmscoring.tgz
│   ├── PANTHER16.0_ascii.tgz
│   ├── PANTHER16.0_binary.tgz
│   ├── PANTHER16.0_fasta
│   ├── PANTHER16.0_fasta.tgz
│   ├── README
│   ├── target4
│   └── wget_panther_panther_library.log
├── pathway
│   ├── BioPAX
│   ├── BioPAX.tar.gz
│   ├── sbml
│   ├── sbml.tar.gz
│   ├── SequenceAssociationPathway3.6.4.txt
│   └── SequenceAssociationPathway3.6.5.txt
└── sequence_classifications
    ├── LICENSE
    ├── PANTHER_Sequence_Classification_files
    ├── README
    └── species

12 directories, 19 files
hmm_classifications

This folder contains the classification files for versions 15 and 16. They contain the name, molecular functions, biological processes, and pathway for every PANTHER protein family and subfamily in Version 15.0 of the PANTHER HMM library.

The files are a tab-delimited file in the following format: 1) PANTHER ID: for example, PTHR11258 or PTHR12213:SF6. ":SF" indicates the subfamily ID 2) Name: The annotation assigned by curators to the PANTHER family or subfamily 3) Molecular function*: PANTHER GO slim molecular function terms assigned to families and subfamilies 4) Biological process*: PANTHER GO slim biological process terms assigned to families and subfamilies 5) Cellular components*: PANTHER GO slim cellular component terms assigned to families and subfamilies 6) Protein class* PANTHER protein class terms assigned to families and subfamilies 7) Pathway***: PANTHER pathways have been assigned to families and subfamilies.

For more information check the README file at /datashare/PANTHER/hmm_classifications

panther_library

This is the main folder, containing the panther HMM files along with the fasta inputs.

For more information check the README file at /datashare/PANTHER/panther_library

pathway

This folder contain the metabolic pathways and the annotation of the sequence association with each pathway. It contains some metabolic pathwaus in BioPAX and SMBL format.

sequence_classifications

The PANTHER website allows access to to pre-calculated HMM scoring results for the complete proteomes derived from the human, mouse, rat and Drosophila melanogaster genomes.

A total of 142 classification files are provided here, one for each organism. For more information check the README file at /datashare/PANTHER/sequence_classifications

PFAM

Pfam is a database of protein families that includes their annotations and multiple sequence alignments generated using hidden Markov models. The general purpose of the Pfam database is to provide a complete and accurate classification of protein families and domains. Originally, the rationale behind creating the database was to have a semi-automated method of curating information on known protein families to improve the efficiency of annotating genomes. The Pfam classification of protein families has been widely adopted by biologists because of its wide coverage of proteins and sensible naming conventions 1.

On SHARCNET we provide the latest version of the PFAM database.

Directory Structure

We follow the structure of the PFAM ftp:

/datashare/PFAM
├── AntiFam
├── current_release
├── database_files
├── mappings
├── papers
├── proteomes
├── releases
├── Tools
└── vm

9 directories, 0 files

For more information about the structure of their FTP and this dataset, please visit https://pfam-docs.readthedocs.io/en/latest/ftp-site.html.

SILVA

The SILVA databases are developed and maintained by the Microbial Genomics and Bioinformatics Research Group in Bremen, Germany, in cooperation with the company Ribocon GmbH.

SILVA provides fully aligned and up to date small (16S/18S, SSU) and large (23S/28S, LSU) subunit ribosomal RNA "Parc" databases as well as ARB files preconfigured subsets of only high quality, full-length sequences as ARB & FASTA files (SSU/LSU Ref). It also has full compatibility with the ARB software and and to many common programs like Phylip or Paup via direct Fasta export or the ARB program.

On Graham, we provide a copy of the latest release, and will be updated twice a year.

Directory structure

Silva directory tree:

/datashare/SILVA
├── ARB_files
│   ├── LICENSE.txt
│   ├── SILVA_138.1_LSURef_NR99_30_06_20_opt.arb.gz
│   ├── SILVA_138.1_LSURef_NR99_30_06_20_opt.arb.gz.md5
│   ├── SILVA_138.1_LSURef_opt.arb.gz
│   ├── SILVA_138.1_LSURef_opt.arb.gz.md5
│   ├── SILVA_138.1_SSURef_NR99_12_06_20_opt.arb.gz
│   ├── SILVA_138.1_SSURef_NR99_12_06_20_opt.arb.gz.md5
│   ├── SILVA_138.1_SSURef_opt.arb.gz
│   └── SILVA_138.1_SSURef_opt.arb.gz.md5
├── CITATION.txt
├── current
│   ├── sina-1.2.11_centos5_amd64.tgz
│   ├── sina-1.2.11_ubuntu1004_amd64.tgz
│   ├── sina-1.2.11_ubuntu1004_i386.tgz
│   ├── sina-1.2.11_ubuntu1204_amd64.tgz
│   └── sina-1.2.11_ubuntu1204_i386.tgz
├── Exports
│   ├── accession
│   │   ├── LICENSE.txt
│   │   ├── SILVA_138.1_LSUParc.acs.gz
│   │   ├── SILVA_138.1_LSUParc.acs.gz.md5
│   │   ├── SILVA_138.1_LSURef.acs.gz
│   │   ├── SILVA_138.1_LSURef.acs.gz.md5
│   │   ├── SILVA_138.1_LSURef_Nr99.acs.gz
│   │   ├── SILVA_138.1_LSURef_Nr99.acs.gz.md5
│   │   ├── SILVA_138.1_SSUParc.acs.gz
│   │   ├── SILVA_138.1_SSUParc.acs.gz.md5
│   │   ├── SILVA_138.1_SSURef.acs.gz
│   │   ├── SILVA_138.1_SSURef.acs.gz.md5
│   │   ├── SILVA_138.1_SSURef_Nr99.acs.gz
│   │   └── SILVA_138.1_SSURef_Nr99.acs.gz.md5
│   ├── cluster
│   │   ├── LICENSE.txt
│   │   ├── SILVA_138.1_LSURef_Nr99.clstr.gz
│   │   ├── SILVA_138.1_LSURef_Nr99.clstr.gz.md5
│   │   ├── SILVA_138.1_SSURef_Nr99.clstr.gz
│   │   └── SILVA_138.1_SSURef_Nr99.clstr.gz.md5
│   ├── country_locality
│   │   ├── LICENSE.txt
│   │   ├── SILVA_138.1_LSUParc.country_locality.gz
│   │   ├── SILVA_138.1_LSUParc.country_locality.gz.md5
│   │   ├── SILVA_138.1_LSURef.country_locality.gz
│   │   ├── SILVA_138.1_LSURef.country_locality.gz.md5
│   │   ├── SILVA_138.1_LSURef_Nr99.country_locality.gz
│   │   ├── SILVA_138.1_LSURef_Nr99.country_locality.gz.md5
│   │   ├── SILVA_138.1_SSUParc.country_locality.gz
│   │   ├── SILVA_138.1_SSUParc.country_locality.gz.md5
│   │   ├── SILVA_138.1_SSURef.country_locality.gz
│   │   ├── SILVA_138.1_SSURef.country_locality.gz.md5
│   │   ├── SILVA_138.1_SSURef_Nr99.country_locality.gz
│   │   └── SILVA_138.1_SSURef_Nr99.country_locality.gz.md5
│   ├── full_metadata
│   │   ├── LICENSE.txt
│   │   ├── SILVA_138.1_LSUParc.full_metadata.gz
│   │   ├── SILVA_138.1_LSUParc.full_metadata.gz.md5
│   │   ├── SILVA_138.1_LSURef.full_metadata.gz
│   │   ├── SILVA_138.1_LSURef.full_metadata.gz.md5
│   │   ├── SILVA_138.1_LSURef_Nr99.full_metadata.gz
│   │   ├── SILVA_138.1_LSURef_Nr99.full_metadata.gz.md5
│   │   ├── SILVA_138.1_SSUParc.full_metadata.gz
│   │   ├── SILVA_138.1_SSUParc.full_metadata.gz.md5
│   │   ├── SILVA_138.1_SSURef.full_metadata.gz
│   │   ├── SILVA_138.1_SSURef.full_metadata.gz.md5
│   │   ├── SILVA_138.1_SSURef_Nr99.full_metadata.gz
│   │   └── SILVA_138.1_SSURef_Nr99.full_metadata.gz.md5
│   ├── geographic_location
│   │   ├── LICENSE.txt
│   │   ├── SILVA_138.1_LSUParc.geographic_location.gz
│   │   ├── SILVA_138.1_LSUParc.geographic_location.gz.md5
│   │   ├── SILVA_138.1_LSURef.geographic_location.gz
│   │   ├── SILVA_138.1_LSURef.geographic_location.gz.md5
│   │   ├── SILVA_138.1_LSURef_Nr99.geographic_location.gz
│   │   ├── SILVA_138.1_LSURef_Nr99.geographic_location.gz.md5
│   │   ├── SILVA_138.1_SSUParc.geographic_location.gz
│   │   ├── SILVA_138.1_SSUParc.geographic_location.gz.md5
│   │   ├── SILVA_138.1_SSURef.geographic_location.gz
│   │   ├── SILVA_138.1_SSURef.geographic_location.gz.md5
│   │   ├── SILVA_138.1_SSURef_Nr99.geographic_location.gz
│   │   └── SILVA_138.1_SSURef_Nr99.geographic_location.gz.md5
│   ├── LICENSE.txt
│   ├── quality
│   │   ├── LICENSE.txt
│   │   ├── SILVA_138.1_LSUParc.quality.gz
│   │   ├── SILVA_138.1_LSUParc.quality.gz.md5
│   │   ├── SILVA_138.1_LSURef_Nr99.quality.gz
│   │   ├── SILVA_138.1_LSURef_Nr99.quality.gz.md5
│   │   ├── SILVA_138.1_LSURef.quality.gz
│   │   ├── SILVA_138.1_LSURef.quality.gz.md5
│   │   ├── SILVA_138.1_SSUParc.quality.gz
│   │   ├── SILVA_138.1_SSUParc.quality.gz.md5
│   │   ├── SILVA_138.1_SSURef_Nr99.quality.gz
│   │   ├── SILVA_138.1_SSURef_Nr99.quality.gz.md5
│   │   ├── SILVA_138.1_SSURef.quality.gz
│   │   └── SILVA_138.1_SSURef.quality.gz.md5
│   ├── rast
│   │   ├── LICENSE.txt
│   │   ├── SILVA_138.1_LSUParc.rast.gz
│   │   ├── SILVA_138.1_LSUParc.rast.gz.md5
│   │   ├── SILVA_138.1_LSURef_NR99.rast.gz
│   │   ├── SILVA_138.1_LSURef_NR99.rast.gz.md5
│   │   ├── SILVA_138.1_LSURef.rast.gz
│   │   ├── SILVA_138.1_LSURef.rast.gz.md5
│   │   ├── SILVA_138.1_SSUParc.rast.gz
│   │   ├── SILVA_138.1_SSUParc.rast.gz.md5
│   │   ├── SILVA_138.1_SSURef_NR99.rast.gz
│   │   ├── SILVA_138.1_SSURef_NR99.rast.gz.md5
│   │   ├── SILVA_138.1_SSURef.rast.gz
│   │   └── SILVA_138.1_SSURef.rast.gz.md5
│   ├── README.txt
│   ├── rnac
│   │   ├── LICENSE.txt
│   │   ├── SILVA_138.1_LSUParc.rnac.gz
│   │   ├── SILVA_138.1_LSUParc.rnac.gz.md5
│   │   ├── SILVA_138.1_LSURef_NR99.rnac.gz
│   │   ├── SILVA_138.1_LSURef_NR99.rnac.gz.md5
│   │   ├── SILVA_138.1_LSURef.rnac.gz
│   │   ├── SILVA_138.1_LSURef.rnac.gz.md5
│   │   ├── SILVA_138.1_SSUParc.rnac.gz
│   │   ├── SILVA_138.1_SSUParc.rnac.gz.md5
│   │   ├── SILVA_138.1_SSURef_NR99.rnac.gz
│   │   ├── SILVA_138.1_SSURef_NR99.rnac.gz.md5
│   │   ├── SILVA_138.1_SSURef.rnac.gz
│   │   └── SILVA_138.1_SSURef.rnac.gz.md5
│   ├── SILVA_138.1_LSUParc_tax_silva.fasta.gz
│   ├── SILVA_138.1_LSUParc_tax_silva.fasta.gz.md5
│   ├── SILVA_138.1_LSUParc_tax_silva_trunc.fasta.gz
│   ├── SILVA_138.1_LSUParc_tax_silva_trunc.fasta.gz.md5
│   ├── SILVA_138.1_LSURef_NR99_tax_silva.fasta.gz
│   ├── SILVA_138.1_LSURef_NR99_tax_silva.fasta.gz.md5
│   ├── SILVA_138.1_LSURef_NR99_tax_silva_full_align_trunc.fasta.gz
│   ├── SILVA_138.1_LSURef_NR99_tax_silva_full_align_trunc.fasta.gz.md5
│   ├── SILVA_138.1_LSURef_NR99_tax_silva_trunc.fasta.gz
│   ├── SILVA_138.1_LSURef_NR99_tax_silva_trunc.fasta.gz.md5
│   ├── SILVA_138.1_LSURef_tax_silva.fasta.gz
│   ├── SILVA_138.1_LSURef_tax_silva.fasta.gz.md5
│   ├── SILVA_138.1_LSURef_tax_silva_full_align_trunc.fasta.gz
│   ├── SILVA_138.1_LSURef_tax_silva_full_align_trunc.fasta.gz.md5
│   ├── SILVA_138.1_LSURef_tax_silva_trunc.fasta.gz
│   ├── SILVA_138.1_LSURef_tax_silva_trunc.fasta.gz.md5
│   ├── SILVA_138.1_SSUParc_tax_silva.fasta.gz
│   ├── SILVA_138.1_SSUParc_tax_silva.fasta.gz.md5
│   ├── SILVA_138.1_SSUParc_tax_silva_trunc.fasta.gz
│   ├── SILVA_138.1_SSUParc_tax_silva_trunc.fasta.gz.md5
│   ├── SILVA_138.1_SSURef_NR99_tax_silva.fasta.gz
│   ├── SILVA_138.1_SSURef_NR99_tax_silva.fasta.gz.md5
│   ├── SILVA_138.1_SSURef_NR99_tax_silva_full_align_trunc.fasta.gz
│   ├── SILVA_138.1_SSURef_NR99_tax_silva_full_align_trunc.fasta.gz.md5
│   ├── SILVA_138.1_SSURef_NR99_tax_silva_trunc.fasta.gz
│   ├── SILVA_138.1_SSURef_NR99_tax_silva_trunc.fasta.gz.md5
│   ├── SILVA_138.1_SSURef_tax_silva.fasta.gz
│   ├── SILVA_138.1_SSURef_tax_silva.fasta.gz.md5
│   ├── SILVA_138.1_SSURef_tax_silva_full_align_trunc.fasta.gz
│   ├── SILVA_138.1_SSURef_tax_silva_full_align_trunc.fasta.gz.md5
│   ├── SILVA_138.1_SSURef_tax_silva_trunc.fasta.gz
│   ├── SILVA_138.1_SSURef_tax_silva_trunc.fasta.gz.md5
│   └── taxonomy
│       ├── LICENSE.txt
│       ├── ncbi
│       │   ├── taxmap_embl-ebi_ena_lsu_parc_138.1.txt.gz
│       │   ├── taxmap_embl-ebi_ena_lsu_parc_138.1.txt.gz.md5
│       │   ├── taxmap_embl-ebi_ena_lsu_ref_138.1.txt.gz
│       │   ├── taxmap_embl-ebi_ena_lsu_ref_138.1.txt.gz.md5
│       │   ├── taxmap_embl-ebi_ena_lsu_ref_nr99_138.1.txt.gz
│       │   ├── taxmap_embl-ebi_ena_lsu_ref_nr99_138.1.txt.gz.md5
│       │   ├── taxmap_embl-ebi_ena_ssu_parc_138.1.txt.gz
│       │   ├── taxmap_embl-ebi_ena_ssu_parc_138.1.txt.gz.md5
│       │   ├── taxmap_embl-ebi_ena_ssu_ref_138.1.txt.gz
│       │   ├── taxmap_embl-ebi_ena_ssu_ref_138.1.txt.gz.md5
│       │   ├── taxmap_embl-ebi_ena_ssu_ref_nr99_138.1.txt.gz
│       │   ├── taxmap_embl-ebi_ena_ssu_ref_nr99_138.1.txt.gz.md5
│       │   ├── taxmap_ncbi_lsu_parc_138.1.txt.gz
│       │   ├── taxmap_ncbi_lsu_parc_138.1.txt.gz.md5
│       │   ├── taxmap_ncbi_lsu_ref_138.1.txt.gz
│       │   ├── taxmap_ncbi_lsu_ref_138.1.txt.gz.md5
│       │   ├── taxmap_ncbi_lsu_ref_nr99_138.1.txt.gz
│       │   ├── taxmap_ncbi_lsu_ref_nr99_138.1.txt.gz.md5
│       │   ├── taxmap_ncbi_ssu_parc_138.1.txt.gz
│       │   ├── taxmap_ncbi_ssu_parc_138.1.txt.gz.md5
│       │   ├── taxmap_ncbi_ssu_ref_138.1.txt.gz
│       │   ├── taxmap_ncbi_ssu_ref_138.1.txt.gz.md5
│       │   ├── taxmap_ncbi_ssu_ref_nr99_138.1.txt.gz
│       │   ├── taxmap_ncbi_ssu_ref_nr99_138.1.txt.gz.md5
│       │   ├── tax_ncbi_lsu_parc_138.1.txt.gz
│       │   ├── tax_ncbi_lsu_parc_138.1.txt.gz.md5
│       │   ├── tax_ncbi_lsu_ref_138.1.txt.gz
│       │   ├── tax_ncbi_lsu_ref_138.1.txt.gz.md5
│       │   ├── tax_ncbi_lsu_ref_nr99_138.1.txt.gz
│       │   ├── tax_ncbi_lsu_ref_nr99_138.1.txt.gz.md5
│       │   ├── tax_ncbi-species_lsu_parc_138.1.txt.gz
│       │   ├── tax_ncbi-species_lsu_parc_138.1.txt.gz.md5
│       │   ├── tax_ncbi-species_lsu_ref_138.1.txt.gz
│       │   ├── tax_ncbi-species_lsu_ref_138.1.txt.gz.md5
│       │   ├── tax_ncbi-species_lsu_ref_nr99_138.1.txt.gz
│       │   ├── tax_ncbi-species_lsu_ref_nr99_138.1.txt.gz.md5
│       │   ├── tax_ncbi-species_ssu_parc_138.1.txt.gz
│       │   ├── tax_ncbi-species_ssu_parc_138.1.txt.gz.md5
│       │   ├── tax_ncbi-species_ssu_ref_138.1.txt.gz
│       │   ├── tax_ncbi-species_ssu_ref_138.1.txt.gz.md5
│       │   ├── tax_ncbi-species_ssu_ref_nr99_138.1.txt.gz
│       │   ├── tax_ncbi-species_ssu_ref_nr99_138.1.txt.gz.md5
│       │   ├── tax_ncbi_ssu_parc_138.1.txt.gz
│       │   ├── tax_ncbi_ssu_parc_138.1.txt.gz.md5
│       │   ├── tax_ncbi_ssu_ref_138.1.txt.gz
│       │   ├── tax_ncbi_ssu_ref_138.1.txt.gz.md5
│       │   ├── tax_ncbi_ssu_ref_nr99_138.1.txt.gz
│       │   └── tax_ncbi_ssu_ref_nr99_138.1.txt.gz.md5
│       ├── taxmap_slv_lsu_parc_138.1.txt.gz
│       ├── taxmap_slv_lsu_parc_138.1.txt.gz.md5
│       ├── taxmap_slv_lsu_ref_138.1.txt.gz
│       ├── taxmap_slv_lsu_ref_138.1.txt.gz.md5
│       ├── taxmap_slv_lsu_ref_nr_138.1.txt.gz
│       ├── taxmap_slv_lsu_ref_nr_138.1.txt.gz.md5
│       ├── taxmap_slv_ssu_parc_138.1.txt.gz
│       ├── taxmap_slv_ssu_parc_138.1.txt.gz.md5
│       ├── taxmap_slv_ssu_ref_138.1.txt.gz
│       ├── taxmap_slv_ssu_ref_138.1.txt.gz.md5
│       ├── taxmap_slv_ssu_ref_nr_138.1.txt.gz
│       ├── taxmap_slv_ssu_ref_nr_138.1.txt.gz.md5
│       ├── tax_slv_lsu_138.1.acc_taxid.gz
│       ├── tax_slv_lsu_138.1.acc_taxid.gz.md5
│       ├── tax_slv_lsu_138.1.diff.gz
│       ├── tax_slv_lsu_138.1.diff.gz.md5
│       ├── tax_slv_lsu_138.1.map.gz
│       ├── tax_slv_lsu_138.1.map.gz.md5
│       ├── tax_slv_lsu_138.1.tre.gz
│       ├── tax_slv_lsu_138.1.tre.gz.md5
│       ├── tax_slv_lsu_138.1.txt.gz
│       ├── tax_slv_lsu_138.1.txt.gz.md5
│       ├── tax_slv_ssu_138.1.acc_taxid.gz
│       ├── tax_slv_ssu_138.1.acc_taxid.gz.md5
│       ├── tax_slv_ssu_138.1.diff.gz
│       ├── tax_slv_ssu_138.1.diff.gz.md5
│       ├── tax_slv_ssu_138.1.map.gz
│       ├── tax_slv_ssu_138.1.map.gz.md5
│       ├── tax_slv_ssu_138.1.tre.gz
│       ├── tax_slv_ssu_138.1.tre.gz.md5
│       ├── tax_slv_ssu_138.1.txt.gz
│       └── tax_slv_ssu_138.1.txt.gz.md5
├── Fields_description
│   ├── LICENSE.txt
│   ├── SILVA_description_of_fields_21_09_2016.htm
│   └── SILVA_description_of_fields_21_09_2016.pdf
├── LICENSE.txt
├── README.txt
└── VERSION.txt

14 directories, 232 files

UNIPROT

UniProt is a freely accessible database of protein sequence and functional information, many entries being derived from genome sequencing projects. It contains a large amount of information about the biological function of proteins derived from the research literature.

In Graham we keep the latest release of uniprot at /datashare/UNIPROT.

Directory Structure

The structure of the UNIPROT dataset follows UNIPROT's FTP:

/datashare/UNIPROT
├── changes.html
├── decoy
│   ├── LICENSE
│   ├── README
│   └── RELEASE.metalink
├── knowledgebase
│   ├── complete
│   ├── genome_annotation_tracks
│   ├── idmapping
│   ├── pan_proteomes
│   ├── proteomics_mapping
│   ├── reference_proteomes
│   └── taxonomic_divisions
├── news.html
├── README
├── RELEASE.metalink
└── relnotes.txt

9 directories, 8 files

The explanation of each directory's content can be found at /datashare/UNIPROT/README or you can check it online here.

AI

CIFAR-10

The CIFAR-10 dataset consists of 60000 32x32 colour images in 10 classes, with 6000 images per class. There are 50000 training images and 10000 test images.

The dataset is divided into five training batches and one test batch, each with 10000 images. The test batch contains exactly 1000 randomly-selected images from each class. The training batches contain the remaining images in random order, but some training batches may contain more images from one class than another. Between them, the training batches contain exactly 5000 images from each class.

We provide the matlab, and python files with the test and training sets of CIFAR-10, along with the labels

Directory structure

CIFAR-10 directory tree (up to level 2):

/datashare/CIFAR-10
├── cifar-10-batches-bin
│   ├── batches.meta.txt
│   ├── data_batch_1.bin
│   ├── data_batch_2.bin
│   ├── data_batch_3.bin
│   ├── data_batch_4.bin
│   ├── data_batch_5.bin
│   ├── readme.html
│   └── test_batch.bin
├── cifar-10-batches-mat
│   ├── batches.meta.mat
│   ├── data_batch_1.mat
│   ├── data_batch_2.mat
│   ├── data_batch_3.mat
│   ├── data_batch_4.mat
│   ├── data_batch_5.mat
│   ├── readme.html
│   └── test_batch.mat
├── cifar-10-batches-py
│   ├── batches.meta
│   ├── data_batch_1
│   ├── data_batch_2
│   ├── data_batch_3
│   ├── data_batch_4
│   ├── data_batch_5
│   ├── readme.html
│   └── test_batch
├── cifar-10-binary.tar.gz
├── cifar-10-matlab.tar.gz
└── cifar-10-python.tar.gz

3 directories, 27 files

CIFAR-100

This dataset is just like the CIFAR-10, except it has 100 classes containing 600 images each. There are 500 training images and 100 testing images per class. The 100 classes in the CIFAR-100 are grouped into 20 superclasses. Each image comes with a "fine" label (the class to which it belongs) and a "coarse" label (the superclass to which it belongs). For more information https://www.cs.toronto.edu/~kriz/cifar.html.

We provide the matlab, and python files with the test and training sets of CIFAR-10, along with the labels

Directory structure

CIFAR-100 directory tree (up to level 2):

/datashare/CIFAR-100
├── cifar-100-binary
│   ├── coarse_label_names.txt
│   ├── fine_label_names.txt
│   ├── test.bin
│   └── train.bin
├── cifar-100-binary.tar.gz
├── cifar-100-matlab
│   ├── meta.mat
│   ├── test.mat
│   └── train.mat
├── cifar-100-matlab.tar.gz
├── cifar-100-python
│   ├── file.txt
│   ├── meta
│   ├── test
│   └── train
└── cifar-100-python.tar.gz

3 directories, 13 files


COCO

COCO is a large-scale object detection, segmentation, and captioning dataset. COCO has several features:

  • Object segmentation
  • Recognition in context
  • Superpixel stuff segmentation
  • 330K images (>200K labeled)
  • 1.5 million object instances
  • 80 object categories
  • 91 stuff categories
  • 5 captions per image
  • 250,000 people with keypoints

SHARCNET provides the 2017 release of the COCO dataset.

Directory Structure

The COCO dataset is provided following the the structure explained in https://cocodataset.org/#download:

/datashare/COCO
├── annotations
├── test2017
├── train2017
└── val2017

4 directories, 0 files

Within test, train and val the plain images in jpeg format can be found. all related annotations can be found on the folder annotations

ImageNet

See https://docs.computecanada.ca/wiki/ImageNet

MNIST

The MNIST database of handwritten digits, available from this page, has a training set of 60,000 examples, and a test set of 10,000 examples. It is a subset of a larger set available from NIST. The digits have been size-normalized and centered in a fixed-size image.

It is a good database for people who want to try learning techniques and pattern recognition methods on real-world data while spending minimal efforts on preprocessing and formatting.

In SHARCNET we offer a copy of these datasets located at /datashare/MNIST

Directory Structure

The directory contains the zip file with all training and testing images and labels, as well as the individual gzip files:

/datashare/MNIST
├── mnist.zip
├── t10k-images-idx3-ubyte.gz
├── t10k-labels-idx1-ubyte.gz
├── train-images-idx3-ubyte.gz
└── train-labels-idx1-ubyte.gz

0 directories, 5 files

For more information about this dataset, please visit http://yann.lecun.com/exdb/mnist/.

MPI_SINTEL

The MPI Sintel Dataset addresses limitations of existing optical flow benchmarks. It provides naturalistic video sequences that are challenging for current methods. It is designed to encourage research on long-range motion, motion blur, multi-frame analysis, non-rigid motion.

The dataset contains flow fields, motion boundaries, unmatched regions, and image sequences. The image sequences are rendered with different levels of difficulty.

Sintel is an open source animated short film produced by Ton Roosendaal and the Blender Foundation. Here we have modified the film in many ways to make it useful for optical flow evaluation.

In SHARCNET we provide this dataset as the complete version.

Directory Structure

SVHN

SVHN is a real-world image dataset for developing machine learning and object recognition algorithms with minimal requirement on data preprocessing and formatting. It can be seen as similar in flavor to MNIST (e.g., the images are of small cropped digits), but incorporates an order of magnitude more labeled data (over 600,000 digit images) and comes from a significantly harder, unsolved, real world problem (recognizing digits and numbers in natural scene images). SVHN is obtained from house numbers in Google Street View images. In SHARCNET we provide the full SVHN dataset at /datashare/SVHN in Graham.

Directory Structure

The SVHN dataset folder on graham contains:

/datashare/SVHN
├── extra
├── extra_32x32.mat
├── extra.tar.gz
├── housenumbers
├── test
├── test_32x32.mat
├── test.tar.gz
├── train
├── train_32x32.mat
└── train.tar.gz

4 directories, 6 files

The folder extra contains 163728 png images, train 33402 images, and test 13068 images. For more information visit http://ufldl.stanford.edu/housenumbers/

VoxCeleb

See https://docs.computecanada.ca/wiki/VoxCeleb