diff --git a/src/RNASeq.nf b/src/RNASeq.nf
new file mode 100644
index 0000000000000000000000000000000000000000..f78d5c2dab0c8a83fd105c5eaddbbc1fd8c4e13e
--- /dev/null
+++ b/src/RNASeq.nf
@@ -0,0 +1,24 @@
+log.info "fastq files : ${params.fastq}"
+
+Channel
+  .fromFilePairs( params.fastq )
+  .ifEmpty { error "Cannot find any fastq files matching: ${params.fastq}" }
+  .set { fastq_files }
+
+process adaptor_removal {
+  tag "$pair_id"
+  publishDir "results/fastq/adaptor_removal/", mode: 'copy'
+
+  input:
+  set pair_id, file(reads) from fastq_files
+
+  output:
+  set pair_id, "*_cut_R{1,2}.fastq.gz" into fastq_files_cut
+
+  script:
+  """
+  cutadapt -a AGATCGGAAGAG -g CTCTTCCGATCT -A AGATCGGAAGAG -G CTCTTCCGATCT \
+  -o ${pair_id}_cut_R1.fastq.gz -p ${pair_id}_cut_R2.fastq.gz \
+  ${reads[0]} ${reads[1]} > ${pair_id}_report.txt
+  """
+}
diff --git a/src/fasta_sampler.nf b/src/fasta_sampler.nf
index bd2e53973bd0cc6daaa8eef378b19ae1d96cb1b7..d1200ed496c77756cde525835f581b71b2528990 100644
--- a/src/fasta_sampler.nf
+++ b/src/fasta_sampler.nf
@@ -9,7 +9,7 @@ process sample_fasta {
 file fasta from fasta_file
 
   output:
-file "sample.fasta" into fasta_sample
+file "*_sample.fasta" into fasta_sample
 
   script:
 """