SCENIC is a tool to infer Gene Regulatory Networks and their associated cell states from single-cell RNA-seq data.
A typical SCENIC workflow includes the following steps:
Building the gene regulatory network (GRN):
Identify potential targets for each TF based on co-expression ("co-expression modules").
Select potential direct-binding targets ("regulons") based on DNA-motif analysis
Identify cell states and their regulators:
Analyzing the network activity in each individual cell
Identify stable cell states based on their gene regulatory network activity (cell clustering) and exploring the results...
For more details on how and why SCENIC folows these steps, and some usage examples, you can check the original paper.
Note that by default SCENIC is only available for three speciess: human, mouse and fly. For other species (or personalized motif collections) you would need to create your own databases).
There are currently implementations of SCENIC in R and in Python. For running it in batch on multiple datasets, or on big datasets, we normally recommend to use VSN (a Nextflow workflow), which highly automates and simplifies the analysis, as explained in the SCENIC protocol paper and examples. The output from VSN can be explored from either R or Python, and the web browser (SCope).
In this workshop, we will run SCENIC using VSN (Notebook 1), and explore the output in SCope and R (Notebook 2):
Notebook 1: Running SCENIC (VSN: includes Steps 1-4)
Notebook 2: Exploring SCENIC's output (R & SCope)
For advanced users who might want more details, modify the algorithm, or run only parts of it, detailed tutorials explaining each step in deatail are avilable in R (e.g. step by step and explanation of source code for regulons).
Where to find help:
When you are doing your own analysis, you will likely bump into problems. In that case:
?get_regulons
)The input to SCENIC is the single-cell RNA-seq expression matrix (i.e. the value of each field in the matrix corressponds to the expression of a gene in a cell):
The gene/feature ID should be the gene-symbol (for compatibility with cisTarget annotation databases).
Expression units: The preferred expression values are gene-summarized counts. There is currently not a strong consensus towards using the raw counts (e.g. from CellRanger), or counts normalized through single-cell specific methods (e.g. Seurat). Other measurements, such as transcripts/counts per million (TPM) and FPKM/RPKM, are also accepted as input. However, note that some authors recommend avoiding within sample normalization (i.e. TPM) for co-expression analysis (first step of SCENIC) because they may induce artificial co-variation (Crow et al. (2016)). The choice of input expression matrix might have some effect on the co-expression analysis to create the regulons (step 1). The other steps of the workflow are not directly affected by the input expression values: (2) The expression is not taken into account for the motif analysis, and (3) AUCell, which is used for scoring the regulons on the cells, is cell ranking-based (it works as an implicit normalization). Overall, SCENIC is quite robust to this choice, we have applied SCENIC to datasets using raw (logged) UMI counts, normalized UMI counts, and TPM and they all provided reliable results (see Aibar et al. (2017)).
This part of the workshop is based on the VSN pipeline tutorial.
For more complex examples, i.e. explaing gene filtering, see the SCENIC protocol example
Nextflow
and a container system (Singularity
or Docker
). VSN is run directly on a terminal.Make sure to have matching versions. e.g. at the time of preparing this notebook:
VSN 0.24.0 -> Nextflow 20.04.1
andVSN 0.25.0 -> Nextflow 20.10.1+
date
Fri Mar 26 12:00:49 CET 2021
module load Nextflow/20.10.0 # only needed in some systems
nextflow -version
N E X T F L O W version 20.10.0 build 5431 created 01-11-2020 15:28 UTC (16:28 CEST) cite doi:10.1038/nbt.3820 http://nextflow.io
singularity version
3.6.4-1.el7
Also make sure that LANG and LC_ALL environment variables have been set:
locale
LANG=en_US.utf8 LC_CTYPE="en_US.utf8" LC_NUMERIC="en_US.utf8" LC_TIME="en_US.utf8" LC_COLLATE=C LC_MONETARY="en_US.utf8" LC_MESSAGES="en_US.utf8" LC_PAPER="en_US.utf8" LC_NAME="en_US.utf8" LC_ADDRESS="en_US.utf8" LC_TELEPHONE="en_US.utf8" LC_MEASUREMENT="en_US.utf8" LC_IDENTIFICATION="en_US.utf8" LC_ALL=
# If some are not set, you can set them to the default language for instance:
export LANG="C"
export LC_ALL="C"
# ln -s /anywhere/Projects/Tutorials/ ~
cd ~/Tutorials/
mkdir -p SCENIC_pbmc
cd SCENIC_pbmc
This tutorial analyzes a typical scRNA-seq dataset with a single run: Blood cells (PBMC) data available from the 10x Genomics support website.
The “Feature / cell matrix (filtered)” data can be downloaded from 10x Genomics website (It is the typical output from their pipeline, after running Cell Ranger)
This dataset includes 10k cells. It would take approximately 2 hours to run SCENIC on it with a HPC system using 15 processes. Therefore, in this tutorial we will not run the analysis. Instead, we will prepare the inputs, and in the second part of the tutorial, we will directly explore the .loom file that was produced as output from a previous run.
wget http://cf.10xgenomics.com/samples/cell-exp/3.0.0/pbmc_10k_v3/pbmc_10k_v3_filtered_feature_bc_matrix.tar.gz
--2021-02-09 13:02:03-- http://cf.10xgenomics.com/samples/cell-exp/3.0.0/pbmc_10k_v3/pbmc_10k_v3_filtered_feature_bc_matrix.tar.gz Resolving cf.10xgenomics.com (cf.10xgenomics.com)... 2606:4700::6812:ad, 2606:4700::6812:1ad, 104.18.1.173, ... Connecting to cf.10xgenomics.com (cf.10xgenomics.com)|2606:4700::6812:ad|:80... connected. HTTP request sent, awaiting response... 301 Moved Permanently Location: https://cf.10xgenomics.com/samples/cell-exp/3.0.0/pbmc_10k_v3/pbmc_10k_v3_filtered_feature_bc_matrix.tar.gz [following] --2021-02-09 13:02:03-- https://cf.10xgenomics.com/samples/cell-exp/3.0.0/pbmc_10k_v3/pbmc_10k_v3_filtered_feature_bc_matrix.tar.gz Connecting to cf.10xgenomics.com (cf.10xgenomics.com)|2606:4700::6812:ad|:443... connected. HTTP request sent, awaiting response... 200 OK Length: 94334700 (90M) [application/x-tar] Saving to: 'pbmc_10k_v3_filtered_feature_bc_matrix.tar.gz.5' 100%[======================================>] 94,334,700 70.0MB/s in 1.3s 2021-02-09 13:02:04 (70.0 MB/s) - 'pbmc_10k_v3_filtered_feature_bc_matrix.tar.gz.5' saved [94334700/94334700]
When using 10x data as an input, the pipeline assumes the files are in the typical Cell Ranger directory structure (<datasetName>/outs/
). Therefore, we will extract the files into a folder following that naming scheme:
# Create directory structure:
mkdir -p pbmc10k_data/outs/
# Extract the file:
tar xvf pbmc_10k_v3_filtered_feature_bc_matrix.tar.gz -C pbmc10k_data/outs/
filtered_feature_bc_matrix/ filtered_feature_bc_matrix/matrix.mtx.gz filtered_feature_bc_matrix/barcodes.tsv.gz filtered_feature_bc_matrix/features.tsv.gz
# See the resulting files:
tree pbmc10k_data
pbmc10k_data `-- outs `-- filtered_feature_bc_matrix |-- barcodes.tsv.gz |-- features.tsv.gz `-- matrix.mtx.gz 2 directories, 3 files
In the following step, when setting up the nextflow config file, the tenx
input channel should point to the outs folder: pwd + 'pbmc10k_data/outs'
VSN-pipelines
project¶First, pull the VSN repository in Nextflow. The -r
flag can be used to specify the pipeline version to use:
nextflow pull vib-singlecell-nf/vsn-pipelines -r v0.25.0
Checking vib-singlecell-nf/vsn-pipelines ... done - revision: 721c42f889 [v0.25.0]
Then, define the run settings (a.k.a. create the config
file):
-profile
: Determines the parameters to include in the config file. Select the pipelines/settings that will be used in this specific analysis (i.e. this argument is to avoid creating huge file with all possibilities for all VSN-pipelines).In this case, we have used:
tenx
: defines the input data typesingle_sample_scenic
: creates the basic parameters for the single_sample
and scenic
workflows (see https://vsn-pipelines.readthedocs.io/en/latest/pipelines.html for the list of available pipelines and their options)scenic_use_cistarget_motifs
and scenic_use_cistarget_track
: includes parameters to specify the location of the cistarget database files (modify their location in the config file)hg38
: specifies the genomesingularity
(or docker
): specifies container system to use to run the processesnextflow config vib-singlecell-nf/vsn-pipelines \
-profile tenx,single_sample_scenic,scenic_use_cistarget_motifs,scenic_use_cistarget_tracks,hg38,singularity \
> pbmc10k.vsn-pipelines.complete.config
This will create the config file: pbmc10k.vsn-pipelines.complete.config
Important variables to check/edit in the config file are:
singularity.runOption
(or docker.runOptions
): the correct volume mounts should be specified (requires the user home folder, and the location of the data).params.global.project_name
(optional): will control the naming of the output files.params.sc.scope.tree.level_${X}
(optional): controls the labeling of the loom file when uploaded to the SCope viewer.params.sc.scanpy.filter
params.sc.scanpy.feature_selection
params.sc.scanpy.clustering
compute_resources__
Exercise: Open the config file and edit the settings required to continue the tutorial, including:
cellranger_mex = 'pbmc10k_data/outs/'
First pass: Check filtering settings
While the overall goal is to run SCENIC, the VSN pipeline also includes preprocessing and filtering steps. Those filtering settings should be checked to confirm they are the appropriate for the given dataset.
To save running time, it is possible and recommended to make a first pass running only those pre-processing steps (determined by the argument -entry single_sample
).
i.e.:
nextflow -C pbmc10k.vsn-pipelines.complete.config \
run vib-singlecell-nf/vsn-pipelines \
-entry single_sample \
-r v0.25.0
N E X T F L O W ~ version 20.10.0 Launching `vib-singlecell-nf/vsn-pipelines` [trusting_stallman] - revision: 721c42f889 [v0.25.0] [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - ------------------------------------------------------------------ No seed detected in the config To ensure reproducibility the seed has been set to 250 ------------------------------------------------------------------ [pbmc10k_data, /ddn1/vol1/staging/leuven/stg_00002/lcb/saibar/Projects/Tutorials/SCENIC_pbmc/pbmc10k_data/outs, 10x_cellranger_mex_outs, h5ad] executor > local (1) [de/71393d] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - ------------------------------------------------------------------ No seed detected in the config To ensure reproducibility the seed has been set to 250 ------------------------------------------------------------------ [pbmc10k_data, /ddn1/vol1/staging/leuven/stg_00002/lcb/saibar/Projects/Tutorials/SCENIC_pbmc/pbmc10k_data/outs, 10x_cellranger_mex_outs, h5ad] Pulling Singularity image docker://vibsinglecellnf/utils:0.4.0 [cache /scratch/leuven/312/vsc31245/tmp/nxf/singularity_cache_dir/vibsinglecellnf-utils-0.4.0.img] executor > local (1) [de/71393d] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - ------------------------------------------------------------------ No seed detected in the config To ensure reproducibility the seed has been set to 250 ------------------------------------------------------------------ [pbmc10k_data, /ddn1/vol1/staging/leuven/stg_00002/lcb/saibar/Projects/Tutorials/SCENIC_pbmc/pbmc10k_data/outs, 10x_cellranger_mex_outs, h5ad] Pulling Singularity image docker://vibsinglecellnf/utils:0.4.0 [cache /scratch/leuven/312/vsc31245/tmp/nxf/singularity_cache_dir/vibsinglecellnf-utils-0.4.0.img] executor > local (2) [de/71393d] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - ------------------------------------------------------------------ No seed detected in the config To ensure reproducibility the seed has been set to 250 ------------------------------------------------------------------ [pbmc10k_data, /ddn1/vol1/staging/leuven/stg_00002/lcb/saibar/Projects/Tutorials/SCENIC_pbmc/pbmc10k_data/outs, 10x_cellranger_mex_outs, h5ad] Pulling Singularity image docker://vibsinglecellnf/utils:0.4.0 [cache /scratch/leuven/312/vsc31245/tmp/nxf/singularity_cache_dir/vibsinglecellnf-utils-0.4.0.img] executor > local (2) [de/71393d] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - ------------------------------------------------------------------ No seed detected in the config To ensure reproducibility the seed has been set to 250 ------------------------------------------------------------------ [pbmc10k_data, /ddn1/vol1/staging/leuven/stg_00002/lcb/saibar/Projects/Tutorials/SCENIC_pbmc/pbmc10k_data/outs, 10x_cellranger_mex_outs, h5ad] Pulling Singularity image docker://vibsinglecellnf/utils:0.4.0 [cache /scratch/leuven/312/vsc31245/tmp/nxf/singularity_cache_dir/vibsinglecellnf-utils-0.4.0.img] executor > local (2) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (3) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (4) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (4) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (5) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (7) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (8) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (10) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [ca/923abb] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (10) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [ca/923abb] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (11) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (11) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (13) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (14) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (15) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (15) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (15) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (16) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (16) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (18) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (18) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (19) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (20) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (20) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (21) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (21) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (22) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (22) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (22) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (23) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (25) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (26) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (28) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [c0/986e46] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (29) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [c0/986e46] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (29) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [c0/986e46] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (31) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [c0/986e46] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:SINGLE_SAMPLE... - [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (32) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [c0/986e46] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (32) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [c0/986e46] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (32) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (32) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:SINGLE_SAMPLE... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (35) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1f/06270c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [e2/116a1d] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [e9/063fd0] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (35) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1f/06270c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [e2/116a1d] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [e9/063fd0] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (35) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1f/06270c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [e2/116a1d] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [e9/063fd0] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - executor > local (36) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1f/06270c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [e2/116a1d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/063fd0] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [26/ae7a33] process > single_sample:PUBLISH_SINGL... [ 0%] 0 of 1 [- ] process > single_sample:PUBLISH_SINGL... - executor > local (36) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1f/06270c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [e2/116a1d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/063fd0] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [26/ae7a33] process > single_sample:PUBLISH_SINGL... [ 0%] 0 of 1 [- ] process > single_sample:PUBLISH_SINGL... - executor > local (37) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1f/06270c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [e2/116a1d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/063fd0] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [26/ae7a33] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ [2b/76348c] process > single_sample:PUBLISH_SINGL... [ 0%] 0 of 1 executor > local (37) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1f/06270c] process > single_sample:SINGLE_SAMPLE... [ 0%] 0 of 1 [e2/116a1d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/063fd0] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [- ] process > single_sample:PUBLISH_SINGL... - [- ] process > single_sample:PUBLISH_SINGL... - [26/ae7a33] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ [2b/76348c] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ executor > local (38) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1f/06270c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e2/116a1d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/063fd0] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/6ec1ee] process > single_sample:PUBLISH_SINGL... [ 0%] 0 of 1 [- ] process > single_sample:PUBLISH_SINGL... - [26/ae7a33] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ [2b/76348c] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ executor > local (39) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1f/06270c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e2/116a1d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/063fd0] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/6ec1ee] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ [d9/5fae42] process > single_sample:PUBLISH_SINGL... [ 0%] 0 of 1 [26/ae7a33] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ [2b/76348c] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ executor > local (39) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1f/06270c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e2/116a1d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/063fd0] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/6ec1ee] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ [d9/5fae42] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ [26/ae7a33] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ [2b/76348c] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ executor > local (39) [de/71393d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [d2/bb98ce] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bf/0e7f5a] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c2/6c05bd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3f/ebcdf3] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [7b/38cac8] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [01/531e43] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [43/13ba9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [6d/4fe048] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/923abb] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/0be5a4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [fe/0cffe7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [b1/a3a833] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/30e3fd] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [bd/c857d4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [3c/2121fe] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [18/01c55c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [35/1cec9c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [8c/514713] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [0f/01a308] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [47/8c47e7] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [85/0d9233] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1b/534742] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e1/8718e4] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [a8/987dec] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [ca/06da07] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [da/0d7158] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c0/986e46] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [11/f5b34c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [c7/3702df] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [9a/d9d46b] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [5c/236f50] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [1f/06270c] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e2/116a1d] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [e9/063fd0] process > single_sample:SINGLE_SAMPLE... [100%] 1 of 1 ✔ [79/6ec1ee] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ [d9/5fae42] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ [26/ae7a33] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ [2b/76348c] process > single_sample:PUBLISH_SINGL... [100%] 1 of 1 ✔ WARN: To render the execution DAG in the required format it is required to install Graphviz -- See http://www.graphviz.org for more info. Completed at: 09-Feb-2021 13:08:23 Duration : 5m 7s CPU hours : 0.6 Succeeded : 39
The argument
-entry
determines the pipeline that will be run. Note that it will ony be possible to run the pipelines added to the config file in the previous step. In this case 'single_sample_scenic' is equivalent to running 'single_sample' + SCENIC. See VSN's readthedocs for the list and description of the different pipelines available.
The resulting QC reports will be located in out/notebooks/intermediate/pbmc10k.SC_QC_filtering_report.htm
(as ipynb, and converted html file).
If needed, the cell and gene filters can be updated by editing the config file.
For example, the filters used by default are:
params {
sc {
scanpy {
filter = {
cellFilterMinNGenes = 200
cellFilterMaxNGenes = 4000
cellFilterMaxPercentMito = 0.15
geneFilterMinNCells = 3
}
}
}
}
Exercise: Open the QC reports and have a look at the stats provided.
Second pass: Run SCENIC
Once the cell and gene filters look fine, we can re-start the pipeline to run SCENIC (setting -entry single_sample_scenic
).
Using the -resum
option will continue running the pipeline, skipping already completed steps: In this case, applying the correct filtering parameters, and continue to the upcoming SCENIC steps.
### Uncomment this field to run it. Note: it will probably take several hours.
# nextflow -C pbmc10k.vsn-pipelines.complete.config \
# run vib-singlecell-nf/vsn-pipelines \
# -entry single_sample_scenic \
# -r v0.25.0 \
# -resume
The main SCENIC outputs (including regulons and cell projections based on regulon activity) are packaged into a loom file. The loom file also includes the results of the parallel expression analysis.
out/loom/pbmc10k.SCENIC_SCope_output.loom
, and is ready to be uploaded to a SCope session.
The loom file from this analysis can be found on the SCENIC protocol SCope session (DSL2 > pbmc10k.SCENIC_SCope_output.loom).Other relevant output files include:
out/scenic/pbmc10k_data/notebooks/SCENIC_report.html
: Notebook with an overview of the SCENIC workflow. The last heatmap ("AUC Heatmap - Top 5 regulons from each cell type"), provides an useful overview of the regulons in the cells.
out/scenic/
: The other folders contain partial results from SCENIC pipeline, which can be useful for advanced users. For example, the motif enrichment analysis and co-expression modules (output of GRNBoost/GENIE3).
out/data/pbmc10k.PBMC10k_DSL2.single_sample.output.h5a
: an anndata file generated by the Scanpy section of the pipeline, including the results of the expression analysis in addition to SCENIC(i.e. clustering based on highly variable genes).
The work
folder contains temporary files to allow resuming the pipeline if needed. It can be deleted once the pipeline is finished.
In the second Notebook, we will explore these outputs in SCope and R.
To see the list of files:
tree out