Guorui Zhong
  • About
  • Blog
  • Programming
    • Python Programming
    • R Programming
    • Conda
  • Wiki
  • Keyboard

Year

  • 2025
  • 2024
  • 2023
  • 2022
  • 2021
Categories
All (56)
barplot (1)
batch effect (1)
cairo (1)
colors (2)
complexheatmap (1)
Computing (1)
conda (1)
density (1)
dimensional reduction (3)
ggbeeswarm (1)
ggplot2 (12)
HPC (1)
imagej (1)
inkscape (1)
linux (6)
markdown (1)
mIF (1)
mutation (1)
p-value (3)
parallel (1)
pca (4)
plate (1)
plsda (2)
pseudobulk (1)
punctuation (1)
r (27)
regex (1)
renv (1)
rnaseq (1)
screen (1)
scrna (5)
scRNA-seq (3)
seurat (5)
shapes (1)
SLURM (1)
ssh (1)
supervised (2)
tmux (1)
tsne (1)
umap (1)
unsupervised (4)
vim (1)
vscode (2)

2025

March 1, 2025

Commonly Used SLURM Commands in HPC

HPC
SLURM
Computing

SLURM (Simple Linux Utility for Resource Management) is a powerful and flexible job scheduler used in High-Performance Computing (HPC) environments. It helps manage and…

Commonly Used SLURM Commands in HPC
No matching items

2024

June 5, 2024

Parallel Processing in R

parallel

Parallel processing is a powerful technique to speed up computations by utilizing multiple CPU cores simultaneously. In R, several functions and packages enable parallel…

Parallel Processing in R

May 11, 2024

Plot scatter plot with 2D density

density

2d density plot is helpful for examining the connection between 2 numerical variables. It divides the plot area into several little fragments to prevent overlapping (as in the scatterplot next to it) and shows the number of points in each fragment.

Plot scatter plot with 2D density

April 18, 2024

Multiplex image-based phenotypic data analysis

mIF

IMC example data is from here

Multiplex image-based phenotypic data analysis

March 18, 2024

Seurat V5 | 10X course example

seurat
scrna

Seurat Example

March 15, 2024

Analysis of single cell RNA-seq data with {SingleCellExperiment}

scrna

Using SingleCellExperiment object to analysis single cell data

Analysis of single cell RNA-seq data with {SingleCellExperiment}

March 13, 2024

SingleCellExperiment | Practise Single-cell RNA-seq data analysis

scrna

All the contents are credited or adapted from Orchestrating Single-Cell Analysis with Bioconductor for leaning purpose.

SingleCellExperiment | Practise Single-cell RNA-seq data analysis

February 25, 2024

Seurat V5 | Learning Single-cell RNA-seq data analysis from HBCtraining workshop

seurat
scrna

All the learning materials are from credited or adapted from Harvard Chan Bioinformatics Core.

Seurat V5 | Learning Single-cell RNA-seq data analysis from HBCtraining workshop
No matching items

2023

December 8, 2023

Pseudobulk differential expression analysis

r
scrna
pseudobulk

Pseudobulk differential expression analysis is a method used to analyze single-cell RNA-seq data by aggregating counts at the sample level. This approach helps to reduce the…

Pseudobulk differential expression analysis

December 3, 2023

Save ggplot2 plots with custom fonts using Cairo graphics across OS

r
ggplot2
cairo

The Cairo graphics library makes it easy to embed custom fonts in PDFs and create high resolution PNGs (with either AGG or Cairo).

Save ggplot2 plots with custom fonts using Cairo graphics across OS

December 2, 2023

Customization of Seurat plots using ggplot2

seurat
ggplot2

The DimPlot, FeaturePlot, Dotplot, VlnPlot, and DoHeatmap from Seurat can be further customized with ggplot2.

Customization of Seurat plots using ggplot2

December 1, 2023

Use colorblind-friendly palette for visualization

colors
ggplot2

Use ggplot2 to make nice coordinate, colors, and size with friendly colors.

Use colorblind-friendly palette for visualization

November 29, 2023

Visual the usage of CPU and memory with htop

linux

htop is an interactive process viewer and system monitor.

Visual the usage of CPU and memory with htop

November 27, 2023

Practise Seurat for single cell data analysis

seurat

Practise scRNA data analysis with Genome Medicine using Seurat package.

Practise Seurat for single cell data analysis

November 26, 2023

Learning Harmony to integrate single cell RNA-seq data for batch borrection and meta analysis

r
scRNA-seq

Harmony allow integrating data across several variables (for example, by experimental batch and by condition), and significant gain in speed and lower memory requirements for integration of large datasets.

Learning Harmony to integrate single cell RNA-seq data for batch borrection and meta analysis

November 25, 2023

Learning Seruat for scRNA-seq data analysis

r
seurat
scRNA-seq

The package that must to learn for scRNA-seq data analysis.

Learning Seruat for scRNA-seq data analysis

November 13, 2023

Using ggbeeswarm plot to represent categorical data

r
ggbeeswarm

The plot shows all data points with a color-code for each replicate, as well as the averages of each replicate, the total average and the SEM.

Using ggbeeswarm plot to represent categorical data

November 3, 2023

Best Practise for R programming

r

Writing clean, efficient, and maintainable code is crucial for any programming language, and R is no exception. In this blog post, we will discuss best practices for R…

Best Practise for R programming

October 1, 2023

General understanding of scRNA-seq data analysis

scRNA-seq

Typical workflows including:

General understanding of scRNA-seq data analysis

September 11, 2023

General workflow for RNAseq data analysis with R

r
rnaseq

Use lightweight and open-source software with R programming language and the Bioconductor suite of packages to perfrm RNA-seq data analysis.

General workflow for RNAseq data analysis with R

August 11, 2023

Commonly used Vim commands

vim
linux

a list of essential Vim commands that could be used every day

Commonly used Vim commands

August 9, 2023

Combat to remove batch effects in high-throughput experiments

batch effect

Comat models batch effects as multiplicative and additive noise to the biological signal and uses a Bayesian framework to fit linear models that factor such noise out of the readouts.

Combat to remove batch effects in high-throughput experiments

August 8, 2023

Using renv to manage R environment for reproducible coding

r
renv

R works by defaultly by installing packages to a central library and shares them between the projects. It sounds like a good and time-saving feature. After all, you don’t…

Using renv to manage R environment for reproducible coding

August 7, 2023

Install Conda to manage R/Python environments and packages

linux
conda

Sometimes, We need to install R in the Linux server, but we don't the root permission

Install Conda to manage R/Python environments and packages

July 5, 2023

Learning [ropls] for multivariate analysis and feature selection of omics data

r
pca
plsda
supervised

PCA (also called eigenvector analysis) is unsupervised pattern recognition technique mostly utilized as data reduction and modelling technique. It determines the degree or…

Learning [ropls] for multivariate analysis and feature selection of omics data

July 4, 2023

Analyze Omics data using [structToolbox]

r

The MTBLS79 dataset represents a systematic evaluation of the reproducibility of a multi-batch direct-infusion mass spectrometry (DIMS)-based metabolomics study of cardiac…

Analyze Omics data using [structToolbox]

June 8, 2023

Regular expression with R

r
regex

Regular expressions are also called regex or regexp. A regex is a text string that defines a search pattern. Regex can be used to manipulate and extract information from…

Regular expression with R

May 28, 2023

Tips for using shapes for ggplot2

r
ggplot2
shapes

Change ggplot point shape values. Use special point shapes, including pch 21 and pch 24. The interesting feature of these point symbols is that you can change their background fill color and, their border line type and color

Tips for using shapes for ggplot2

May 28, 2023

PCA, PLS-DA and OPLS-DA analysis using [ropls]

plsda
supervised

May 27, 2023

Learning PCA, tSNE and UMAP from simple example

r
pca
tsne
umap
unsupervised
dimensional reduction

PCA, tSNE, and UMAP are the most commonly used l dimensionality reduction techniques visualizing high-dimensional datasets.

Learning PCA, tSNE and UMAP from simple example

May 18, 2023

PCA Graph Customization

r
pca
unsupervised
dimensional reduction

Arguments to customize the PCA graph of variables and individuals.

PCA Graph Customization

May 17, 2023

Perform Principal Component Analysis

r
pca
unsupervised
dimensional reduction

Principle component methods are used to summarize and viusalize the information contained in a large multivariate datasets.

Perform Principal Component Analysis

May 3, 2023

Make heatmap using ComplexHeatmap

r
complexheatmap
unsupervised

Heatmap (or heat map) is way to visualize hierarchical clustering. It’s also called a false colored image, where data values are transformed to color scale.

Make heatmap using ComplexHeatmap

April 10, 2023

Using Tmux and Screen for Persistent Terminal in VSCode Remote Session

linux
tmux
screen

The solution is to set the default terminal provider on the remote settings to be tmux, and have it attach to either an existing session named main, or create a new one if it doesn't exist.

Using Tmux and Screen for Persistent Terminal in VSCode Remote Session

April 5, 2023

The best way to perform feature scaling using R

r

Data normalization methods are used to make variables, measured in different scales, have comparable values. This preprocessing steps is important for clustering and heatmap visualization, principal component analysis and other machine learning algorithms based on distance measures.

The best way to perform feature scaling using R

March 31, 2023

Add p-value and significant level at facet boxplot

r
p-value
ggplot2

How to compute and add p-values to basic ggplots using the rstatix and the ggpubr R packages.

Add p-value and significant level at facet boxplot

March 30, 2023

Add p-values onto basic barplot or boxplot

r
ggplot2
p-value

How to compute and add p-values to basic ggplots using the rstatix and the ggpubr R packages.

Add p-values onto basic barplot or boxplot

March 11, 2023

Barplot with negative and positive value

r
barplot

Coloring Negative and Positive Bars Differently using ggplot2

Barplot with negative and positive value

March 8, 2023

Ridgeline plots in ggplot2

r
ggplot2

Visualizing changes in distributions over time or space nicely usning ggrigges.

Ridgeline plots in ggplot2

March 6, 2023

Equalizing Bar Widths

r
ggplot2

Make the widths of bars to be same when the level of subgroups are not equal

Equalizing Bar Widths

March 6, 2023

ggplot2 with p-value and significant level

r
p-value
ggplot2

A sample example to add p-value and significant level to barpot.

ggplot2 with p-value and significant level

March 5, 2023

Scatter plot with ggplot2

r
ggplot2

Make a nice scatter plot

Scatter plot with ggplot2
No matching items

    2022

    December 24, 2022

    Setup SSH to work in remote server

    linux
    ssh

    The following setup will help to ogin to server without using password and IP address with SSH remote key

    Setup SSH to work in remote server

    December 23, 2022

    VSCode Keyboard Shortcut Cheat Sheet

    vscode

    The most useful VSCode shotcuts that can boost my productivity!

    VSCode Keyboard Shortcut Cheat Sheet

    December 20, 2022

    Using R in VSCode

    r
    vscode

    The details refer to: https://github.com/REditorSupport/vscode-R

    Using R in VSCode

    December 19, 2022

    Learn Linux basic for computing

    linux

    After working at Bioinformatics Institute for 3 years, I gradullly relizaed that it’s essential to learn Linux as:

    Learn Linux basic for computing

    December 18, 2022

    ggplot2 Theme Elements

    ggplot2

    Modify components of a theme: https://ggplot2.tidyverse.org/reference/theme

    ggplot2 Theme Elements

    October 1, 2022

    Nomenclature for the description of mutations and variations

    mutation

    DNA:

    Nomenclature for the description of mutations and variations

    August 1, 2022

    View data from 96/384 multi-well plates

    r
    plate

    plater makes it easy to work with data from experiments performed in plates.

    View data from 96/384 multi-well plates

    May 2, 2022

    Make scatter plot with truncated axis

    r
    ggplot2

    Make scatter plot more beautiful with truncated axis

    Make scatter plot with truncated axis

    February 1, 2022

    Add errorbar and p-value on barplot with ggsignif

    Creating informative and visually appealing barplots is essential for data analysis and presentation. In this blog post, we will demonstrate how to add error bars and…

    Add errorbar and p-value on barplot with ggsignif

    January 22, 2022

    Use colorblind-friendly palette for visualization

    colors

    Use friendly colors in a graph with ggplot2

    Use colorblind-friendly palette for visualization
    No matching items

    2021

    June 1, 2021

    Using greek unicode in Inkscape

    inkscape

    To get Greek letters in Inkscape, go into text mode and type Ctrl+U and the 4-digit unicode for the desired Greek letter.

    Using greek unicode in Inkscape

    March 16, 2021

    Crop image and add scale bar with ImageJ/Fiji

    imagej

    Nikon (20x object):

    Crop image and add scale bar with ImageJ/Fiji

    February 1, 2021

    Punctuation marks words

    punctuation

    I don't know why i can not remember this English punctuation marks

    Punctuation marks words

    January 2, 2021

    Markdown input greek letters

    markdown

    Commonly used greek letters when using markdown

    Markdown input greek letters
    No matching items
     

    2021-2024 Guorui Zhong ~ Made with and Quarto