Giter Site home page Giter Site logo

guessmylt's Introduction

install with bioconda docker_guessmylt DOI DOI PyPI version Anaconda-Server Badge Anaconda-Server Badge

GUESSmyLT

Software to guess the RNA-Seq library type of paired and single end read files using mapping and gene annotation.

Table of contents

Background

The choice of RNA-Seq library type defines the read orientation of the sequencing and the order in which the strands of cDNA are sequenced, which means that RNA-Seq reads from different library types can differ significantly. The information regarding library type can be very useful for reads to be assembled into a transcriptome or mapped to a reference assembly. This is because the library type can help to discern where in the transcriptome shorter ambiguous reads belong by using the read’s relative orientation and from which strand it was sequenced. Unfortunately, this information regarding the library type used is not included in sequencing output files and may be lost before the assembly of the data. Even when working with RNA-Seq data from public repositories there is no guarantee that the library type information is correct or that it exists at all. This is what GUESSmyLT aims to fix by looking at how reads map to a reference and together with gene annotation guess which library was used to generate the data.

Dependencies:

Developed for Unix systems. Depending installation approach more or less dependencies will be installed automatically. Check the installation paragraph.

Python and libraries:

  • Python >3
  • biopython (1.67)
  • bcbio-gff (0.6.4) - handling gff annotation
  • pysam (0.15.1) - handling mapped reads

Other programs:

  • Snakemake (5.4.0) - Workflow management
  • BUSCO (3.0.2) - Gene annotation
  • Bowtie2 (2.3.4.3) - Mapping
  • Trinity (2.8.4) - Reference assembly

Others:

Installation

Using Docker

First you must have Docker installed and running.
Secondly have look at the availabe GUESSmyLT biocontainers at quay.io.
Then:

# get the chosen GUESSmyLT container version
docker pull quay.io/biocontainers/guessmylt:0.2.5--py_0
# run GUESSmyLT
docker run quay.io/biocontainers/guessmylt:0.2.5--py_0 GUESSmyLT

Using Singularity

First you must have Singularity installed and running. Secondly have look at the availabe GUESSmyLT biocontainers at quay.io.
Then:

# get the chosen GUESSmyLT container version
singularity pull docker://quay.io/biocontainers/guessmylt:0.2.5--py_0 
# run the container
singularity run guessmylt_0.2.5--pl5262hdfd78af_0.sif

Installation with conda:

With an activated Bioconda channel (see 2. Set up channels), install with:

conda install guessmylt

Installation with pip:

Installation using pip will not install BUSCO, Bowtie2 and Trinity. These external programs can be installed using conda.

pip install GUESSmyLT

Installation with git:

Installation using git will not install BUSCO, Bowtie2 and Trinity. These external programs can be installed using conda.

Clone the repository and move to the folder:

git clone https://github.com/NBISweden/GUESSmyLT.git
cd GUESSmyLT/

Launch the installation either:

python setup.py install

Or if you do not have administrative rights on your machine:

python setup.py install --user

Check installation

Executing:

GUESSmyLT

or

GUESSmyLT -h

to display help.

There is also an example run that takes roughly 5 mins. A folder called GUESSmyLT_example_out will be created in the working directory:

GUESSmyLT-example

Result

The results are printed as stdout and to a result file. One example of a result would be:

Results of paired library inferred from reads:

   Library type    Relative orientation         Reads     Percent    Vizualization according to firststrand

 ff_firststrand                matching             5        0.1%    3' <==2==----<==1== 5'
                                                                     5' ---------------- 3'


ff_secondstrand                matching             3        0.0%    3' ---------------- 5'
                                                                     5' ==1==>----==2==> 3'


 fr_firststrand                  inward          4167       47.7%    3' ----------<==1== 5'
                                                                     5' ==2==>---------- 3'


fr_secondstrand                  inward          4521       51.7%    3' ----------<==2== 5'
                                                                     5' ==1==>---------- 3'


 rf_firststrand                 outward            19        0.2%    3' <==2==---------- 5'
                                                                     5' ----------==1==> 3'


rf_secondstrand                 outward            23        0.3%    3' <==1==---------- 5'
                                                                     5' ----------==2==> 3'


      undecided                      NA             1        0.0%    3' -------??------- 5'
                                                                     5' -------??------- 3'
								     
Roughly 50/50 split between the strands of the same library orientation should be interpreted as unstranded.

Based on the orientations of the reads we would assume that the library type is fr-unstranded as there is roughly a 50-50 split between fr-first and fr-second.

Usage

File formats

Read files: .fastq Mapping: .bam Reference: .fa

Supported header formats

Tested for Old/New Illumina headers and downloads from SRA. Should work, but not tested for all fastq header formats at: https://www.ncbi.nlm.nih.gov/sra/docs/submitformats/

Supported interleaved formats

If headers are in Old/New Illumina or if reads are alternating.

Old Illumina: @HWUSI-EAS100R:6:73:941:1973#0/1
New Illumina: @EAS139:136:FC706VJ:2:2104:15343:197393 1:Y:18:ATCACG
Alternating:
      @read1 (first mate)
      ..
      @read1 (second mate)
      ..
      @read2 (first mate)
      ..
      @read2 (second mate)
      ..

Example commands

In top of your fastq RNA-Seq read file(s) (compressed or uncompressed):

If you have no other information just the reads

Example with paired reads in eukaryote.

GUESSmyLT --reads read_1.fastq read_2.fastq

If you only have a reference genome

Example with paired reads in eukaryote.

GUESSmyLT --reads read_1.fastq read_2.fastq --reference ref.fa --mode genome --organism euk

If you have reference genome and annotation

Example with paired reads in eukaryote.

GUESSmyLT --reads read_1.fastq read_2.fastq --reference ref.fa --mode genome --annotation annotation.gff --organism euk

If you have reference genome and mapped reads

Example with paired reads in eukaryote.

GUESSmyLT --reads read_1.fastq read_2.fastq --reference ref.fa --mode genome --mapped mapped.bam --organism euk

If you have reference genome and annotation and mapped reads

Example with paired reads in eukaryote.

GUESSmyLT --reads read_1.fastq read_2.fastq --reference ref.fa --mode genome --mapped mapped.bam --annotation annotation.gff --organism euk

If you only have transcript sequences

/!\ not yet implemented (use genome mode instead it should work anyway) Example with paired reads in eukaryote.

GUESSmyLT --reads read_1.fastq read_2.fastq --reference ref.fa --mode transcriptome --organism euk

If you have transcript sequences and annotation

/!\ not yet implemented (use genome mode instead it should work anyway) Example with paired reads in eukaryote. (The annotation has to be the annotation within the trascriptome not the genome)

GUESSmyLT --reads read_1.fastq read_2.fastq --reference ref.fa --mode transcriptome --annotation annotation.gff --organism euk

Other examples

Paired end reads and reference with specified subsampled reads. Output directed to existing directory.
GUESSmyLT --reads read_1.fastq read_2.fastq --organism pro --reference ref.fa --subsample 100000 --output my_output/
Single end reads and prokaryote genome
GUESSmyLT --reads reads.fastq --reference ref.fa --organism pro

Interleaved paired reads

cd GUESSmyLT/
python3 GUESSmyLT.py --reads reads.fastq --reference ref.fa --organism euk

Output

GUESSmyLT will print the result in the command line as well as write it to a file:

[output_dir]/result_[read_name]on_[refname].txt

Results from intermediate steps, such as the mapping from Bowtie2 or annotation from BUSCO are saved in

[output_dir]/intermediate_data/

Parameters

Mandatory

Parameter Input Description
--reads .fastq file(s) Full path(s) to RNA-Seq read file(s). Can be compressed or uncompressed. Order is not important. Can handle two paired end read files, one interleaved read file and single end read file.
--organism euk or pro Eukaryote or prokaryote (euk/pro) is an option needed for the BUSCO annotation.

Optional

Parameter Input Description
--subsample Even integer Number of reads that will be used for subsampling.
--reference .fa file Full paths to reference genome/transcriptome for mapping reads to (nucleotide fasta file).
--mode genome or transcriptome When no annotation is provided, tells the programm if the reference fasta file has to be considered as a genome or a transcriptome in order to use BUSCO properly.
--threads Integer Number of threads to use. (default 2)
--memory Number of GB ex: 10G Maximum memory that can be used in GB. (default 8G)
--annotation .gff file Full path to annotation file for skipping BUSCO step.
--mapped Sorted .bam file Full path to mapped read file for skipping Bowtie2 step.
--output File path Full path to result file. If left out files will be written to working directory.

Overview of the pipeline

alt text
GUESSmyLT uses Snakemake to build the pipeline it needs in order to predict the library type. Required arguments are organism (euk/pro) and reads (read file(s) in fastq format). Reference (genome or transcriptome in .fasta format) is optional, and if it is not provided, Trinity will first be executed to create a De novo assembly of the reads. Next, BUSCO is used for annotation. This is also a QC step because BUSCO looks for core genes, so called BUSCOs, in the reference. If they cannot be found, it indicates that the reference has bad quality and therefore the pipeline will terminate. If BUSCOs are found, the process continues with mapping the reads to the reference using Bowtie2. The mapping is done with unstranded option so that the reads can be mapped on both the strands and in both directions. Finally, the mapping and annotation is used for inference, which is done with a python script and the library type is returned. On top of Snakemake, we have a python script, GUESSmyLT.py. Its purpose is to handle user arguments by:

  1. Checking that arguments are correct, files exists and are in correct format.
  2. Telling Snakemake what files exist by updating the config file.
  3. Executing snakemake.

The Snakefile subsample handles preparation of the readfiles:

  1. Subsamples reads into new read files that are used in the analysis. This makes GUESSmyLT faster and protects the original files from being modified.
  2. Modifying files: a. Changes read files that are in wrong format. Trinity and Pysam can only handle old Illumina format: @read_ID/pair#, where pair# is 1 or 2. They do not work with whitespaces, punctutations nor undescrores. Therefore, the script makes sure that the headers are converted into the correct format. b. Deinterleaves paired end read files if they are interleaved.

Overview of the different library types:

alt text

Library prep methods:

kit Description Paired Stranded Strand according to mRNA Strand according to first strand
TruSeq RNA Sample Prep kit yes No fr-unstranded
SMARTer ultralow RNA protocol yes No fr-unstranded
All dUTP methods, NSR, NNSR yes Yes RF fr-firststrand
TruSeq Stranded Total RNA Sample Prep Kit yes Yes RF fr-firststrand
TruSeq Stranded mRNA Sample Prep Kit yes Yes RF fr-firststrand
NEB Ultra Directional RNA Library Prep Kit yes Yes RF fr-firststrand
Agilent SureSelect Strand-Specific yes Yes RF fr-firststrand
Directional Illumina (Ligation) yes Yes FR fr-secondstrand
 Standard SOLiD Yes yes FR fr-secondstrand
ScriptSeq v2 RNA-Seq Library Preparation Kit yes Yes FR fr-secondstrand
SMARTer Stranded Total RNA yes Yes FR fr-secondstrand
 Encore Complete RNA-Seq Library Systems yes Yes FR fr-secondstrand
NuGEN SoLo yes Yes FR fr-secondstrand
Illumina ScriptSeq yes Yes FR fr-secondstrand
SOLiD mate-pair protocol ff

--rf orientation are produced using the Illumina mate-pair protocol?

External resources:

https://chipster.csc.fi/manual/library-type-summary.html
https://galaxyproject.org/tutorials/rb_rnaseq/
http://onetipperday.sterding.com/2012/07/how-to-tell-which-library-type-to-use.html
https://sailfish.readthedocs.io/en/master/library_type.html
https://rnaseq.uoregon.edu
https://www.researchgate.net/post/What_is_the_difference_between_strand-specific_and_not_strand-specific_RNA-seq_data

Known issues

  1. Complains about gzip broken pipe when subsampling with compressed files (but works anyway).
  2. BUSCO sometimes looses the config path. Fix manually in terminal:
export AUGUSTUS_CONFIG_PATH=~/miniconda3/pkgs/augustus-3.2.3-boost1.60_0/config
  1. BUSCO might not find any core genes. Fix by using more reads or by providing reference.
  2. Mapping, annotation, assembly or the entire pipeline is skipped. This is most likely due to the fact that Snakemake checks which output files need to be generated and from there only performs the necessary steps of the pipeline. The result of this is that is you already have a .bam file, BUSCO/Trinity output folder or a result .txt file for the reads Snakemake will skip steps
  3. Installing Trinity for mac via Conda will give you a version from 2011 that doesn't work. Install using Homebrew instead.

TO DO

* Add Travis using example data provided as reference.  
* Look more into why some reads get undecided orientation. This is when a read's mate cannot be found and is probably due to a read is at the end of a gene and its mate is outside of the selected region.  

Citation

If you use GUESSmyLT in your work, please cite us:
DOI

Author

Berner Wik E.*,1, Olin H.*,1, Vigetun Haughey C.*,1, Lisa Klasson1, Jacques Dainat2,3

*These authors contributed equally to the work.
1Molecular Evolution, Department of Cell and Molecular Biology, Uppsala University, 75124 Sweden.
2National Bioinformatics Infrastructure Sweden (NBIS), SciLifeLab, Uppsala Biomedicinska Centrum (BMC), Husargatan 3, S-751 23 Uppsala, SWEDEN.
3IMBIM - Department of Medical Biochemistry and Microbiology, Box 582, S-751 23 Uppsala, SWEDEN.

guessmylt's People

Contributors

intelin avatar juke34 avatar nanjiangshu avatar

Stargazers

 avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar

Watchers

 avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar

guessmylt's Issues

Installed BUSCO is detected to be missing

Hello,
I met a problem with GUESSmyLT:

$ Building DAG of jobs...
Using shell: /bin/bash
Provided cores: 2
Rules claiming more threads will be scaled down.
Job counts:
	count	jobs
	1	bowtie2_index
	1	bowtie2_map
	1	check_programs
	1	inferr
	1	samtools_sort_new_mapped
	1	subsample_fastq
	6

[Thu Oct  7 14:33:03 2021]
rule check_programs:
    output: programs.checked
    jobid: 3
    priority: 2

Job counts:
	count	jobs
	1	check_programs
	1
[Thu Oct  7 14:33:03 2021]
Error in rule check_programs:
    jobid: 0
    output: programs.checked

SystemExit in line 25 of /storage/ppl/software/anaconda3/envs/AltSplice/lib/python3.8/site-packages/guessmylt-0.2.5-py3.8.egg/GUESSmyLT/check_programs:
1
  File "/storage/ppl/software/anaconda3/envs/AltSplice/lib/python3.8/concurrent/futures/thread.py", line 57, in run
  File "/storage/ppl/software/anaconda3/envs/AltSplice/lib/python3.8/site-packages/guessmylt-0.2.5-py3.8.egg/GUESSmyLT/check_programs", line 25, in __rule_check_programs
  File "/storage/ppl/software/anaconda3/envs/AltSplice/lib/python3.8/_sitebuiltins.py", line 26, in __call__
Exiting because a job execution failed. Look above for error message
Checking for bowtie2, upon error make sure it's installed properly
Bowtie2 works, continuing...

Checking for BUSCO, upon error make sure it's installed properly
Let's try run_busco
Let's try run_BUSCO.py
BUSCO is missing.
Shutting down, this might take some time.
Exiting because a job execution failed. Look above for error message
Complete log: /storage/yifang/AltSplicing/scripts/.snakemake/log/2021-10-07T143303.312906.snakemake.log

The log pointed to me the problem busco, but busco was installed.

$ which busco
/storage/ppl/software/anaconda3/envs/AltSplice/bin/busco

My command line is:

GUESSmyLT  --reads ${DIR_IN}/RE5_1_trimmed_PE_R1.fq.gz ${DIR_IN}/RE5_1_trimmed_PE_R2.fq.gz \
             --reference ${REF_FASTA} \
             --mapped ${DIR_OUT}/Brapa_genome_1st_sorted.bam \
             --mode genome \
             --annotation ${GFF} \
             --organism euk

I am wondering is anybody has a clue for this issue? Thanks a lot!

Provide a docker container

Do you have any interest in packaging this tool and all of its dependencies in a docker container? It would be a lot easier to deploy across computing environments.

error

Hello,

I'm getting the following error after sending this job:
GUESSmyLT --reads ~/sample1.fastq --reference ~/referenceGenome.fa --mode genome --mapped sample1_bowtie2.coordSorted.bam --organism euk

Reference and bam have Sequence ID matching. We can continue.
Traceback (most recent call last):
File "/.conda/envs/py3Env/bin/GUESSmyLT", line 8, in
sys.exit(main())
File "
/.conda/envs/py3Env/lib/python3.6/site-packages/GUESSmyLT/GUESSmyLT.py", line 305, in main
if get_type(args.mapped) == "single":
File "~/.conda/envs/py3Env/lib/python3.6/site-packages/GUESSmyLT/GUESSmyLT.py", line 94, in get_type
nb_reads_paired = int(str(out.decode("utf-8")).split("\n")[0])
ValueError: invalid literal for int() with base 10: ''

Any suggestion on how to fix this error?

Thanks

Error. No genes could be found in --annotation

Hello,

I get the error ''Error. No genes could be found in --annotation" when specifying a GTF or GFF3 file. I know I could just run BUSCO but I would like to use the annotations I have. Could you please:
1- Confirm you need GFF3 file ?
2- That you need "gene" features in the GFF3 ? I have data from UCSC and we have those features (but no "gene"):
3UTR
5UTR
CDS
exon
start_codon
stop_codon
transcript

If I really need these 'genes features' do you know of any tool I could use to infer them ?

Thanks in advance,

N. Lehmann

cannot run with only fastq file

The README says that we can run with only fastq files but I am unable to do so:

GUESSmyLT --reads raw_fastq/Mov10_oe_1.subset.fq

Mode parameter (--mode) must be filled when no annotation provided (--annotation). It must be <genome> or <transcriptome>.

Singularity container does not work due to read only filesystem

Hi!
I tried the Singularity container, but get below error, Probably whatever that is should be extracted to a tempdir outside the container. Conda works for me.

singularity run -B $WORK:$WORK $WORK/singularity/guessmylt\:0.2.5--py_0.sif

Singularity> GUESSmyLT --reads foo_1.fq.gz foo_2.fq.gz --reference genome.fasta --annotation genomic.gff --organism euk
           
Traceback (most recent call last):
  File "/usr/local/bin/GUESSmyLT", line 6, in <module>        
    from GUESSmyLT.GUESSmyLT import main                           
  File "/usr/local/lib/python3.6/site-packages/GUESSmyLT/GUESSmyLT.py", line 29, in <module>
    tf.extractall(path=script_dir+"data/")                         
  File "/usr/local/lib/python3.6/tarfile.py", line 2010, in extractall
    numeric_owner=numeric_owner)                              
  File "/usr/local/lib/python3.6/tarfile.py", line 2052, in extract
    numeric_owner=numeric_owner)                              
  File "/usr/local/lib/python3.6/tarfile.py", line 2124, in _extract_member
    self.makedir(tarinfo, targetpath)
  File "/usr/local/lib/python3.6/tarfile.py", line 2153, in makedir
    os.mkdir(targetpath, 0o700)
OSError: [Errno 30] Read-only file system: '/usr/local/lib/python3.6/site-packages/GUESSmyLT/data/eukaryota_odb9'

Logging of last step, Inference

The output of the inferring script is a bit barebones. Some more logging could be added to give more insight into how it's progressing.

hmmsearch Parse failed ...

Hi GuessmyLT developers, I'd like to ask if [hmmsearch] Parse failed ... [hmmsearch] Line 2: illegal character % is something that can be safely ignored. I'm running the strand prediction with bam files. Although the job doesn't terminate with this INFO, I'm wondering if this has something to do with the hmmer version (using v3.3.2) or with input file. Thank you!

No match found betwwen sequence id from the bam file and the reference file

Hi @Juke34. I've used GUESSmyLT before with PE150 reads and it worked. Now, I'm trying to use it with SE50 reads with a sorted bam file alignment, and I'm only getting "Not match found between sequence id from the bam file and the reference file. Please check provided files.". I checked the reference and the bam file, and contrary to what's being raised the sequence ID is perfectly identical. I wonder what's causing this.

Thanks a lot for the help!

result interpretation

Hi,

I get the following result when running guessmylty:

fr_firststrand 43.3%
fr_secondstrand 0.4%
rf_secondstrand 1.4%
undecided 55.0%

More than half of the reads are undecided. I was wondering how could I interpret the results concerning the strandedness of the library?

Thank you,
Kind regards,
Homa

Handling external annotation file (gff)

Would be nice to be able to use an external annotation (off file). we can then skip the BUSCO part. Maybe we can check that sequence id between fasta and gff are the same.

Error in bowtie2_index

Hello,

When running GUESSmyLT with fastq files and reference genome, I get the following error:

bowtie2-build: /cluster/software/VERSIONS/intel-2017.2/advisor_2017.1.2.501009/lib64/libstdc++.so.6: version `GLIBCXX_3.4.21' not found (required by bowtie2-build)
[Fri Oct 25 22:55:09 2019]
Error in rule bowtie2_index:
    jobid: 0
    output: intermediate_data/index/spanish_sparrow_4kflye_pilon1.1.bt2, intermediate_data/index/spanish_sparrow_4kflye_pilon1.2.bt2, intermediate_data/index/spanish_sparrow_4kflye_pilon1.3.bt2, intermediate_data/index/spanish_sparrow_4kflye_pilon1.4.bt2, intermediate_data/index/spanish_sparrow_4kflye_pilon1.rev.1.bt2, intermediate_data/index/spanish_sparrow_4kflye_pilon1.rev.2.bt2
    log: logs/bowtie2_index_spanish_sparrow_4kflye_pilon1.log (check log file(s) for error message)

RuleException:
CalledProcessError in line 42 of /usit/abel/u1/annaru/miniconda3/envs/RNA_seq_analysis/lib/python3.5/site-packages/GUESSmyLT/bowtie2:
Command 'set -euo pipefail;  bowtie2-build /projects/cees/in_progress/anna/Homa/sparrow_annotation/bin/../data/spanish_sparrow_4kflye_pilon1/spanish_sparrow_4kflye_pilon1.fasta intermediate_data/index/spanish_sparrow_4kflye_pilon1 | tee logs/bowtie2_index_spanish_sparrow_4kflye_pilon1.log' returned non-zero exit status 1
  File "/usit/abel/u1/annaru/miniconda3/envs/RNA_seq_analysis/lib/python3.5/site-packages/GUESSmyLT/bowtie2", line 42, in __rule_bowtie2_index
  File "/usit/abel/u1/annaru/miniconda3/envs/RNA_seq_analysis/lib/python3.5/concurrent/futures/thread.py", line 55, in run
Exiting because a job execution failed. Look above for error message

Does this mean I should install libstdc++.so.6: version GLIBCXX_3.4.21? Is there a way that I install it only in my working environment since I'm working on a cluster?

Thank you,
Homa

error with using the GUESSmyLT.py

I tried following instruction but I keep getting the following:

(base) Meetas-MacBook-Pro:GUESSmyLT mem205$ python GUESSmyLT.py Traceback (most recent call last): File "GUESSmyLT.py", line 12, in <module> from BCBio import GF

Deal with different samtools version

Should launch different command according to the samtools version .
Add a try and do either samtools sort {input.bam_file} -f {output} when samtools <= 1.2 or samtools sort {folder}"+sample+"_mapped.bam > {output} when samtools >= 1.3

cannot install with conda on Ubuntu 20.04 nor 22.04

Hi,
Despite my best efforts I'm not able to install guessmylt on Ubuntu.

On Ubuntu 20.04 LTS:

conda install -c bioconda guessmylt
Collecting package metadata (current_repodata.json): done
Solving environment: failed with initial frozen solve. Retrying with flexible solve.
Solving environment: failed with repodata from current_repodata.json, will retry with next repodata source.
Collecting package metadata (repodata.json): done
Solving environment: failed with initial frozen solve. Retrying with flexible solve.
Solving environment: \ 
Found conflicts! Looking for incompatible packages.
This can take several minutes.  Press CTRL-C to abort.
failed                                                                                                                                                                                                                                       

UnsatisfiableError: The following specifications were found to be incompatible with each other:

Output in format: Requested package -> Available versionsThe following specifications were found to be incompatible with your system:

  - feature:/linux-64::__glibc==2.31=0
  - feature:|@/linux-64::__glibc==2.31=0

Your installed version is: 2.31

On Ubuntu 22.04 LTS:

conda install -c bioconda guessmylt
Collecting package metadata (current_repodata.json): done
Solving environment: failed with initial frozen solve. Retrying with flexible solve.
Solving environment: failed with repodata from current_repodata.json, will retry with next repodata source.
Collecting package metadata (repodata.json): done
Solving environment: failed with initial frozen solve. Retrying with flexible solve.
Solving environment: - 
Found conflicts! Looking for incompatible packages.
This can take several minutes.  Press CTRL-C to abort.
failed                                                                                                                                                                                                                                       

UnsatisfiableError: The following specifications were found to be incompatible with each other:

Output in format: Requested package -> Available versionsThe following specifications were found to be incompatible with your system:

  - feature:/linux-64::__glibc==2.35=0
  - feature:|@/linux-64::__glibc==2.35=0

Your installed version is: 2.35

Any help would be greatly appreciated!
Thanks

Recommend Projects

  • React photo React

    A declarative, efficient, and flexible JavaScript library for building user interfaces.

  • Vue.js photo Vue.js

    🖖 Vue.js is a progressive, incrementally-adoptable JavaScript framework for building UI on the web.

  • Typescript photo Typescript

    TypeScript is a superset of JavaScript that compiles to clean JavaScript output.

  • TensorFlow photo TensorFlow

    An Open Source Machine Learning Framework for Everyone

  • Django photo Django

    The Web framework for perfectionists with deadlines.

  • D3 photo D3

    Bring data to life with SVG, Canvas and HTML. 📊📈🎉

Recommend Topics

  • javascript

    JavaScript (JS) is a lightweight interpreted programming language with first-class functions.

  • web

    Some thing interesting about web. New door for the world.

  • server

    A server is a program made to process requests and deliver data to clients.

  • Machine learning

    Machine learning is a way of modeling and interpreting data that allows a piece of software to respond intelligently.

  • Game

    Some thing interesting about game, make everyone happy.

Recommend Org

  • Facebook photo Facebook

    We are working to build community through open source technology. NB: members must have two-factor auth.

  • Microsoft photo Microsoft

    Open source projects and samples from Microsoft.

  • Google photo Google

    Google ❤️ Open Source for everyone.

  • D3 photo D3

    Data-Driven Documents codes.