Skip to content
Snippets Groups Projects

change gff for gtf

Merged Carine Rey requested to merge dev_carine into master
1 file
+ 10
9
Compare changes
  • Side-by-side
  • Inline
+ 10
9
@@ -3,7 +3,8 @@ nextflow.enable.dsl=2
@@ -3,7 +3,8 @@ nextflow.enable.dsl=2
log.info "fastq files: ${params.fastq}"
log.info "fastq files: ${params.fastq}"
log.info "fasta cds file: ${params.cds_fasta}"
log.info "fasta cds file: ${params.cds_fasta}"
log.info "fasta genomic file: ${params.genomic_fasta}"
log.info "fasta genomic file: ${params.genomic_fasta}"
log.info "fasta gff3 file: ${params.genomic_gff3}"
log.info "fasta gtf file: ${params.genomic_gtf}"
 
include { fastp } from './nf_modules/fastp/main.nf' addParams(fastp_out: "fastQC/")
include { fastp } from './nf_modules/fastp/main.nf' addParams(fastp_out: "fastQC/")
include {
include {
@@ -20,7 +21,7 @@ include {
@@ -20,7 +21,7 @@ include {
)
)
include {
include {
index_with_gff as star_index_with_gff;
index_with_gtf as star_index_with_gtf;
mapping_fastq as star_mapping_fastq
mapping_fastq as star_mapping_fastq
} from './nf_modules/star/main.nf' addParams(
} from './nf_modules/star/main.nf' addParams(
star_mapping_fastq_out: "star_bam/"
star_mapping_fastq_out: "star_bam/"
@@ -31,7 +32,7 @@ include { index_bam
@@ -31,7 +32,7 @@ include { index_bam
htseq_out: "star_bam/"
htseq_out: "star_bam/"
)
)
include { htseq_count_with_gff
include { htseq_count as htseq_count_with_gtf
} from './nf_modules/htseq/main.nf' addParams(
} from './nf_modules/htseq/main.nf' addParams(
htseq_out: "htseq_count/"
htseq_out: "htseq_count/"
)
)
@@ -61,10 +62,10 @@ channel
@@ -61,10 +62,10 @@ channel
.set { genomic_fasta_file }
.set { genomic_fasta_file }
channel
channel
.fromPath( params.genomic_gff3 )
.fromPath( params.genomic_gtf )
.ifEmpty { error "Cannot find any gff3 files matching: ${params.genomic_gff3}" }
.ifEmpty { error "Cannot find any gtf files matching: ${params.genomic_gtf}" }
.map { it -> [it.simpleName, it]}
.map { it -> [it.simpleName, it]}
.set { genome_gff3_file }
.set { genome_gtf_file }
workflow {
workflow {
//trim data
//trim data
@@ -82,7 +83,7 @@ workflow {
@@ -82,7 +83,7 @@ workflow {
//star mapping
//star mapping
//// star index
//// star index
star_index_with_gff(genomic_fasta_file,genome_gff3_file)
star_index_with_gtf(genomic_fasta_file,genome_gtf_file)
star_index = star_index_with_gff.out
star_index = star_index_with_gff.out
////star mapping
////star mapping
@@ -95,9 +96,9 @@ workflow {
@@ -95,9 +96,9 @@ workflow {
//// index bam
//// index bam
index_bam(star_mapping_fastq.out.bam)
index_bam(star_mapping_fastq.out.bam)
htseq_count_with_gff(
htseq_count_with_gtf(
index_bam.out.bam_idx,
index_bam.out.bam_idx,
genome_gff3_file
genome_gtf_file
)
)
//report multiqc
//report multiqc
Loading