Abstract

Supervised and unsupervised methods have emerged to address the complexity of single cell data analysis in the context of large pools of independent studies. Here, we present ClusterFoldSimilarity (CFS), a novel statistical method design to quantify the similarity between cell groups across any number of independent datasets, without the need for data correction or integration. By bypassing these processes, CFS avoids the introduction of artifacts and loss of information, offering a simple, efficient, and scalable solution. This method match groups of cells that exhibit conserved phenotypes across datasets, including different tissues and species, and in a multimodal scenario, including single-cell RNA-Seq, ATAC-Seq, single-cell proteomics, or, more broadly, data exhibiting differential abundance effects among groups of cells. Additionally, CFS performs feature selection, obtaining cross-dataset markers of the similar phenotypes observed, providing an inherent interpretability of relationships between cell populations. To showcase the effectiveness of our methodology, we generated single-nuclei RNA-Seq data from the motor cortex and spinal cord of adult mice. By using CFS, we identified three distinct sub-populations of astrocytes conserved on both tissues. CFS includes various visualization methods for the interpretation of the similarity scores and similar cell populations.

Introduction

Single-cell sequencing is a technology that captures the biomolecular status at cell resolution and measures multiple cellular markers in hundreds to millions of cells. Researchers can elucidate the genomic, epigenomic, and transcriptomic heterogeneity and variability in cellular populations and subpopulations [1].

Cell classification and labeling based on phenotypic characteristics is one of the key features of single-cell analysis, they are achieved by computationally grouping cells based on common gene expression patterns, leading to a compendium of known specific markers from previously discovered cell types, cell status (e.g. cell cycle markers), and developmental stages [2]. Cell labeling in groups is a crucial task for determining the composition and heterogeneity that helps to understand tissue composition, microenvironment function, disease, and cell fate. The available number of large-scale single-cell datasets generated using a wide range of technologies is continuously increasing with the advent of public databases [3, 4]. However, wide data integration remains difficult, because of the inherent batch-specific systematic variations and high heterogeneity of single-cell data and because of data privacy regulations to aggregate human raw data. Bioinformatic removal of batch effects can lead to the loss of biological signals owing to a general assumption of identical biological conditions [5]. Several specific tools for integrative analysis exist [6, 7]; the main challenge for combining disjoint measurements (known as diagonal integration), for both mono-omics and multi-omic data, surfaces from the distinct feature spaces.

Because of this, a general approach consists in the transformation of the input data to a shared feature space, to achieve it we can roughly classify existing methodologies in three distinct groups: label transfer, joint dimensionality reduction, and late integration. However, each approach has its own advantages and limitations, without a clearly superior method [6, 8–10]. For example, early integration using joint dimensionality reduction and late integration are better at overcoming highly heterogeneous noise, but early integration is more impacted by drop-out events, since information is locally shared on the embedding space from nearby-cells, introducing additional biases due to this sparsity [11], additionally dimensionality reduction methods are known to be prone to large information loss [12]. On the other hand, late integration can impact the power of downstream analysis (e.g. clustering), since data size is locally limited on the first steps of the analysis. Methodologically, more recent machine learning and neuronal network-based methods often lack causal modeling making the interpretation of the output difficult [10, 13].

These challenges are particularly relevant for obscured cellular populations, which are often underrepresented or highly specialized subcellular groups where robust markers have not been defined [14]. In all these cases, the inclusion of additional data and integration can improve the characterization of understudied cell groups; however, recently proposed approaches and benchmarks show moderate accuracy in cell type labeling tasks on ground-truth datasets [15, 16]. Overall, integrative methods exhibit considerable performance variability and are highly susceptible to dataset peculiarities [17]. These issues have led to increasing attention and growing concerns regarding reproducibility between single-cell studies [18–21].

Here, we present ClusterFoldSimilarity (CFS), a new methodology that effectively analyzes the similarity between groups of cells from any number of different and heterogeneous datasets without the need for batch-effect removal or integration. Our method is based on the differences in abundance of the sequenced signal between cell groups, using a Bayesian inference approach and permutation analysis to obtain the FCs and computation of similarity values based on the vector space of these differences in abundance. The underlying assumption is that the overall signal expression changes across different cell populations, subpopulations, or phenotypes in each individual dataset should be conserved in external studies with similar populations when using the same frame of reference as a comparison.

We show that our method is highly versatile and accurate and can be used to label single cell-data using reference datasets, including labeling cell types in scATAC-Seq data using scRNA-Seq or scATAC-Seq reference datasets as ground truth, with potential multimodal data analysis applications. Furthermore, we show how it can be used to compare groups of cells from different tissues and different organisms in cross-species studies, and to infer, to some extent, cell mixtures in heterogeneous clusters. Because our computational similarity method can handle any number of independent datasets, it will enable the analysis of large existing collections of single-cell studies, and it will contribute to solve the modern community efforts on building wide-scale single-cell atlases across tissues, organs, and organisms [22–24]

Finally, we exemplify how our methodology can be used to study small cell subpopulations across tissues by sequencing single-nucleus RNA-Seq from the spinal cord and motor cortex of adult mice and analyzing astrocytes as a disease-relevant glial cell subpopulation.

Materials and methods

A typical single-cell data analysis workflow entails a series of essential steps. These steps commonly include filtering out low-quality cells and non-contributing features, normalizing and scaling the data, performing dimensionality reduction, and clustering or labeling cells based on groups defined by variability and phenotypic characteristics of interest.

Our method is designed to handle untransformed values (raw counts or peaks) and the specific groups of interest that need to be compared (e.g. clusters, cell types, cell states) in each independent dataset.

The features utilized for comparison can embody genes, transcripts, peaks, or other. Our workflow makes use of the set of features that are shared across all datasets. It is advisable to select features that exhibit some degree of variability or serve as markers of interest for our cell populations, albeit in some cases, it might be desirable to include all available features when the phenotypic characteristics are unknown, or the main interest is that of marker selection.

Fold change distribution and pairwise computation

Fold change (FC) can be formulated as the disparity in abundance between two sample sets or groups of samples/cells, and it is one of the most ubiquitous and intuitive metrics for evaluating hypotheses in quantitative experiments. Typically, we have a set of two samples representing a specific feature abundance, these can be seen as Poisson distributed random variables with mean μ, FC is then formulated as the logarithmic ratio of the means of observed quantities such as mRNA fragments or protein levels, and statistical testing involves assessing the Null hypothesis that the measured entity exhibits no significant change in abundance under different conditions. Various statistical methods have been used and developed to calculate a P value associated with this measure of differential expression. However, caution must be exercised when interpreting measurements due to inherent technical biases and stochasticity of biological data. This concern is particularly pertinent when dealing with highly sparse single-cell data, where low or zero abundance observations may yield infinite or extremely high FCs.

To mitigate this problem several approaches have been proposed, being the most widely used the addition of a small positive number p (often set as p= 1) to the count data, known as a pseudocount. With this approach, problems like division by 0, or infinite |${{C}_n}$| values for log-normalization are avoided. But, assigning arbitrary numbers to p has a strong influence on the difference in abundance of low expressing entities: this is because artificially inflating the counts make disproportionate increase in low expressed features (for a feature with 1 count, adding a p= 1 corresponds to a 100% increment, meanwhile a feature with expression 1000, a p= 1 yields an increment in size of just a 0.1%). This has been demonstrated as problematic, both for differential expression and downstream analysis [25–28].

Here we extend the methodology devised by Erhard and Zimmer [28, 29] which employs an empirical Bayes procedure to estimate pseudocounts and FCs. We have made certain modifications to this approach (see details). We selected a FC estimation procedure for several reasons: our similarity score is based on cumulative changes in abundances from a frame of reference (i.e. specific cluster or cell population), rather than the statistical significance of those changes. Consequently, we bypass the computation of statistical scores or P values. Furthermore, considering the large number of pairwise tests required to assess differential abundance and compute our similarity score, utilizing regression models to estimate size effects would incur in excessive computational time.

To calculate the pseudocounts for each group, we estimate the prior distribution based in the observed FCs without pseudocounts by calculating:

(1)

where |${{C}_n}$| and |${{C}_m}$| are, respectively, the mean of feature i expression in groups n and m. Consequently, we compute the mean |$\mu$| and variance |${{\sigma }^2}$| of the prior as:

(2)
(3)

These quantiles correspond to one standard deviation for a Normal distribution. Importantly, to construct this prior distribution, we only use informative features, i.e. entries with non-zero values in both groups. Additionally, we impose a minimum of three features for calculating the prior, as opposed in the original [28] where 0 values are allowed on one group and no minimum number of informative features is required. If there are not sufficient values, we compute the FCs adding a pseudocount p (equation 4) to |${{C}_n}$| and |${{C}_m}$| for each gene, based on the hyperbolic arcsine (asinh) function with no log transformation, and we compute the variance using the standard formula. The asinh function has been shown to have desirable properties as pseudocount estimator [27, 30], as it avoids preselecting an arbitrary constant, and yields a proportional pseudocount for each individual gene.

(4)

Finally, we select the mean instead of the median as the |$\mu$| prior to reflect more extreme values in low abundance observations. In summary, we believe these changes are relevant when dealing with single-cell data, especially in the case of ATAC-Seq, single-nuclei RNA-Seq, and single-cell proteomics. As mentioned, |${{C}_n}$| and |${{C}_m}$| are expected to follow a Poisson distribution, being the conjugated prior of this distribution the gamma distribution. Following previous statistical frameworks [28], the expected mean and variance of the log distribution can be formulated as:

(5)
(6)

And thus, pseudocounts |$\alpha$| and |$\beta$| can be computed by minimizing the function:

(7)

Where |$\psi$| and |${{\psi }_1}$| are the digamma and trigamma functions, respectively. Finally, the FC distribution can be estimated using the new pseudocounts |$\alpha$| and |$\beta$| for each feature as:

(8)

We apply the median to zero procedure [31] as a normalization factor over the new distribution of FCs. This estimated FC is computed between cells in cluster/group i and cells in cluster/group j |$\forall j\neq i$|⁠. In such manner, we obtain k-1 FCs (k: number of clusters/groups in the dataset) for each feature (e.g. a dataset with 10 clusters/groups will yield 9 FC values for each feature on each of the 10 clusters/groups). By doing this, we obtain a unique frame of reference for each cell group that encompass all the abundance differences from the perspective of each individual cell group, this information can be later compared with another external differential abundance reference, in our case, a cluster or group of cells coming from an independent dataset.

Cell subsampling and FC stabilization

As highlighted in preceding sections, a primary obstacle in calculating differential abundance arises from the occurrence of low to zero values, which can result in infinite or excessively high FCs that do not accurately represent genuine biological effects. To mitigate this, we employ a permutation-based methodology to estimate the null distribution of the differences in abundance. Here, we randomly subsample 1/3 of the cells from each group “n” times and then estimate the FCs utilizing the Bayesian approach (including the pseudocount estimation) described in the previous section:

(9)

By subsampling 1/3 of the cells in each draw, the average number of permutations needed to observe all n cells in a group is:

(10)

Which yields on average feasible computational times. As a reference, it is needed an average of 16 permutations to observe all cells in a group of 100 cells (Supplementary Fig. S1C).

Overall, we show (Supplementary Fig. S1A and D) that subsampling cells and estimating n times the FC posterior distribution using a Bayesian procedure shrinks the mean of estimated FCs -coming from low count data and with no real and significant difference in abundance towards zero, meanwhile maintaining the FC distribution for significant values (Supplementary Fig. S1B and E). This is expected for a normal random distribution with mean |$\mu = 0$|⁠. By contrast, features with available expression data and true FC maintain the same effect size throughout the n permutations.

Similarity score

We can think of FCs as unit vectors, being the magnitude equal to the FC value and direction equal to the sign of the expression change, the element-wise product of the magnitudes of these two vectors gives as a result a perpendicular vector computed as:

(11)

Following this approach, the direction of this perpendicular vector will act as a concordance metric of the direction of the FCs (perpendicular vectors with negative component will indicate non-concordance in the differences in abundance of two frames of reference: the FCs have opposite directions). The FCs are computed using the method described in the previous section, and it is calculated pairwise between each cluster i and all the rest of the clusters j belonging to the same dataset.

Once all frames of reference are computed (all the possible combinations of FCs between all clusters/groups from each independent dataset), we start by comparing the cluster 1 from dataset n with the cluster 1 in dataset m and continue iteratively. We achieve this comparison by computing, for each feature, the Hadamard product of all pair-wise combinations (equation 11). We denominate |${{S}_i}$| these collections of products for each specific feature i and every combination of FCs for the two clusters being compared|$,{\rm{\ }}$|being the number of possible combinations |$k$|⁠:

(12)

Being |${{k}_i}$|⁠: the number of groups in dataset i. Then we calculate for each feature the mean of these k perpendicular unit vectors, that we denominate SC (mean of feature-wise products from equation 11).

(13)

The assumption that we build upon is that two groups (e.g. clusters) resembling the same cell population will have distinct markers (either positive or negative), and thus FC for this marker must show similar size effects across independent datasets yielding a positive SC. This SC value will additionally serve as a measure of feature importance, being the feature with the highest positive value the one that contributes the most to the similarity between the two clusters (negative values of the pair-wise products indicate opposite FC values, and thus, dissimilarities between the changes in expression of the cell groups being compared). As these scores are built from differences in abundance, these selected contributing features can be seen as expression markers for both cell groups tied together by the similarity score.

An additional weight |$\omega$| is added based on the concordance of the number of positive vs negative SC values (only values with absolute SC > 0.2 are considered), this assures to give more weight or penalize the similarity values considering the concordance of the direction of expression changes across datasets, especially for low FCs (a set of small negative SCs may add a small quantity to the overall similarity, but if the number of negative SCs is much larger than positive SCs this will indicate and overall tendency of non-concordant changes in abundances). Weight |$\omega$| is calculated as:

(14)

Finally, the similarity value for a pair of clusters is calculated as the square root of the sum (absolute value) of the SC values from all features, retaining the sign of the sum:

(15)

The highest similarity positive value calculated this way will correspond with the most similar cluster: it is expected that, for a specific population of cells, overall changes in gene expression across different clusters (other cell populations) are conserved on different datasets when using a similar frame of comparison, and thus the sign of the product of FCs should be positive and its module higher than non-concordant groups of cells.

Interpretation of the similarity scores

The similarity scores computed in the previous section have either positive or negative values, indicating correlations in gene expression: it compares a cell population against the remainder of the dataset populations, and computes the similarity between another cell population from an external dataset and their respective local cells. Given the inherent diversity and complexity of single-cell data, as well as variations in methods for grouping cells into populations (e.g. clusters, cell states, experimental conditions, or pre-existing annotations), the interpretation of these scores is highly context-dependent.

A positive similarity score suggests that the same markers are identified in populations derived from different datasets. This outcome may indicate that the populations consist of the same cell type, a similar mixture of cell types, or closely related lineages. It may also reflect shared conditions or cell states. Conversely, a negative score indicates anticorrelated expression changes between two independent populations; for example, a marker that is upregulated in one dataset may be downregulated in another. The interpretation of such negative scores depends, again, on the context. For instance, if a specific cell type is absent or is not expected in one dataset, similarity scores for the former population in the other dataset may be negative or near zero. However, if a closely related cell type exists (e.g. within the same lineage), the score may be positive. Negative values may also highlight differences between the same cell type under varying conditions or states. In all cases, a detailed analysis of the markers is essential to draw meaningful conclusions from the similarity scores, and the computed similarity graph as well as the community analysis can help to understand these complex relationships.

Similarity graph construction and community analysis

A directed graph is built from all the similarity results within the similarity table using the R package for complex network research igraph [32], the similarity table is imported using the function graph_from_data_frame with the option directed = TRUE. Thus, in the igraph network architecture, the nodes represent cluster/groups defined by the user, and edges represent the similarity score. Edges are directed and point in the direction of the similarity score computed from cluster/group A to B meaning how similar is cluster A to cluster B, the weight (length) of edges correspond with the magnitude of the similarity score.

CFS will compute the network using igraph with the n top similarities desired by the user, as an example, if only the top one similarity is obtained with CFS (option TopN = 1), then each cluster n from dataset i (a node on the graph) will have only one outward edge (arrow) directed towards one cluster from dataset i + 1 (another node of the graph). If the top two similarities are specified, each node will have two edges pointing outwards per external dataset. Once the graph has been built, we visualize the network using the function layout_with_gem from igraph, which places vertices on the plane using the GEM force-directed layout algorithm [33].

CFS can also perform a community analysis using the Leiden algorithm on the constructed graph, by using the package function findCommunitiesSimmilarity (which makes use of the igraph function graph_community_leiden), this analysis returns a table with the detected communities, and which clusters/groups correspond to each community, helping to aggregate the similar groups of clusters algorithmically, additionally the communities are depicted in different colors in the graph. The Leiden algorithm consists of three phases: [1] local moving of nodes, [2] refinement of the partition, and [3] aggregation of the network based on the refined partition, using the non-refined partition to create an initial partition for the aggregate network.

Mice motor cortex and spinal cord nuclei isolation and single nuclei RNA sequencing

Wild-type mice (C57BL/6NRj, Janvier Labs) were used in this study. Cortex was dissected from the left-brain hemisphere. Spinal cord was dissected and divided into three pieces. All tissues were flash frozen. For nuclei isolation, 20 μg of upper spinal cord (cervical / thoracic) and motor cortex were used. Samples were lysed in 2 ml of lysis buffer (5 mM CaCl2, 3 mM magnesium acetate, 0.32 M sucrose, 0.1 mM EDTA pH8.0, 10 mM Tris-HCl pH, 1 mM DTT, 0.5% Triton X-100) using a dounce homogenizer. Next, 3.7 ml of sucrose solution (1.8 M sucrose, 3 mM magnesium acetate, 1 mM DTT, 10 mM Tris-HCl pH8.0), and the ultracentrifugation tubes were filled up with the lysis buffer. Ultracentrifugation was performed at 24 400 rpm (107 164 rcf) for 2.5 h at 4°C in a SW28 swing rotor (Beckman Coulter). Supernatant was discarded and the pelleted nuclei were resuspended on ice in 200 μl of DEPC-treated water-based 1X PBS. To get rid of any debris or nuclei aggregates, pre-separation filters of 30-μm pore size were used (Miltenyi Biotec). Nuclei were counted and the suspension was adjusted to 1000 nuclei per microliter. For single-nuclei capture, 5000 nuclei per sample were loaded on the Chromium controller (10x Genomics). All downstream steps were performed as described in the manufacturer's protocol in the Chromium Next GEM Single Cell 3′ Kit v3.1. The libraries were sequenced on a NextSeq 550 System (Illumina) using the NextSeq 500/550 High Output Kit v2.5 (150 Cycles).

Mice motor cortex and spinal cord single-nuclei RNA Seq bioinformatic analysis

Sequencing files from the 6 samples were processed using cellranger software version-6.0.1 and aligned to Genome Mouse Build 38 (mm10). Cells with more than 1.5% of mitochondrial content, library size inferior to 1500 counts, and less than 250 genes detected, were filter out. Downstream analysis was conducted individually using Seurat package on each of the six individual samples (tissue-mouse pairs). Cell type labeling was done using type specific markers from the scientific literature.

Astrocyte population was then subtracted for re-analysis, selecting clusters that showed unambiguous and distinct expression of astrocyte markers. The number of principal components for calculating nearest neighbors was chosen using both JackStraw and elbow methods in a data driven manner for each sample. Re-clustering was done using Louvain algorithm, testing for granularity parameters that yield a coherent and stable number of clusters.

Similarity scores were obtained with CFS statistical approach, using as a grouping variable the cluster id, and using a subsampling number of n = 30. Feature selection of markers by CFS were obtained by specifying topN = 10 (obtain top 10 markers contributing to the similarity for each cluster pair compared). Markers depicted in Fig. 3C were selected as being a similarity contributor in more than one cluster pair contrast.

Differential expression between Astrocyte Groups (AG) was tested using a negative binomial model using the merged expression from all mice and tissues, and including as model covariates the tissue, the sequencing date, and the mouse id.

Cell-cell communication analysis was done using CellChat [34] version 2 [35] with default parameters, this method is based on literature-supported ligand-receptor interactions. Groups interrogated for cell-cell communication were obtained by clustering the neuronal populations using the merged data from all mice and only the motor cortex region, and the communication analysis was done between neuronal clusters and the three astrocyte populations described before.

Trajectory analysis, pseudotime scores, and graph analysis to identify differential expressed genes as a function of pseudotime for AG3 were obtained using Monocle2 [36] by using the raw merged expression of AG3 subpopulations from all mice and tissues and using Monocle2 default parameters. Gene set enrichment analysis was obtained with gprofiler2 R package.

Benchmark of CFS and different integrative methods

Inspired by the approach used by Ghazanfar et al. [16], we adapted extended and performed a benchmark comparison with other integrative and batch correction algorithms: MultiMap; naive PCA with no batch correction, PCA corrected using MNN (mutual nearest neighbors), and PCA corrected using Harmony; Seurat CCA (canonical correlation analysis); StabMap with no batch correction, StabMap corrected using MNN. We design two different scenarios: a scRNA-Seq pancreatic multispecies datasets [37], composed of mouse and human samples (human n = 4, mice n = 2), with different sizes of cell populations (human n = 7561 cells, mice n = 1861 cells), downloaded using R/Bioconductor package scRNAseq. To make this benchmark reproducible we used set.seed(01 022 025). Additionally, and using the pancreas dataset, we computed extra quantitative metrics using the Pearson distance, cosine similarity, and Minkowski distance with p= 1.5, again with set.seed(01 022 025) to make it comparable we the previous benchmark. The second scenario uses an assay of scRNA-seq that aims to study mouse gastrulation across entire embryos on E8.5 timepoint [38], downloaded using the MouseGastrulationData R/Bioconductor package [39], using R function set.seed (29 072 024).

For each scenario, a pair of random samples were selected and processed using Seurat workflow (normalized, scaled, computation of top 2000 HVG, and dimensionality reduction), we then selected one sample as the reference dataset, to be used as ground-truth reference with the original annotation, and assign the other sample as the query dataset, keeping it unannotated and subjected to clustering analysis for the group similarity computation. Within each sampling round, we randomly selected a subgroup from the 2000 variable genes (n = 25, 50, 100, 250, 500, 1000, 1500), doing this random sampling 4 times for each n gene subgroup (producing four observations of n genes between the same query and reference datasets). For StabMap, we followed the instructions depicted on the manual and benchmarking approach on the original paper, to compute the reference and query joint embedding into a common space, and using similar approaches with naive PCA, UINMF, and MultiMAP.

To compute the accuracy at cell type label inference using CFS, clusters from the query dataset were labeled as the top-similar class group from the reference dataset, assuming that the entire cluster cell composition to be that cell type. Then accuracy was computed as assessing the number of cells from that cluster having the real annotation matching the assigned annotation. To assess the accuracy of the other integrative methods, we followed the approach by Ghazanfar et al., computing the mean accuracy of cell type annotation from the query sample cells using k-nearest neighbors with k = 5.

Data processing

Human and mouse single cell RNA-Seq from pancreas

Annotated data from both studies were downloaded using the R Bioconductor package scRNAseq.

Downstream analysis was conducted using Seurat package on each of the datasets. The number of principal components for calculating nearest neighbors was chosen using both JackStraw (n = 15). Clustering was done using Louvain algorithm. CFS was run using a subsampling of n = 28. Barplots and exploratory analysis of the cell composition of clusters was done using LotOfCells R package [40]. To analyze the correlation between similarity scores and cell type mixture composition of clusters, simulated single cell count data was produced using scDesign2 [41] selecting the Gaussian copula method to compute the model. The same number of cell per cell type were produced to account for population size (n = 1200 cells per cell type).

RA and OR single-cell RNA-seq data, bulk RNA-seq data, and mass cytometry data

Normalized and filtered data was downloaded from (https://www.immport.org/shared/study/SDY998. Expression was scaled, T-cell subpopulation was extracted from the main dataset, re-analyzed, and re-clustered using Louvain algorithm (“FindNeighbors(reduction = “pca,” dims = 1:25),” “FindClusters(resolution = 1)”). The same approach was followed for Cytof data with clustering resolution of 0.8.

PBMCs ATAC-Seq and single cell RNA-Seq

We obtained two public single-cell datasets of human PBMCs. First, an unannotated scATAC-seq of human PBMCs were downloaded from the 10x Genomics website. In addition, a fully processed and high-quality annotated scRNA and ADT dataset was downloaded from https://atlas.fredhutch.org/nygc/multimodal-pbmc (Hao et al., 2021, PMID: 34 062 119) and used without further modifications. For the 10x Genomics dataset, the filtered peak-barcode matrices were loaded into R (v.4.0.0) using the Seurat (v.4.0.1)/Signac (v.1.4.0) functions “Read10X_h5” and “CreateChromatinAssay(min.cells = 10, min.features = 200. Barcodes from the unimodal dataset were filtered for a number of cut sites between 5000 and 50 000 and a transcription start site score > 3.5. Gene activity scores were calculated using the function “GeneActivity” and log-normalized using as scaling factor the median of the gene activity matrix. Subsequently dimensionality reduction was applied based on the peak matrix using top 2000 variable, and cells were clustered using the first 20 PCA dimensions, with a resolution of 0.8. For the final cell type annotation, clusters were annotated based on marker gene expression. CFS was run based on the gene activity matrix (10x Genomics dataset) or the RNA count matrix (ADT dataset) using all common features and fine cell type labels as cell identities, with a subsampling of n = 30.

Statistical significance

Throughout this study, we considered a P-value threshold for statistical significance of 0.005, as it has been shown to foster reproducibility and lower the false-positive rate [42, 43]. Therefore, any claims of significance on this paper should be noted as passing the threshold α = 0.005.

Compatibility

CFS is compatible with the most popular single-cell pipelines for an easy downstream integration: Seurat [44] and SingleCellExperiment [45].

Ethics approval

All animal experiments were performed in accordance with institutional guidelines of the University of Heidelberg and were approved by the local authority (Regierungspräsidium Karlsruhe, Germany).

Results

CFS Overview

CFS computes scores for each pair of cell groups based on differences in abundance, these values are centered around 0 (negative scores mean dissimilarity, while positive values are similar phenotypical states based on abundance differences). A summary of the workflow for computing the similarity metric is shown in Fig. 1. The tool expects two or more single-cell datasets, each with their raw feature count matrix, and defined groups of interest at the cell level. The identity of these groups can be a phenotypic characteristic (e.g. cell type, cell cycle, or time series) or an algorithmically obtained label (e.g. clustering techniques). In the first step, differences in abundance from raw expression between the groups in each dataset are estimated using a Bayesian approach. These FCs are normalized and used to compute a similarity metric between groups from independent single-cell assays. Additionally, the contribution of each feature to the similarity score is used to understand its importance as a marker of these specific groups of cells, acting as a feature importance discovery tool. To understand the complex interaction between the groups and their similarities, CFS builds a directed graph using the igraph R package framework [32], in which edges represent the direction (arrow) and intensity (length) of similarities from cluster source to cluster target. An additional community algorithm can be applied to find communities of clusters from the similarity graph, helping to identify the most similar cell communities.

Diagram of CFS for the comparison of two independent datasets. The datasets are depicted by dimensionality reduction (PCA, UMAP, t-SNE, VAE, PATHE, or others) for visualization purposes only.
Figure 1.

Diagram of CFS for the comparison of two independent datasets. The datasets are depicted by dimensionality reduction (PCA, UMAP, t-SNE, VAE, PATHE, or others) for visualization purposes only.

Comparison with popular integrative methods

CFS can process a total of 750k cells, divided into three datasets with 20 clusters each (k = 6819 combinations) in three minutes using seven cores (Fig. 2A). Additionally, we tested how CFS is able to scale with larger data sizes, for this purpose, we measure the processing time of datasets composed of 15–750k cells, again divided into three datasets with 20 clusters each (k = 6819 combinations), and a fixed number of 17 CPUs, we demonstrate that the increase in processing time with size is almost linear (Fig. 2B). To assess the performance of CFS against other popular methods, we first selected two public annotated datasets and computed the accuracy of predicting the cell type by cluster similarities. The first scenario is composed of two scRNA-Seq pancreatic tissue datasets, from mouse and human samples [37]. The second scenario uses an assay of scRNA-seq that aims to study mouse gastrulation across entire embryos on E8.5 time point [38]. These datasets were used as ground-truth reference and unlabeled query iteratively, with cell groups defined based on their known cell-type annotation by the original authors. For the pancreatic scRNA-Seq, apart from the organism and sample batch effect (human samples n = 4, mice individuals n = 2), these datasets have a large difference in the number of available cells (human dataset n = 7561 cells, mice dataset n = 1861 cells), which allowed us to benchmark the sample size impact on the performance (Supplementary Fig. S2A), and show that on average CFS is not significantly impacted by the varying size of the datasets. We performed an extensive benchmark comparison with other integrative and batch correction algorithms: MultiMap; naive PCA with no batch correction, PCA corrected using MNN (mutual nearest neighbors), and PCA corrected using Harmony; Seurat CCA (canonical correlation analysis); StabMap with no batch correction, StabMap corrected using MNN. We iterated across all datasets, using each as the reference and the query, and with varying number of available features (n = 25, 50, 100, 250, 500, 1000, 1500) following a similar approach as depicted by Ghazanfar et al. [16]. In our case, for each reference-query pair we select from the top 2000 high variable features n random genes more than once (producing several predictions for the same reference-query n features pair), to assess the accuracy for different sets of genes. Results show high accuracy of CFS at cell type mapping task, especially when low number of shared features are available (Fig. 2C and D), case in which CFS has a better performance, highlighting that it can be applied in scenarios where the number common shared features is low, like multi-organism or multi-modal (e.g. single-cell proteomics with extremely small number of surface markers screened).

(A) Benchmark of computing times of CFS using different numbers of CPUs. The artificial dataset is composed of 750k cells, divided into three datasets with 20 clusters each (k = 6819 combinations). (B) Benchmark of computing times of CFS using different dataset sizes using a fixed number of 17 CPUs. The artificial datasets are composed from 15k to 750k cells, divided into three datasets with 20 clusters each (k = 6819 combinations). (C) Barplot displaying mean cell type classification accuracy results of the Benchmark comparison against other integrative methods using two pancreatic scRNA-Seq datasets, each gene subset includes several permutations per gene sampling. Error bars represent the standard error of the mean. (D) Barplot showing mean accuracy results of cell type classification benchmark comparison against integrative methods using a mice gastrulation scRNA-Seq datasets (n = 4 mouse) on E8. Error bars represent the SEM. (E) Directed graph of clusters by top similarity; each node corresponds to a cluster/cell type group from one dataset (human and mice). Length of edges corresponds with the magnitude of the similarity and arrows depict the direction of the similarity test. (F) Proportion of cell types per cluster using the authors annotation (Muraro et al.) from human pancreatic single cell dataset used as an unannotated target (human.NA). (G) Heatmap showing all computed similarity scores (all possible combinations of groups) between the datasets.
Figure 2.

(A) Benchmark of computing times of CFS using different numbers of CPUs. The artificial dataset is composed of 750k cells, divided into three datasets with 20 clusters each (k = 6819 combinations). (B) Benchmark of computing times of CFS using different dataset sizes using a fixed number of 17 CPUs. The artificial datasets are composed from 15k to 750k cells, divided into three datasets with 20 clusters each (k = 6819 combinations). (C) Barplot displaying mean cell type classification accuracy results of the Benchmark comparison against other integrative methods using two pancreatic scRNA-Seq datasets, each gene subset includes several permutations per gene sampling. Error bars represent the standard error of the mean. (D) Barplot showing mean accuracy results of cell type classification benchmark comparison against integrative methods using a mice gastrulation scRNA-Seq datasets (n = 4 mouse) on E8. Error bars represent the SEM. (E) Directed graph of clusters by top similarity; each node corresponds to a cluster/cell type group from one dataset (human and mice). Length of edges corresponds with the magnitude of the similarity and arrows depict the direction of the similarity test. (F) Proportion of cell types per cluster using the authors annotation (Muraro et al.) from human pancreatic single cell dataset used as an unannotated target (human.NA). (G) Heatmap showing all computed similarity scores (all possible combinations of groups) between the datasets.

In general, results suggest that the performance and accuracy of integrative single-cell methods are dataset-dependent, as an example StabMap showed a varying performance, being one of the topmost accurate in the gastrulation dataset (Fig. 2D), but one of the worst performing in the pancreatic multi-species dataset (Fig 2C). This again highlights that a careful consideration of the selected method should be done for each independent single-cell data analysis, and many factors must be considered beforehand, like the number of features available, size of the datasets, degree of tissue/organism/technical batch effects, and others.

Finally, and to add extra quantitative metrics with more closely related similarity metrics, we performed a benchmark comparing CFS to the Pearson distance, cosine similarity, and Minkowski distance with p= 1.5 (a generalization in between the Manhattan distance and the Euclidean distance), computing these metrics using the count matrix from the pancreas dataset. We choose again this dataset both because it will let us compare these metrics with the already tested methods, and because its low-complexity with mild batch effect. Results clearly indicate the superiority of our CFS metric (Supplementary Fig. S2B), with the other distance scores having an empirical upper limit on this scenario of around 75% accuracy at matching clusters and cell types.

CFS effectively compares groups of mice and human cells

We used one mouse and two publicly available human single-cell RNA-Seq datasets from pancreatic tissue, each with annotated cell-type labels, to evaluate the accuracy of the similarity metric. The first human dataset [46] was subjected to unsupervised clustering to interrogate the cell-type composition, retaining the annotated cell types for later comparison. The other two datasets, from mouse and human pancreatic samples [37], were used as ground-truth references, with cell groups defined based on their known cell-type annotation by the original authors.

To assess the pair matches between the clusters in the unannotated human dataset and the cell type groups in the remaining studies, we computed and selected the top similarity scores for each of the 11 unannotated clusters (Supplementary Table S1). This approach allowed us to confidently establish matches between clusters and annotated cell type groups (Fig. 2EG). The results show that 10 out of 11 clusters exhibited perfect matches to the known annotations of the clusters from the original publication and both reference datasets.

Notably, the only exception (cluster 3), corresponding to acinar cells, displayed the highest similarity with the acinar cell group from the second human dataset and the ductal cell group from the mouse dataset. This could be expected, as acinar cells were absent in the annotation of the utilized mouse dataset. Notably, our similarity metric successfully indicated the closest related cell type by lineage: ductal cells. Furthermore, we observed a consistent association for cluster 11, which represents mesenchymal cells (a cell type that is not present in both reference datasets), with stellate cells, which were missing in the clustered human dataset, but present in both mouse and second human reference datasets. This association has been previously demonstrated in the literature [47].

Our results demonstrated the capability of our algorithmic approach to successfully match comparable phenotypic cell groups, even when working with different organisms. Notably, using more than one dataset as a reference helped to clear and define the broad relationships between cell populations (Fig. 2E); we believe that ClusterFoldSimilarity will benefit for the numerous public cell atlases available. However, it is important to acknowledge the potential limitation of our metric, which operates at the cell group level rather than at the individual cell level, which may lead to some loss of resolution in the annotation of heterogeneous clusters. However, we believe that this issue can be mitigated to some extent by increasing the granularity in the clustering analysis or by using existing meta-cell analysis algorithms that capture small cell groups with the same technical variability and thus maximize data resolution [48–50].

Correlation between cell mixture proportion and similarity score

To investigate the effect of different cell mixtures within clusters on our similarity metric, we generated an artificial single-cell RNA-Seq dataset using the scDesign2 algorithm [41]. The data were constructed based on a human pancreatic dataset [37] with known cell type labels. We adjusted the artificially recreated count matrix to ensure an identical number of cells per cell type (n = 1200), thereby minimizing the cluster size effect and fostering the signal of small-cell populations (Supplementary Fig. S2C).

Using CFS, we computed the similarity scores between clusters from the original human pancreatic dataset, which included clusters with cell type mixtures, and the artificially recreated and cell type balanced dataset. Interestingly, the similarity scores demonstrated the ability to effectively capture cell mixture proportions at some extent (Supplementary Fig. S2E). For example, in the original dataset, Cluster 10 comprised up to nine different cell types, with marginal cell types not typically found in the pancreas. The similarity scores mirrored the cell type proportions in descending order: endothelial cells, macrophages, mast cells, Schwann cells, and T-cells (Supplementary Fig. S2E). Only stellate cells exhibited a higher similarity value than anticipated, although they were still lower than those of the top two most abundant cell types. Similar trends were observed in Cluster 4 of the original dataset, composed of five different cell types. The similarity values again correlated with the percentage of cells from each cell type in the following descending order: activated stellate cells, quiescent stellate cells, endothelial cells, acinar cells, and Schwann cells (Supplementary Fig. S2D–F).

Overall, our results demonstrate how CFS is able to capture -at some extent- the complex mixture of cell populations, although we do not believe that it will be suitable for deconvolutional single-cell task, we think it is an important point to take into consideration when analyzing and interpreting CFS results, and we believe similarity values exhibit great potential for downstream analysis, and can be integrated in combination with additional bioinformatics methods.

Expanding to multimodal assays: single-cell proteomics, sorted bulk RNA-Seq and single-cell RNA-Seq

To test whether cell populations from additional multimodalities can be linked using our technique, we analyzed 51 samples of synovial tissue biopsies from rheumatoid arthritis (RA) and osteoarthritis (OA) from sorted B cells, T cells, monocytes, and stromal fibroblast populations [51]. The multimodal study included sorted bulk RNA-seq from all patients (n = 54 patients), single-cell RNA expression (n = 21), and single-cell protein expression from a 34-marker mass cytometry panel (Cytof, n = 26).

We processed the three datasets independently, obtaining 13 clusters for the single cell RNA-Seq assay to be used as targets of the annotation by similarity, and used the cell type annotations from the original authors as ground truth labels for both bulk RNA-Seq and Cytof. Annotations for the computed single cell RNA-Seq clusters were retrieved and compared with the unannotated cluster for later comparison (fibroblast clusters 0, 4, 6; T cell clusters 1, 5, 8, 9, 12; B cells clusters: 2, 7, 11; monocyte clusters: 3, 10). The data processing differs considerably from the original study, as an integration strategy is used by the authors, which might negatively impact the clustering analysis especially in the case of cell subtypes.

The similarity metric was computed using 33 common features across all datasets (proteins in the case of mass spectrometry data and genes coding for those proteins in the case of RNA-Seq assays). For all the cell type classes present in the assays (B cells, T cells, monocytes, and fibroblasts) clusters of cells with the same pre-annotation were unambiguously mapped together using our similarity metric (Supplementary Table S1) for all three data modalities, including the unannotated clusters (Supplementary Fig. S3A and B). Only the small cluster CD4 + HLA-DR + from the Cytof data, composed of T cells, was linked per top similarity to cluster 3 from single cell RNA-Seq, composed of monocytes. Although the same cluster 3 (monocytes) from single cell RNA-Seq assay showed as its top similarity the Cytof cell group CD11c + CD38 − CD64+ (Supplementary Fig. S3A), which is composed solely of monocytes. This shows that using more than two datasets can improve the similarity matching and thus the understanding of complex interactions between groups. Notably, even with an extremely small number of common features available (n = 33), our approach demonstrates to be robust and accurate, showing again the flexibility and adaptability of the methodology.

Similarity matches population across single-cell RNA-seq and ATAC-seq data

We applied our novel methodology to multimodal single-cell data comprising RNA-seq and ATAC-seq from two PBMC datasets. As a reference, we used a high-quality CITE-seq atlas of the circulating human immune system, comprising 160k cells with 26 annotated cell types [44]. Additionally, we processed one non-annotated public 10x ATAC-Seq dataset, obtaining 18 clusters that were manually labeled by cell type using canonical markers, including fine annotations for specialized subtypes, with a total of 15 different phenotype characterizations. We then computed the similarity metric from the ATAC-Seq clusters against the reference ground-truth CITE-seq annotated data. For ATAC-Seq, the gene activity matrix was computed from peak calling using Signac, easing the mapping between features from different modalities and datasets.

Overall, similarity scores were able to link clusters from ATAC-Seq data to reference cell populations in RNA-Seq data with identical phenotypes (Supplementary Table S1), including small populations such as plasmacytoid Dendritic Cells and myeloid Dendritic Cells (mDCs), and differentiate between specialized subgroups of CD8 and CD4 of T-memory VS T-naïve (Supplementary Fig. S3C). Results showed that out of 17 comparable cell populations, 14 obtained top similarity values with the corresponding and matching cell types. The second and third most similar groups were the corresponding types from those that did not map with the most similar group. For instance, non-classical monocytes top similar group in the reference was classical monocytes, followed closely as second most similar by the non-classical monocytes. Interestingly, one cluster of CD8 T-memory cells was found to be most similar to Natural Killer cells, and KLRD1 selected by our tool (Supplementary Fig. S3D), the marker gene contributing the most to the score. KLRD1 is used as an NK marker and is known to be expressed in CD8 cytotoxic cells [52–55]. The top markers selected by feature selection ability of CFS were in general highly specific (Supplementary Fig. S3D).

In the case of some highly specialized manually annotated groups that were not present in the reference dataset, cell types engaging in those specific phenotypes were found to be the most similar (e.g. the top similar group for the ATAC-Seq manually annotated T helper cell clusters was CD4 naïve from the reference single-cell RNA-Seq, Supplementary Fig. S3C).

These results show that our method is a powerful tool not only for matching clusters or finding markers of interest but can also be used in conjunction with high-quality reference datasets.

Astrocyte analysis on mouse motor cortex and spinal cord

To further demonstrate the versatility of our metric, we sequenced and analyzed single-nuclei RNA-Seq from the motor cortex and spinal cord of three wild-type 12 months old mice, for a total of six samples (Fig. 3A), with the focus of identifying and characterizing astrocytes in different parts of the motor-neuronal system. Astrocytes are glial cells in the central nervous system with a wide diversity of roles and physiological functions, including development and maturation of synapses, neurotransmitter homeostasis, glycogen storage, blood brain barrier maintenance, and clearance of protein aggregates [56–59]. They have become of high interest as they contribute to several neurological diseases, such as the motor disease amyotrophic lateral sclerosis (ALS) [60–62]. After processing and filtering for quality control, a total of 39 493 cell-nuclei were selected for downstream analysis (mean of nuclei per mouse = 6582, sd = 1107). Astrocytic cell populations were selected using respective canonical markers (Fig. 3C), for a total of 3056 astrocytes (mean per mouse = 509 astrocytes, sd = 167).

Integration of astrocyte cluster subpopulation using our similarity metric. (A) UMAP dimensionality reduction of datasets (N = 6) sc:spinal cord, cx:cortex. (B) Directed graph of clusters by similarity, each node corresponds to a cluster from one dataset, edges correspond to the similarity value and the direction of the similarity, shorter edge lengths translate to larger similarity values. (C) Violin plots of astrocyte gene markers selected by CFS as contributing the most to the similarity value for the specified AG1, AG2, and AG3 subpopulations. (D) Percentage of cells corresponding to each AG per sample. (E) Heatmap plot of all the similarity values between spinal cord and cortex from the same mouse (id:26).
Figure 3.

Integration of astrocyte cluster subpopulation using our similarity metric. (A) UMAP dimensionality reduction of datasets (N = 6) sc:spinal cord, cx:cortex. (B) Directed graph of clusters by similarity, each node corresponds to a cluster from one dataset, edges correspond to the similarity value and the direction of the similarity, shorter edge lengths translate to larger similarity values. (C) Violin plots of astrocyte gene markers selected by CFS as contributing the most to the similarity value for the specified AG1, AG2, and AG3 subpopulations. (D) Percentage of cells corresponding to each AG per sample. (E) Heatmap plot of all the similarity values between spinal cord and cortex from the same mouse (id:26).

An initial integration of the expression data revealed, as expected, major differences between spinal cord and motor cortex (Supplementary Fig. S4B and E). To overcome the tissue and intra-specimen variability (Supplementary Fig. S4A, B, D, and E) and identify conserved astrocyte populations, we used our similarity score analysis to match clusters between mice. For this, each sample was independently processed (Fig. 3A) and clustered (see “Materials and methods”). The processed samples were then fed into our similarity score algorithmic approach, using all available genes, so that novel markers outside the top variable genes could be detected by CFS feature selection ability.

Exploratory analysis of common markers like Gfap and Aqp4 showed high variability (Fig. 3C), revealing the emerging heterogeneity and diverse functionality of astrocytes [63, 64]. Glial fibrillary acidic protein (Gfap), while showing overall expression in spinal cord, was cluster-specific in motor cortex, showing the limitations of this marker as previously described [65, 66]. In the same direction, Aquaporin 4 (Aqp4), highly expressed in astrocytes and responsible for water exchange across the brain, showed consistent expression in spinal cord astrocyte populations, but not in the motor cortex. The enzyme aldehyde dehydrogenase 1 family member L1 (Aldh1l1), regulating folate metabolism and known to be strongly expressed in astrocytes, showed overall inconsistent expression across tissues and clusters.

Similarity score identifies conserved astrocyte populations across motor cortex and spinal cord

Using the similarity scores from the clusters of each sample and the graph community analysis using Leiden algorithm, we defined three distinct subpopulations of astrocytes based on differences in transcript abundances (Fig. 3BE). Isolated clusters with few or no inward arrows on the similarity graph were excluded (cx.699 clusters 3 and 5, sc.699 cluster 4, and sc.36 cluster 3). These subpopulations were observed in both motor cortex and spinal cord. Top features selected by CFS as the ones contributing the most to the observed similarities were highly specific in most of the cases (Fig. 3C) and in they were observed in the significant DEG found on the contrast analysis withing each group (see next section). Astrocyte Group 3 (AG3) was the largest and most heterogeneous, comprising three additional sub-groups showcasing similar characteristics but different expression patterns. In contrast, AG1 was the smallest in terms of number of cells, yet exhibiting high homogeneity, and showing highly specific markers found by our similarity method. AG2 resembled GFAP + physiologically active population, showing upregulated genes that are shared with pathogenic reactive populations [67].

To better understand the main differences between these three AG populations, we performed a differential expression analysis between the groups discovered by CFS pulling all the data together and adding as model covariates for the DE test the mouse id and sequencing date. A justification for this is that the marker selection capabilities of CFS are complementary to differential expression analysis, but a more refined test is needed to uncover the significant differences once the main groups have been identified, since features contributing to the similarity between clusters can be relevant for several cluster pairs and thus not necessarily differentially expressed between main groups.

A small astrocyte population enriched in neuronal and CNS developmental markers

In total, we found 330 differentially upregulated genes (P value < 0.005, see materials and methods statistical significance) in Astrocyte Group 1 (AG1) in contrast with AG2 and AG3 (Table 1), both in spinal cord and motor cortex tissues (differential expression analysis was done using the merged data with the tissue, sequencing date, and the mouse id as covariates). A large quantity of these upregulated genes were linked to neurogenesis and nervous system development functions (Fig. 4A and B). Ontology analysis revealed a set of major biological terms significantly associated with neurogenesis, nervous system development, neuron projection, neuron differentiation, and cell projection organization (Fig. 4B). Relevant actors in this upregulated list include a set of transcription factors (TF) uniquely expressed in AG1. Sox10 involved in embryonic development and cell fate, has been described to play an important role in neural crest and peripheral nervous system development [68], as well as activating additional TFs [69, 70]. Zfp536 with roles in regulation of neuron differentiation and negative regulation of retinoic acid receptor signaling pathway [71, 72]. Zeb2 (Sip1, Zfhx1b), a TF that acts both as a DNA-binding transcriptional repressor and activator, is known to be involved in neuronal development [73] and in the differentiation between cortical and striatal interneurons [74]; Zeb2 shows expression across all groups in our study, being significantly higher in AG1.

Table 1.

Differentially upregulated genes (P value < 0.005) in AG1 in comparison with AG2 and AG3

Genep_valavg_log2FCpct.1pct.2p_val_adjDescription
Tmeff21.96E-2792.190 3530.8660.1716.32E-275transmembrane protein with EGF-like and two follistatin-like domains 2 [Source:MGI Symbol;Acc:MGI:1 861 735]
Slc24a22.18E-2712.39 047 0550.9010.3137.04E-267solute carrier family 24 (sodium/potassium/calcium exchanger), member 2 [Source:MGI Symbol;Acc:MGI:1 923 626]
St186.00E-2471.99 495 0270.8310.0651.94E-242suppression of tumorigenicity 18 [Source:MGI Symbol;Acc:MGI:2 446 700]
Pde4b1.48E-2342.43 293 9180.9580.5184.79E-230phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Edil31.19E-2271.90 688 8690.8380.193.86E-223EGF-like repeats and discoidin I-like domains 3 [Source:MGI Symbol;Acc:MGI:1 329 025]
Zfp5364.61E-2041.59 566 4070.7890.0461.49E-199zinc finger protein 536 [Source:MGI Symbol;Acc:MGI:1 926 102]
Dock102.99E-2021.82 246 2490.8590.1079.65E-198dedicator of cytokinesis 10 [Source:MGI Symbol;Acc:MGI:2 146 320]
Frmd52.29E-1871.91 664 3750.810.1057.40E-183FERM domain containing 5 [Source:MGI Symbol;Acc:MGI:2 442 557]
Pex5l2.43E-1792.1 784 6580.8170.1877.84E-175peroxisomal biogenesis factor 5-like [Source:MGI Symbol;Acc:MGI:1 916 672]
Prr5l8.98E-1642.11 001 0490.8380.0842.90E-159proline rich 5 like [Source:MGI Symbol;Acc:MGI:1 919 696]
Map73.57E-1561.42 866 7840.7390.1551.15E-151microtubule-associated protein 7 [Source:MGI Symbol;Acc:MGI:1 328 328]
Hecw21.21E-1411.3 025 4460.6970.0913.89E-137HECT, C2 and WW domain containing E3 ubiquitin protein ligase 2 [Source:MGI Symbol;Acc:MGI:2 685 817]
Ank35.63E-1311.39 801 6830.8240.2411.82E-126ankyrin 3, epithelial [Source:MGI Symbol;Acc:MGI:88 026]
Mbp3.03E-1221.61 563 5750.8730.3849.80E-118myelin basic protein [Source:MGI Symbol;Acc:MGI:96 925]
Dscaml15.79E-1221.14 094 5760.5920.0311.87E-117DS cell adhesion molecule like 1 [Source:MGI Symbol;Acc:MGI:2 150 309]
Ano42.70E-1201.19 501 1790.6620.0788.70E-116anoctamin 4 [Source:MGI Symbol;Acc:MGI:2 443 344]
Nkain21.23E-1182.459 1050.9230.4793.99E-114Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Plp14.27E-1111.18 847 6230.930.6141.38E-106proteolipid protein (myelin) 1 [Source:MGI Symbol;Acc:MGI:97 623]
Elmo17.68E-1101.49 626 4760.7750.1112.48E-105engulfment and cell motility 1 [Source:MGI Symbol;Acc:MGI:2 153 044]
Plcl15.42E-1091.79 213 8730.9580.5511.75E-104phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Mog5.45E-1050.83 664 2470.5280.0571.76E-100myelin oligodendrocyte glycoprotein [Source:MGI Symbol;Acc:MGI:97 435]
Spock13.35E-1041.06 025 6450.620.1141.08E-99sparc/osteonectin, cwcv and kazal-like domains proteoglycan 1 [Source:MGI Symbol;Acc:MGI:105 371]
C030029H02Rik6.53E-1040.87 497 8050.5350.0132.11E-99RIKEN cDNA C030029H02 gene [Source:MGI Symbol;Acc:MGI:1 924 633]
Bin11.85E-1000.96 607 4690.6760.1355.98E-96bridging integrator 1 [Source:MGI Symbol;Acc:MGI:108 092]
Ptprd1.32E-991.33 071 4840.9790.8424.26E-95protein tyrosine phosphatase, receptor type, D [Source:MGI Symbol;Acc:MGI:97 812]
Mag2.63E-980.8 681 8370.5630.1048.50E-94myelin-associated glycoprotein [Source:MGI Symbol;Acc:MGI:96 912]
Ypel24.47E-980.90 782 6930.5560.0751.44E-93yippee like 2 [Source:MGI Symbol;Acc:MGI:1 925 114]
Ppp1r16b9.04E-981.05 503 1860.5990.0892.92E-93protein phosphatase 1, regulatory subunit 16B [Source:MGI Symbol;Acc:MGI:2 151 841]
D7Ertd443e7.06E-960.95 018 3190.5420.0332.28E-91DNA segment, Chr 7, ERATO Doi 443, expressed [Source:MGI Symbol;Acc:MGI:1 196 431]
Sec14l57.85E-960.8 238 5310.4930.0242.53E-91SEC14-like lipid binding 5 [Source:MGI Symbol;Acc:MGI:3 616 084]
Bcas12.14E-950.8 599 4870.5280.0586.91E-91brain enriched myelin associated protein 1 [Source:MGI Symbol;Acc:MGI:1 924 210]
Plekhh11.69E-930.67 017 4680.4440.0225.46E-89pleckstrin homology domain containing, family H (with MyTH4 domain) member 1 [Source:MGI Symbol;Acc:MGI:2 144 989]
Rnf2203.11E-901.51 733 1620.7390.1521.00E-85ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Fa2h3.38E-870.75 377 5980.4370.031.09E-82fatty acid 2-hydroxylase [Source:MGI Symbol;Acc:MGI:2 443 327]
Gjc31.13E-850.75 679 7550.4720.0353.66E-81gap junction protein, gamma 3 [Source:MGI Symbol;Acc:MGI:2 153 041]
Zeb21.86E-841.28 891 0950.880.536.02E-80zinc finger E-box binding homeobox 2 [Source:MGI Symbol;Acc:MGI:1 344 407]
Agap13.01E-811.00 618 5370.7320.2079.71E-77ArfGAP with GTPase domain, ankyrin repeat and PH domain 1 [Source:MGI Symbol;Acc:MGI:2 653 690]
Ptprk2.86E-791.01 913 2210.6130.0939.23E-75protein tyrosine phosphatase, receptor type, K [Source:MGI Symbol;Acc:MGI:103 310]
Sox2ot4.38E-781.13 822 8030.8660.4751.41E-73SOX2 overlapping transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 112]
A230001M10Rik3.33E-770.72 716 2610.4370.0081.08E-72RIKEN cDNA A230001M10 gene [Source:MGI Symbol;Acc:MGI:2 443 043]
Pakap9.74E-771.0 263 7660.5630.0513.15E-72paralemmin A kinase anchor protein [Source:MGI Symbol;Acc:MGI:5 141 924]
4930419G24Rik1.16E-760.70 591 9710.4150.0173.74E-72RIKEN cDNA 4930419G24 gene [Source:MGI Symbol;Acc:MGI:1 921 124]
Adipor22.95E-761.02 693 2160.5630.1539.52E-72adiponectin receptor 2 [Source:MGI Symbol;Acc:MGI:93 830]
Arhgap234.40E-761.02 552 1970.6690.2341.42E-71Rho GTPase activating protein 23 [Source:MGI Symbol;Acc:MGI:3 697 726]
Phldb11.03E-750.68 383 2940.4720.0653.34E-71pleckstrin homology like domain, family B, member 1 [Source:MGI Symbol;Acc:MGI:2 143 230]
Ugt8a2.30E-750.73 747 8390.4860.0637.42E-71UDP galactosyltransferase 8A [Source:MGI Symbol;Acc:MGI:109 522]
Shtn11.26E-720.71 115 0320.4580.0424.07E-68shootin 1 [Source:MGI Symbol;Acc:MGI:1 918 903]
Pak72.67E-700.8 747 0790.4860.0778.63E-66NA
March16.51E-691.176 5950.6340.0912.10E-64NA
Mobp2.10E-681.06 170 7860.6480.1396.77E-64myelin-associated oligodendrocytic basic protein [Source:MGI Symbol;Acc:MGI:108 511]
Csmd34.28E-671.0 810 8120.8170.4041.38E-62CUB and Sushi multiple domains 3 [Source:MGI Symbol;Acc:MGI:2 386 403]
Slain12.35E-660.61 273 4580.4510.0617.58E-62SLAIN motif family, member 1 [Source:MGI Symbol;Acc:MGI:2 145 578]
A330015K06Rik1.42E-620.64 696 3620.3590.0234.60E-58RIKEN cDNA A330015K06 gene [Source:MGI Symbol;Acc:MGI:2 443 553]
Enpp24.34E-621.01 557 3970.690.2471.40E-57ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
A330049N07Rik1.28E-610.50 447 5180.3170.0124.14E-57RIKEN cDNA A330049N07 gene [Source:MGI Symbol;Acc:MGI:3 041 175]
Slco3a12.53E-610.71 425 8820.430.0658.17E-57solute carrier organic anion transporter family, member 3a1 [Source:MGI Symbol;Acc:MGI:1 351 867]
Mapt3.51E-611.03 710 9950.8240.441.13E-56microtubule-associated protein tau [Source:MGI Symbol;Acc:MGI:97 180]
Neat19.26E-610.90 096 1160.8730.532.99E-56nuclear paraspeckle assembly transcript 1 (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 914 211]
Sox101.48E-600.48 456 8920.3170.0124.78E-56SRY (sex determining region Y)-box 10 [Source:MGI Symbol;Acc:MGI:98 358]
Sh3d192.37E-600.73 672 3660.4580.0527.64E-56SH3 domain protein D19 [Source:MGI Symbol;Acc:MGI:1 350 923]
Aspa2.86E-600.83 141 4260.5630.1259.23E-56aspartoacylase [Source:MGI Symbol;Acc:MGI:87 914]
St6galnac39.88E-591.36 442 6560.8310.1693.19E-54ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Dnm32.80E-581.08 067 8960.7960.3129.05E-54dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Mast46.02E-581.17 111 1780.9230.6621.94E-53microtubule associated serine/threonine kinase family member 4 [Source:MGI Symbol;Acc:MGI:1 918 885]
Spock31.06E-550.82 781 5740.50.1463.42E-51sparc/osteonectin, cwcv and kazal-like domains proteoglycan 3 [Source:MGI Symbol;Acc:MGI:1 920 152]
Tspan21.59E-550.53 547 8250.3870.0425.14E-51tetraspanin 2 [Source:MGI Symbol;Acc:MGI:1 917 997]
Pstpip27.48E-550.6 397 3930.3520.0272.41E-50proline-serine-threonine phosphatase-interacting protein 2 [Source:MGI Symbol;Acc:MGI:1 335 088]
Myo1d2.03E-530.5 941 8160.3380.0196.54E-49myosin ID [Source:MGI Symbol;Acc:MGI:107 728]
Trf2.50E-520.74 161 8910.570.2238.09E-48transferrin [Source:MGI Symbol;Acc:MGI:98 821]
Gm374596.58E-510.47 492 8590.2890.0132.12E-46predicted gene, 37 459 [Source:MGI Symbol;Acc:MGI:5 610 687]
Gatm3.61E-490.6 767 9770.5490.1621.17E-44glycine amidinotransferase (L-arginine:glycine amidinotransferase) [Source:MGI Symbol;Acc:MGI:1 914 342]
Tbc1d52.37E-470.96 314 2080.7820.3937.67E-43TBC1 domain family, member 5 [Source:MGI Symbol;Acc:MGI:1 919 488]
Arhgef104.17E-470.61 505 5650.4720.0961.35E-42Rho guanine nucleotide exchange factor (GEF) 10 [Source:MGI Symbol;Acc:MGI:2 444 453]
Magi28.29E-470.76 494 3460.9930.9582.68E-42membrane associated guanylate kinase, WW and PDZ domain containing 2 [Source:MGI Symbol;Acc:MGI:1 354 953]
Frmd4b3.84E-460.83 612 7370.5560.1141.24E-41FERM domain containing 4B [Source:MGI Symbol;Acc:MGI:2 141 794]
Slc25a131.13E-450.47 421 7710.2820.0233.66E-41solute carrier family 25 (mitochondrial carrier, adenine nucleotide translocator), member 13 [Source:MGI Symbol;Acc:MGI:1 354 721]
Mast31.21E-450.54 141 4790.3940.0613.91E-41microtubule associated serine/threonine kinase 3 [Source:MGI Symbol;Acc:MGI:2 683 541]
9330111N05Rik2.85E-450.86 924 3090.2390.029.20E-41RIKEN cDNA 9330111N05 gene [Source:MGI Symbol;Acc:MGI:2 443 112]
Plxdc22.90E-450.99 119 4110.6970.2899.37E-41plexin domain containing 2 [Source:MGI Symbol;Acc:MGI:1 914 698]
Hapln21.55E-420.42 343 6150.3030.0445.01E-38hyaluronan and proteoglycan link protein 2 [Source:MGI Symbol;Acc:MGI:2 137 300]
Pls11.69E-420.48 138 9080.3310.0365.45E-38plastin 1 (I-isoform) [Source:MGI Symbol;Acc:MGI:104 809]
Zdhhc201.12E-410.71 868 9140.6480.2713.63E-37zinc finger, DHHC domain containing 20 [Source:MGI Symbol;Acc:MGI:1 923 215]
Kif13b1.84E-410.65 625 5650.5920.2235.93E-37kinesin family member 13B [Source:MGI Symbol;Acc:MGI:1 098 265]
Nkain17.94E-410.39 682 3360.2750.022.56E-36Na+/K + transporting ATPase interacting 1 [Source:MGI Symbol;Acc:MGI:1 914 399]
Erbin1.15E-400.86 650 2980.7040.3183.73E-36Erbb2 interacting protein [Source:MGI Symbol;Acc:MGI:1 890 169]
Fnbp11.39E-390.87 125 7280.8730.7124.50E-35formin binding protein 1 [Source:MGI Symbol;Acc:MGI:109 606]
Ttll72.04E-390.60 669 7220.4790.1496.58E-35tubulin tyrosine ligase-like family, member 7 [Source:MGI Symbol;Acc:MGI:1 918 142]
Srcin12.73E-390.51 518 0350.4230.0938.83E-35SRC kinase signaling inhibitor 1 [Source:MGI Symbol;Acc:MGI:1 933 179]
Zdhhc144.12E-390.68 121 4790.5490.1531.33E-34zinc finger, DHHC domain containing 14 [Source:MGI Symbol;Acc:MGI:2 653 229]
Arsg8.39E-390.38 634 5390.2680.0222.71E-34arylsulfatase G [Source:MGI Symbol;Acc:MGI:1 921 258]
Gm424131.02E-380.3 871 6350.2680.0283.31E-34predicted gene, 42 413 [Source:MGI Symbol;Acc:MGI:5 648 986]
Tubb4a1.15E-380.54 604 1650.4580.1333.72E-34tubulin, beta 4A class IVA [Source:MGI Symbol;Acc:MGI:107 848]
Slc12a21.22E-380.58 801 6450.5210.1353.94E-34solute carrier family 12, member 2 [Source:MGI Symbol;Acc:MGI:101 924]
Gm161682.12E-380.87 079 4980.5990.2056.86E-34predicted gene 16 168 [Source:MGI Symbol;Acc:MGI:3 802 010]
Pcdh92.68E-380.97 488 42210.9848.66E-34protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Pik3c2b4.28E-380.37 728 2020.2460.0241.38E-33phosphatidylinositol-4-phosphate 3-kinase catalytic subunit type 2 beta [Source:MGI Symbol;Acc:MGI:2 685 045]
4930511M06Rik1.11E-370.3 310 7130.2540.0183.60E-33RIKEN cDNA 4930511M06 gene [Source:MGI Symbol;Acc:MGI:1 922 334]
Cdc42bpa2.23E-370.78 839 3340.810.5737.19E-33CDC42 binding protein kinase alpha [Source:MGI Symbol;Acc:MGI:2 441 841]
Sept42.64E-370.54 089 8980.4650.1378.53E-33NA
Ninj23.79E-370.51 902 0610.3030.0231.22E-32ninjurin 2 [Source:MGI Symbol;Acc:MGI:1 352 751]
Kcnk134.12E-370.43 764 7880.2820.0271.33E-32potassium channel, subfamily K, member 13 [Source:MGI Symbol;Acc:MGI:2 384 976]
Unc5c6.43E-371.11 147 0440.7390.2122.08E-32unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Gm195002.08E-360.30 602 4910.2110.0086.72E-32predicted gene, 19 500 [Source:MGI Symbol;Acc:MGI:5 011 685]
Il1rap2.56E-360.57 608 2550.4150.0768.25E-32interleukin 1 receptor accessory protein [Source:MGI Symbol;Acc:MGI:104 975]
Vmp15.27E-360.66 465 0540.5770.2511.70E-31vacuole membrane protein 1 [Source:MGI Symbol;Acc:MGI:1 923 159]
Anln1.38E-350.48 487 9750.3030.0574.46E-31anillin, actin binding protein [Source:MGI Symbol;Acc:MGI:1 920 174]
Tmeff14.17E-350.51 360 5280.3450.0751.35E-30transmembrane protein with EGF-like and two follistatin-like domains 1 [Source:MGI Symbol;Acc:MGI:1 926 810]
Pak14.91E-350.62 796 5020.6270.2151.58E-30p21 (RAC1) activated kinase 1 [Source:MGI Symbol;Acc:MGI:1 339 975]
Sept71.27E-340.73 987 8470.7750.4714.09E-30NA
Creb51.29E-340.56 432 8150.3870.0414.18E-30cAMP responsive element binding protein 5 [Source:MGI Symbol;Acc:MGI:2 443 973]
Eml11.29E-340.56 745 0440.3520.0834.18E-30echinoderm microtubule associated protein like 1 [Source:MGI Symbol;Acc:MGI:1 915 769]
Slc44a13.97E-340.58 788 5490.4860.1261.28E-29solute carrier family 44, member 1 [Source:MGI Symbol;Acc:MGI:2 140 592]
Exoc6b5.55E-340.73 711 6010.7390.4411.79E-29exocyst complex component 6B [Source:MGI Symbol;Acc:MGI:1 923 164]
Pde8a1.37E-330.68 761 1450.4580.0944.42E-29phosphodiesterase 8A [Source:MGI Symbol;Acc:MGI:1 277 116]
Phlpp11.83E-330.81 013 8890.9720.7765.92E-29PH domain and leucine rich repeat protein phosphatase 1 [Source:MGI Symbol;Acc:MGI:2 138 327]
Synj23.19E-330.37 727 9530.3030.0491.03E-28synaptojanin 2 [Source:MGI Symbol;Acc:MGI:1 201 671]
Gm427563.27E-330.33 667 0230.2040.0041.05E-28predicted gene 42 756 [Source:MGI Symbol;Acc:MGI:5 662 893]
Rffl4.32E-330.53 223 0760.3870.0651.39E-28ring finger and FYVE like domain containing protein [Source:MGI Symbol;Acc:MGI:1 914 588]
Cntn21.03E-320.40 649 6330.2820.0443.31E-28contactin 2 [Source:MGI Symbol;Acc:MGI:104 518]
Litaf1.69E-320.40 625 2680.2890.0495.44E-28LPS-induced TN factor [Source:MGI Symbol;Acc:MGI:1 929 512]
Anks1b3.33E-320.75 156 8140.5210.2561.08E-27ankyrin repeat and sterile alpha motif domain containing 1B [Source:MGI Symbol;Acc:MGI:1 924 781]
Otud7b7.11E-320.65 083 1440.5630.2222.29E-27OTU domain containing 7B [Source:MGI Symbol;Acc:MGI:2 654 703]
Klhl28.54E-320.65 820 8990.5420.2222.76E-27kelch-like 2, Mayven [Source:MGI Symbol;Acc:MGI:1 924 363]
Grb141.01E-310.4 093 8340.2610.0323.28E-27growth factor receptor bound protein 14 [Source:MGI Symbol;Acc:MGI:1 355 324]
Cdc37l11.36E-310.66 387 6890.6830.3694.39E-27cell division cycle 37-like 1 [Source:MGI Symbol;Acc:MGI:1 914 322]
Sorcs12.12E-310.81 115 6190.50.126.85E-27sortilin-related VPS10 domain containing receptor 1 [Source:MGI Symbol;Acc:MGI:1 929 666]
Kctd36.37E-310.43 513 9220.3170.0792.06E-26potassium channel tetramerisation domain containing 3 [Source:MGI Symbol;Acc:MGI:2 444 629]
Tmem63a1.55E-300.30 592 6710.2180.0244.99E-26transmembrane protein 63a [Source:MGI Symbol;Acc:MGI:2 384 789]
Agpat41.74E-300.4 155 8550.3030.0525.61E-261-acylglycerol-3-phosphate O-acyltransferase 4 (lysophosphatidic acid acyltransferase, delta) [Source:MGI Symbol;Acc:MGI:1 915 512]
Ssh21.52E-290.68 483 3430.5560.1984.92E-25slingshot protein phosphatase 2 [Source:MGI Symbol;Acc:MGI:2 679 255]
Ptgds2.16E-290.78 930 2020.5770.3966.98E-25prostaglandin D2 synthase (brain) [Source:MGI Symbol;Acc:MGI:99 261]
Opalin2.55E-290.29 885 5370.2110.0248.24E-25oligodendrocytic myelin paranodal and inner loop protein [Source:MGI Symbol;Acc:MGI:2 657 025]
Gm485083.89E-290.2 522 3650.1620.0051.26E-24predicted gene, 48 508 [Source:MGI Symbol;Acc:MGI:6 098 039]
Cpm7.69E-290.26 961 4350.1760.0112.48E-24carboxypeptidase M [Source:MGI Symbol;Acc:MGI:1 917 824]
Prickle21.51E-280.81 121 3710.7320.3894.87E-24prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
Abca8a2.27E-280.30 631 7360.2110.0127.32E-24ATP-binding cassette, sub-family A (ABC1), member 8a [Source:MGI Symbol;Acc:MGI:2 386 846]
Kndc17.59E-280.38 605 8260.2250.0332.45E-23kinase non-catalytic C-lobe domain (KIND) containing 1 [Source:MGI Symbol;Acc:MGI:1 923 734]
Lpgat11.47E-270.52 009 4610.430.174.76E-23lysophosphatidylglycerol acyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 446 186]
Efnb31.57E-270.33 242 6310.2460.055.06E-23ephrin B3 [Source:MGI Symbol;Acc:MGI:109 196]
Slc8a12.10E-261.08 822 7360.7460.2666.77E-22solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Ubash3b2.74E-260.59 280 7850.4150.1158.85E-22ubiquitin associated and SH3 domain containing, B [Source:MGI Symbol;Acc:MGI:1 920 078]
Dixdc17.79E-260.37 251 0420.2750.0582.51E-21DIX domain containing 1 [Source:MGI Symbol;Acc:MGI:2 679 721]
Rtn49.96E-260.64 795 1080.7610.5273.21E-21reticulon 4 [Source:MGI Symbol;Acc:MGI:1 915 835]
Tmem132d1.74E-250.35 903 8040.2320.035.61E-21transmembrane protein 132D [Source:MGI Symbol;Acc:MGI:3 044 963]
Lrp1b2.41E-250.74 690 3160.930.8177.78E-21low density lipoprotein-related protein 1B [Source:MGI Symbol;Acc:MGI:2 151 136]
Tmem178b3.75E-250.74 144 4540.7040.4041.21E-20transmembrane protein 178B [Source:MGI Symbol;Acc:MGI:3 647 581]
Car24.82E-250.56 411 7070.5420.2781.56E-20carbonic anhydrase 2 [Source:MGI Symbol;Acc:MGI:88 269]
Dock96.04E-250.60 210 9950.6060.3221.95E-20dedicator of cytokinesis 9 [Source:MGI Symbol;Acc:MGI:106 321]
Gab18.06E-250.60 942 8240.5280.2412.60E-20growth factor receptor bound protein 2-associated protein 1 [Source:MGI Symbol;Acc:MGI:108 088]
Trim21.01E-240.67 060 9730.6480.3363.27E-20tripartite motif-containing 2 [Source:MGI Symbol;Acc:MGI:1 933 163]
Gm283761.45E-240.3 902 1970.2250.0174.69E-20predicted gene 28 376 [Source:MGI Symbol;Acc:MGI:5 579 082]
Atp8a11.75E-240.58 217 7910.7250.4545.64E-20ATPase, aminophospholipid transporter (APLT), class I, type 8A, member 1 [Source:MGI Symbol;Acc:MGI:1 330 848]
Kif21a2.22E-240.64 239 6680.7540.4277.16E-20kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
1700047M11Rik2.26E-240.33 808 7650.2320.0447.29E-20RIKEN cDNA 1700047M11 gene [Source:MGI Symbol;Acc:MGI:1 914 580]
Rasgrp32.48E-240.32 476 8140.2110.028.02E-20RAS, guanyl releasing protein 3 [Source:MGI Symbol;Acc:MGI:3 028 579]
Gm42584.16E-240.63 782 3750.5630.2521.34E-19predicted gene 4258 [Source:MGI Symbol;Acc:MGI:3 782 435]
Dip2b4.33E-240.58 787 8750.6060.3651.40E-19disco interacting protein 2 homolog B [Source:MGI Symbol;Acc:MGI:2 145 977]
Elovl71.48E-230.30 062 5330.2250.0264.79E-19ELOVL family member 7, elongation of long chain fatty acids (yeast) [Source:MGI Symbol;Acc:MGI:1 921 809]
Tenm21.85E-230.63 263 0640.4790.2445.96E-19teneurin transmembrane protein 2 [Source:MGI Symbol;Acc:MGI:1 345 184]
Rcbtb12.41E-230.42 611 2480.3310.127.78E-19regulator of chromosome condensation (RCC1) and BTB (POZ) domain containing protein 1 [Source:MGI Symbol;Acc:MGI:1 918 580]
Pacs21.61E-220.40 374 9690.3590.1215.20E-18phosphofurin acidic cluster sorting protein 2 [Source:MGI Symbol;Acc:MGI:1 924 399]
Inpp5f2.18E-220.43 895 6510.3730.1527.05E-18inositol polyphosphate-5-phosphatase F [Source:MGI Symbol;Acc:MGI:2 141 867]
Kcnab12.87E-220.52 369 3830.4440.1339.27E-18potassium voltage-gated channel, shaker-related subfamily, beta member 1 [Source:MGI Symbol;Acc:MGI:109 155]
Snx303.23E-220.36 229 5220.2960.0571.04E-17sorting nexin family member 30 [Source:MGI Symbol;Acc:MGI:2 443 882]
Nbas3.59E-220.46 269 9510.50.2231.16E-17neuroblastoma amplified sequence [Source:MGI Symbol;Acc:MGI:1 918 419]
Fign8.79E-220.42 219 0880.2680.0282.84E-17fidgetin [Source:MGI Symbol;Acc:MGI:1 890 647]
Dgki9.62E-220.80 427 9610.6340.2773.11E-17diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Jph19.64E-220.25 605 1770.2040.0253.11E-17junctophilin 1 [Source:MGI Symbol;Acc:MGI:1 891 495]
Prkcq1.26E-210.2 556 6030.2040.0274.06E-17protein kinase C, theta [Source:MGI Symbol;Acc:MGI:97 601]
Smad71.48E-210.3 719 7710.3240.0964.78E-17SMAD family member 7 [Source:MGI Symbol;Acc:MGI:1 100 518]
Kif13a1.69E-210.53 230 7980.5490.2685.45E-17kinesin family member 13A [Source:MGI Symbol;Acc:MGI:1 098 264]
Rftn11.78E-210.26 476 3140.1620.0195.75E-17raftlin lipid raft linker 1 [Source:MGI Symbol;Acc:MGI:1 923 688]
4930420G21Rik1.96E-210.30 770 5490.1760.0016.32E-17RIKEN cDNA 4930420G21 gene [Source:MGI Symbol;Acc:MGI:1 926 174]
Lpar12.02E-210.25 219 6870.1970.0286.51E-17lysophosphatidic acid receptor 1 [Source:MGI Symbol;Acc:MGI:108 429]
Clasp26.71E-210.62 845 5450.8380.6692.16E-16CLIP associating protein 2 [Source:MGI Symbol;Acc:MGI:1 923 749]
Stmn41.51E-200.39 314 1710.3030.0974.88E-16stathmin-like 4 [Source:MGI Symbol;Acc:MGI:1 931 224]
Il332.18E-200.45 476 1030.3380.1127.04E-16interleukin 33 [Source:MGI Symbol;Acc:MGI:1 924 375]
Opcml3.18E-200.63 576 0150.5560.3231.03E-15opioid binding protein/cell adhesion molecule-like [Source:MGI Symbol;Acc:MGI:97 397]
Mbnl23.25E-200.59 288 2240.8380.5961.05E-15muscleblind like splicing factor 2 [Source:MGI Symbol;Acc:MGI:2 145 597]
Ttll55.13E-200.44 199 4730.4720.1831.66E-15tubulin tyrosine ligase-like family, member 5 [Source:MGI Symbol;Acc:MGI:2 443 657]
Itpk16.27E-200.40 133 3660.3520.1172.02E-15inositol 1,3,4-triphosphate 5/6 kinase [Source:MGI Symbol;Acc:MGI:2 446 159]
Jakmip37.34E-200.25 099 9910.1620.0172.37E-15janus kinase and microtubule interacting protein 3 [Source:MGI Symbol;Acc:MGI:1 921 254]
Ppp1cc9.20E-200.38 432 9670.2890.0982.97E-15protein phosphatase 1 catalytic subunit gamma [Source:MGI Symbol;Acc:MGI:104 872]
Sez6l21.10E-190.36 167 9540.3380.1163.55E-15seizure related 6 homolog like 2 [Source:MGI Symbol;Acc:MGI:2 385 295]
Adamtsl12.14E-190.30 111 1080.3520.0756.91E-15ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
Aatk3.55E-190.50 286 0640.5990.2741.15E-14apoptosis-associated tyrosine kinase [Source:MGI Symbol;Acc:MGI:1 197 518]
Nfe2l35.30E-190.25 950 2370.1970.0271.71E-14nuclear factor, erythroid derived 2, like 3 [Source:MGI Symbol;Acc:MGI:1 339 958]
Dip2a7.75E-190.39 330 7940.3380.1282.50E-14disco interacting protein 2 homolog A [Source:MGI Symbol;Acc:MGI:2 385 920]
App8.63E-190.57 992 0890.7610.5392.79E-14amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Tmod29.60E-190.50 543 3440.5850.3543.10E-14tropomodulin 2 [Source:MGI Symbol;Acc:MGI:1 355 335]
Nbea1.14E-180.55 141 5480.7180.5273.68E-14neurobeachin [Source:MGI Symbol;Acc:MGI:1 347 075]
Grm31.15E-180.49 127 6030.8170.5333.70E-14glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Tcf121.77E-180.49 589 4460.7610.5615.70E-14transcription factor 12 [Source:MGI Symbol;Acc:MGI:101 877]
Nfasc1.91E-180.35 074 2820.620.46.16E-14neurofascin [Source:MGI Symbol;Acc:MGI:104 753]
Tmem1173.88E-180.40 506 2310.2960.0891.25E-13transmembrane protein 117 [Source:MGI Symbol;Acc:MGI:2 444 580]
Arrdc34.42E-180.29 785 6180.2820.0771.43E-13arrestin domain containing 3 [Source:MGI Symbol;Acc:MGI:2 145 242]
Qk4.48E-180.53 794 0640.9720.9431.45E-13NA
Arhgap394.73E-180.47 953 3330.4440.1461.53E-13Rho GTPase activating protein 39 [Source:MGI Symbol;Acc:MGI:107 858]
Lrrc8b8.33E-180.32 156 3340.2750.0652.69E-13leucine rich repeat containing 8 family, member B [Source:MGI Symbol;Acc:MGI:2 141 353]
Pacrg1.41E-170.71 534 1720.6060.3284.55E-13PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Cipc1.41E-170.40 268 3330.4080.2154.56E-13CLOCK interacting protein, circadian [Source:MGI Symbol;Acc:MGI:1 919 185]
Cdk192.11E-170.59 985 4530.7460.4696.80E-13cyclin-dependent kinase 19 [Source:MGI Symbol;Acc:MGI:1 925 584]
Apba13.45E-170.47 134 4710.4010.1471.12E-12amyloid beta (A4) precursor protein binding, family A, member 1 [Source:MGI Symbol;Acc:MGI:1 860 297]
Kcna13.87E-170.34 416 2440.3170.0941.25E-12potassium voltage-gated channel, shaker-related subfamily, member 1 [Source:MGI Symbol;Acc:MGI:96 654]
Prkcz4.84E-170.32 116 0270.2890.0931.56E-12protein kinase C, zeta [Source:MGI Symbol;Acc:MGI:97 602]
9330182L06Rik4.86E-170.29 562 8380.2320.0581.57E-12NA
Ube2d18.60E-170.29 694 1920.2540.0792.78E-12ubiquitin-conjugating enzyme E2D 1 [Source:MGI Symbol;Acc:MGI:2 384 911]
Dpy19l11.64E-160.33 789 7630.2890.15.29E-12dpy-19-like 1 (C. elegans) [Source:MGI Symbol;Acc:MGI:1 915 685]
1500004A13Rik3.15E-160.37 441 6140.430.1931.02E-11RIKEN cDNA 1500004A13 gene [Source:MGI Symbol;Acc:MGI:2 442 808]
Kazn3.33E-160.25 772 9650.2540.0711.08E-11kazrin, periplakin interacting protein [Source:MGI Symbol;Acc:MGI:1 918 779]
Ccp1104.68E-160.26 463 5820.2180.071.51E-11centriolar coiled coil protein 110 [Source:MGI Symbol;Acc:MGI:2 141 942]
Robo14.70E-160.59 124 2020.5560.3881.52E-11roundabout guidance receptor 1 [Source:MGI Symbol;Acc:MGI:1 274 781]
Sorcs37.52E-160.34 798 2850.2750.0692.43E-11sortilin-related VPS10 domain containing receptor 3 [Source:MGI Symbol;Acc:MGI:1 913 923]
Dlg27.57E-160.66 353 4290.8730.6082.44E-11discs large MAGUK scaffold protein 2 [Source:MGI Symbol;Acc:MGI:1 344 351]
Phactr11.20E-150.52 911 6610.7320.463.87E-11phosphatase and actin regulator 1 [Source:MGI Symbol;Acc:MGI:2 659 021]
Cobl1.33E-150.3 222 9750.2180.0594.28E-11cordon-bleu WH2 repeat [Source:MGI Symbol;Acc:MGI:105 056]
Pcdh151.33E-150.43 452 6530.2250.1174.29E-11protocadherin 15 [Source:MGI Symbol;Acc:MGI:1 891 428]
Ralgps12.05E-150.41 133 6380.4370.2136.62E-11Ral GEF with PH domain and SH3 binding motif 1 [Source:MGI Symbol;Acc:MGI:1 922 008]
Ppfibp22.54E-150.35 273 1630.3940.1588.20E-11PTPRF interacting protein, binding protein 2 (liprin beta 2) [Source:MGI Symbol;Acc:MGI:894 649]
Ube2e23.46E-150.53 184 9220.7540.4941.12E-10ubiquitin-conjugating enzyme E2E 2 [Source:MGI Symbol;Acc:MGI:2 384 997]
Olfml14.70E-150.28 671 0910.2390.0691.52E-10olfactomedin-like 1 [Source:MGI Symbol;Acc:MGI:2 679 264]
Jam37.35E-150.2 902 0260.2750.0752.37E-10junction adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 933 825]
Dleu29.17E-150.49 958 3780.5770.2532.96E-10deleted in lymphocytic leukemia, 2 [Source:MGI Symbol;Acc:MGI:1 934 030]
Cobll11.02E-140.33 155 7310.310.0973.31E-10Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Tnfaip61.75E-140.26 196 3610.1690.0315.66E-10tumor necrosis factor alpha induced protein 6 [Source:MGI Symbol;Acc:MGI:1 195 266]
Grm71.98E-140.75 582 8590.5070.2526.38E-10glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Wnk12.81E-140.44 146 8250.690.4769.08E-10WNK lysine deficient protein kinase 1 [Source:MGI Symbol;Acc:MGI:2 442 092]
Galnt73.18E-140.34 120 7010.2750.0781.03E-09polypeptide N-acetylgalactosaminyltransferase 7 [Source:MGI Symbol;Acc:MGI:1 349 449]
Dlg13.25E-140.47 381 5360.6270.431.05E-09discs large MAGUK scaffold protein 1 [Source:MGI Symbol;Acc:MGI:107 231]
Ttyh24.00E-140.30 576 1960.3730.1681.29E-09tweety family member 2 [Source:MGI Symbol;Acc:MGI:2 157 091]
Kif64.36E-140.26 052 7370.1970.0271.41E-09kinesin family member 6 [Source:MGI Symbol;Acc:MGI:1 098 238]
Sytl24.73E-140.29 329 8070.2320.0531.53E -09synaptotagmin-like 2 [Source:MGI Symbol;Acc:MGI:1 933 366]
Tmcc15.11E-140.49 862 9240.7390.5391.65E-09transmembrane and coiled coil domains 1 [Source:MGI Symbol;Acc:MGI:2 442 368]
Pip4k2a6.16E-140.40 115 8480.5140.2981.99E-09phosphatidylinositol-5-phosphate 4-kinase, type II, alpha [Source:MGI Symbol;Acc:MGI:1 298 206]
Tulp46.52E-140.47 631 8820.6340.4112.10E-09tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Dpyd6.89E-140.40 904 6820.4230.2772.23E-09dihydropyrimidine dehydrogenase [Source:MGI Symbol;Acc:MGI:2 139 667]
Rere8.76E-140.46 371 6460.7750.6032.83E-09arginine glutamic acid dipeptide (RE) repeats [Source:MGI Symbol;Acc:MGI:2 683 486]
Klf138.90E-140.35 945 1720.3870.1712.87E-09Kruppel-like factor 13 [Source:MGI Symbol;Acc:MGI:1 354 948]
Picalm1.00E-130.38 008 8280.4650.2183.23E-09phosphatidylinositol binding clathrin assembly protein [Source:MGI Symbol;Acc:MGI:2 385 902]
Abca21.07E-130.3 176 4730.3170.1383.47E-09ATP-binding cassette, sub-family A (ABC1), member 2 [Source:MGI Symbol;Acc:MGI:99 606]
Schip11.19E-130.41 507 8190.6130.3613.84E-09schwannomin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 353 557]
Trim351.19E-130.33 581 6820.3380.1433.85E-09tripartite motif-containing 35 [Source:MGI Symbol;Acc:MGI:1 914 104]
Sik31.26E-130.55 695 0360.810.6624.08E-09SIK family kinase 3 [Source:MGI Symbol;Acc:MGI:2 446 296]
Dscam1.81E-130.35 722 6750.1690.0875.84E-09DS cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 196 281]
Gas71.93E-130.31 931 1760.2680.1016.24E-09growth arrest specific 7 [Source:MGI Symbol;Acc:MGI:1 202 388]
Map4k52.07E-130.35 137 5910.3870.26.69E-09mitogen-activated protein kinase kinase kinase kinase 5 [Source:MGI Symbol;Acc:MGI:1 925 503]
Ptk22.31E-130.46 037 8210.7180.5357.46E-09PTK2 protein tyrosine kinase 2 [Source:MGI Symbol;Acc:MGI:95 481]
Rab312.35E-130.51 587 3040.5770.3887.58E-09RAB31, member RAS oncogene family [Source:MGI Symbol;Acc:MGI:1 914 603]
Cerk2.67E-130.30 557 3820.3240.1088.62E-09ceramide kinase [Source:MGI Symbol;Acc:MGI:2 386 052]
Chn22.83E-130.28 594 9570.1760.0239.13E-09chimerin 2 [Source:MGI Symbol;Acc:MGI:1 917 243]
Epb41l33.41E-130.3 103 6420.3170.1431.10E-08erythrocyte membrane protein band 4.1 like 3 [Source:MGI Symbol;Acc:MGI:103 008]
Naaladl23.52E-130.59 644 9580.6480.3491.14E-08N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Fam102a5.93E-130.27 780 9080.2610.1021.92E-08family with sequence similarity 102, member A [Source:MGI Symbol;Acc:MGI:2 138 935]
Slc38a26.77E-130.33 572 3820.310.1522.19E-08solute carrier family 38, member 2 [Source:MGI Symbol;Acc:MGI:1 915 010]
St6gal17.93E-130.48 959 3820.4860.252.56E-08beta galactoside alpha 2,6 sialyltransferase 1 [Source:MGI Symbol;Acc:MGI:108 470]
Tanc18.90E-130.26 089 0240.190.0632.87E-08tetratricopeptide repeat, ankyrin repeat and coiled-coil containing 1 [Source:MGI Symbol;Acc:MGI:1 914 110]
Rassf29.55E-130.31 791 0160.310.1183.08E-08Ras association (RalGDS/AF-6) domain family member 2 [Source:MGI Symbol;Acc:MGI:2 442 060]
Epn21.30E-120.40 804 8350.4010.2434.21E-08epsin 2 [Source:MGI Symbol;Acc:MGI:1 333 766]
Usp311.39E-120.28 668 2090.2890.0974.49E-08ubiquitin specific peptidase 31 [Source:MGI Symbol;Acc:MGI:1 923 429]
Enox11.48E-120.64 119 8450.6410.2914.77E-08ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Pbx31.60E-120.36 348 6690.2180.0825.18E-08pre B cell leukemia homeobox 3 [Source:MGI Symbol;Acc:MGI:97 496]
Lrrc8d1.69E-120.26 743 0180.2680.0675.46E-08leucine rich repeat containing 8D [Source:MGI Symbol;Acc:MGI:1 922 368]
Kctd131.89E-120.25 910 8240.2320.0716.12E-08potassium channel tetramerisation domain containing 13 [Source:MGI Symbol;Acc:MGI:1 923 739]
Wipf12.10E-120.42 212 8350.4720.2256.79E-08WAS/WASL interacting protein family, member 1 [Source:MGI Symbol;Acc:MGI:2 178 801]
Fmnl22.98E-120.50 797 6460.810.5629.62E-08formin-like 2 [Source:MGI Symbol;Acc:MGI:1 918 659]
Ralyl3.13E-120.37 461 3310.3590.1971.01E-07RALY RNA binding protein-like [Source:MGI Symbol;Acc:MGI:1 924 147]
Snrnp484.35E-120.30 167 1090.380.1631.40E-07small nuclear ribonucleoprotein 48 (U11/U12) [Source:MGI Symbol;Acc:MGI:1 915 047]
Apbb25.86E-120.37 732 9760.50.2681.89E-07amyloid beta (A4) precursor protein-binding, family B, member 2 [Source:MGI Symbol;Acc:MGI:108 405]
St3gal38.35E-120.33 765 2660.3870.2122.70E-07ST3 beta-galactoside alpha-2,3-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 316 659]
Hipk29.23E-120.42 920 2630.6970.4812.98E-07homeodomain interacting protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 314 872]
Zfp6381.00E-110.39 071 8480.6060.3823.23E-07zinc finger protein 638 [Source:MGI Symbol;Acc:MGI:1 203 484]
Bcl2l11.02E-110.37 843 4610.3870.2093.30E-07BCL2-like 1 [Source:MGI Symbol;Acc:MGI:88 139]
Plaat31.10E-110.2 560 6220.2460.0833.54E-07phospholipase A and acyltransferase 3 [Source:MGI Symbol;Acc:MGI:2 179 715]
Pkp41.53E-110.42 997 3950.5140.2794.95E-07plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Dst2.29E-110.41 891 4810.8380.6347.38E-07dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Snx12.37E-110.26 798 7520.2610.0947.65E-07sorting nexin 1 [Source:MGI Symbol;Acc:MGI:1 928 395]
Itsn23.99E-110.3 832 3910.5630.3131.29E-06intersectin 2 [Source:MGI Symbol;Acc:MGI:1 338 049]
Itch4.64E-110.34 894 2160.5560.3511.50E-06itchy, E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 202 301]
Ankib16.01E-110.32 551 4010.380.1871.94E-06ankyrin repeat and IBR domain containing 1 [Source:MGI Symbol;Acc:MGI:1 918 047]
Rapgef57.30E-110.28 518 1350.2040.0782.36E-06Rap guanine nucleotide exchange factor (GEF) 5 [Source:MGI Symbol;Acc:MGI:2 444 365]
Alcam7.37E-110.49 777 9240.5770.4922.38E-06activated leukocyte cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 313 266]
Slc25a278.64E-110.25 283 8640.2540.1062.79E-06solute carrier family 25, member 27 [Source:MGI Symbol;Acc:MGI:1 921 261]
Ppp2r3a1.54E-100.37 290 2470.5420.3684.96E-06protein phosphatase 2, regulatory subunit B'', alpha [Source:MGI Symbol;Acc:MGI:2 442 104]
Foxp11.58E-100.36 946 8910.6340.4465.11E-06forkhead box P1 [Source:MGI Symbol;Acc:MGI:1 914 004]
Sh3kbp11.76E-100.32 577 3130.3310.1455.69E-06SH3-domain kinase binding protein 1 [Source:MGI Symbol;Acc:MGI:1 889 583]
Oxr12.01E-100.43 543 6510.6480.4026.48E-06oxidation resistance 1 [Source:MGI Symbol;Acc:MGI:2 179 326]
Ppp1r212.34E-100.26 332 9970.2890.1297.54E-06protein phosphatase 1, regulatory subunit 21 [Source:MGI Symbol;Acc:MGI:1 921 075]
Elavl32.44E-100.30 396 8320.3030.1437.88E-06ELAV like RNA binding protein 3 [Source:MGI Symbol;Acc:MGI:109 157]
Clic42.45E-100.28 194 3690.4080.2327.90E-06chloride intracellular channel 4 (mitochondrial) [Source:MGI Symbol;Acc:MGI:1 352 754]
Dnajc62.62E-100.29 955 5620.2390.1098.44E-06DnaJ heat shock protein family (Hsp40) member C6 [Source:MGI Symbol;Acc:MGI:1 919 935]
Ncam12.62E-100.3 620 7210.8730.7798.45E-06neural cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:97 281]
Gm485122.85E-100.31 683 1480.310.1069.19E-06predicted gene, 48 512 [Source:MGI Symbol;Acc:MGI:6 098 046]
Usp547.29E-100.35 238 7250.4580.3172.35E-05ubiquitin specific peptidase 54 [Source:MGI Symbol;Acc:MGI:1 926 037]
Mtss19.29E-100.25 566 7840.2610.1143.00E-05MTSS I-BAR domain containing 1 [Source:MGI Symbol;Acc:MGI:2 384 818]
Kat2b1.19E-090.31 444 9630.4230.2243.85E-05K(lysine) acetyltransferase 2B [Source:MGI Symbol;Acc:MGI:1 343 094]
Dpysl21.24E-090.3 221 7760.5490.3434.00E-05dihydropyrimidinase-like 2 [Source:MGI Symbol;Acc:MGI:1 349 763]
Gna121.28E-090.29 101 1180.380.1754.14E-05guanine nucleotide binding protein, alpha 12 [Source:MGI Symbol;Acc:MGI:95 767]
Ywhaq1.52E-090.30 001 3210.4150.2214.92E-05tyrosine 3-monooxygenase/tryptophan 5-monooxygenase activation protein theta [Source:MGI Symbol;Acc:MGI:891 963]
Kif1b1.55E-090.36 174 4040.9230.815.01E-05kinesin family member 1B [Source:MGI Symbol;Acc:MGI:108 426]
5031439G07Rik1.55E-090.30 489 7880.5350.3895.02E-05RIKEN cDNA 5031439G07 gene [Source:MGI Symbol;Acc:MGI:2 444 899]
Nrbp21.59E-090.32 356 9840.3940.2155.12E-05nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Ncoa31.61E-090.25 337 7610.2750.1045.19E-05nuclear receptor coactivator 3 [Source:MGI Symbol;Acc:MGI:1 276 535]
Otud7a1.77E-090.50 197 6170.7040.4735.73E-05OTU domain containing 7A [Source:MGI Symbol;Acc:MGI:2 158 505]
Daam11.89E-090.38 269 9520.5630.4046.11E-05dishevelled associated activator of morphogenesis 1 [Source:MGI Symbol;Acc:MGI:1 914 596]
Ankrd284.30E-090.34 478 5890.5560.3650.00 013 897ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Fryl4.33E-090.32 061 0060.570.3320.00 013 975FRY like transcription coactivator [Source:MGI Symbol;Acc:MGI:1 919 563]
Ncam25.63E-090.52 172 6850.7540.5570.00 018 185neural cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:97 282]
Pakap.15.86E-090.25 161 4460.2680.1010.0 001 892NA
Cpeb26.71E-090.27 668 3380.3660.2540.00 021 677cytoplasmic polyadenylation element binding protein 2 [Source:MGI Symbol;Acc:MGI:2 442 640]
Pld17.92E-090.26 934 3650.2610.0930.00 025 557phospholipase D1 [Source:MGI Symbol;Acc:MGI:109 585]
Retreg18.48E-090.28 313 5660.3240.1260.0 002 738reticulophagy regulator 1 [Source:MGI Symbol;Acc:MGI:1 913 520]
Apod8.62E-090.27 079 6840.3450.2130.0 002 784apolipoprotein D [Source:MGI Symbol;Acc:MGI:88 056]
Atp11a1.01E-080.25 199 2730.2820.1510.00 032 617ATPase, class VI, type 11A [Source:MGI Symbol;Acc:MGI:1 354 735]
Sema6a1.31E-080.30 897 1740.2960.1020.00 042 137sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
2610035D17Rik1.51E-080.40 048 9710.5770.4280.00 048 781RIKEN cDNA 2610035D17 gene [Source:MGI Symbol;Acc:MGI:1 919 636]
Baz2b1.57E-080.37 303 6250.6970.5510.00 050 559bromodomain adjacent to zinc finger domain, 2B [Source:MGI Symbol;Acc:MGI:2 442 782]
Wdr202.34E-080.25 520 2230.3380.1590.00 075 438WD repeat domain 20 [Source:MGI Symbol;Acc:MGI:1 916 891]
Cttnbp22.40E-080.32 095 6070.4580.2660.0 007 738cortactin binding protein 2 [Source:MGI Symbol;Acc:MGI:1 353 467]
Osbpl1a2.57E-080.31 900 4890.4930.3250.00 082 996oxysterol binding protein-like 1A [Source:MGI Symbol;Acc:MGI:1 927 551]
Abhd17b2.70E-080.29 402 5890.4650.290.00 087 174abhydrolase domain containing 17B [Source:MGI Symbol;Acc:MGI:1 917 816]
Rnf133.01E-080.27 892 3080.4230.2290.000 972ring finger protein 13 [Source:MGI Symbol;Acc:MGI:1 346 341]
Tmem132b4.93E-080.26 716 1940.2680.1010.00 159 086transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Gnao15.42E-080.3 966 2220.8380.6540.00 175 013guanine nucleotide binding protein, alpha O [Source:MGI Symbol;Acc:MGI:95 775]
Pde1c5.66E-080.25 711 3140.2320.0510.00 182 824phosphodiesterase 1C [Source:MGI Symbol;Acc:MGI:108 413]
Pvt17.44E-080.25 652 9580.310.1540.00 240 229Pvt1 oncogene [Source:MGI Symbol;Acc:MGI:97 824]
Pard38.43E-080.3 133 2860.5920.4540.00 272 182par-3 family cell polarity regulator [Source:MGI Symbol;Acc:MGI:2 135 608]
Malat18.64E-080.26 747 411110.00 279 021metastasis associated lung adenocarcinoma transcript 1 (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 919 539]
Dcc9.55E-080.34 680 7950.50.2940.00 308 213deleted in colorectal carcinoma [Source:MGI Symbol;Acc:MGI:94 869]
Zcchc71.00E-070.32 309 1350.690.50.00 323 528zinc finger, CCHC domain containing 7 [Source:MGI Symbol;Acc:MGI:2 442 912]
Limch11.08E-070.35 675 4480.7390.6320.00 349 991LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Genep_valavg_log2FCpct.1pct.2p_val_adjDescription
Tmeff21.96E-2792.190 3530.8660.1716.32E-275transmembrane protein with EGF-like and two follistatin-like domains 2 [Source:MGI Symbol;Acc:MGI:1 861 735]
Slc24a22.18E-2712.39 047 0550.9010.3137.04E-267solute carrier family 24 (sodium/potassium/calcium exchanger), member 2 [Source:MGI Symbol;Acc:MGI:1 923 626]
St186.00E-2471.99 495 0270.8310.0651.94E-242suppression of tumorigenicity 18 [Source:MGI Symbol;Acc:MGI:2 446 700]
Pde4b1.48E-2342.43 293 9180.9580.5184.79E-230phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Edil31.19E-2271.90 688 8690.8380.193.86E-223EGF-like repeats and discoidin I-like domains 3 [Source:MGI Symbol;Acc:MGI:1 329 025]
Zfp5364.61E-2041.59 566 4070.7890.0461.49E-199zinc finger protein 536 [Source:MGI Symbol;Acc:MGI:1 926 102]
Dock102.99E-2021.82 246 2490.8590.1079.65E-198dedicator of cytokinesis 10 [Source:MGI Symbol;Acc:MGI:2 146 320]
Frmd52.29E-1871.91 664 3750.810.1057.40E-183FERM domain containing 5 [Source:MGI Symbol;Acc:MGI:2 442 557]
Pex5l2.43E-1792.1 784 6580.8170.1877.84E-175peroxisomal biogenesis factor 5-like [Source:MGI Symbol;Acc:MGI:1 916 672]
Prr5l8.98E-1642.11 001 0490.8380.0842.90E-159proline rich 5 like [Source:MGI Symbol;Acc:MGI:1 919 696]
Map73.57E-1561.42 866 7840.7390.1551.15E-151microtubule-associated protein 7 [Source:MGI Symbol;Acc:MGI:1 328 328]
Hecw21.21E-1411.3 025 4460.6970.0913.89E-137HECT, C2 and WW domain containing E3 ubiquitin protein ligase 2 [Source:MGI Symbol;Acc:MGI:2 685 817]
Ank35.63E-1311.39 801 6830.8240.2411.82E-126ankyrin 3, epithelial [Source:MGI Symbol;Acc:MGI:88 026]
Mbp3.03E-1221.61 563 5750.8730.3849.80E-118myelin basic protein [Source:MGI Symbol;Acc:MGI:96 925]
Dscaml15.79E-1221.14 094 5760.5920.0311.87E-117DS cell adhesion molecule like 1 [Source:MGI Symbol;Acc:MGI:2 150 309]
Ano42.70E-1201.19 501 1790.6620.0788.70E-116anoctamin 4 [Source:MGI Symbol;Acc:MGI:2 443 344]
Nkain21.23E-1182.459 1050.9230.4793.99E-114Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Plp14.27E-1111.18 847 6230.930.6141.38E-106proteolipid protein (myelin) 1 [Source:MGI Symbol;Acc:MGI:97 623]
Elmo17.68E-1101.49 626 4760.7750.1112.48E-105engulfment and cell motility 1 [Source:MGI Symbol;Acc:MGI:2 153 044]
Plcl15.42E-1091.79 213 8730.9580.5511.75E-104phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Mog5.45E-1050.83 664 2470.5280.0571.76E-100myelin oligodendrocyte glycoprotein [Source:MGI Symbol;Acc:MGI:97 435]
Spock13.35E-1041.06 025 6450.620.1141.08E-99sparc/osteonectin, cwcv and kazal-like domains proteoglycan 1 [Source:MGI Symbol;Acc:MGI:105 371]
C030029H02Rik6.53E-1040.87 497 8050.5350.0132.11E-99RIKEN cDNA C030029H02 gene [Source:MGI Symbol;Acc:MGI:1 924 633]
Bin11.85E-1000.96 607 4690.6760.1355.98E-96bridging integrator 1 [Source:MGI Symbol;Acc:MGI:108 092]
Ptprd1.32E-991.33 071 4840.9790.8424.26E-95protein tyrosine phosphatase, receptor type, D [Source:MGI Symbol;Acc:MGI:97 812]
Mag2.63E-980.8 681 8370.5630.1048.50E-94myelin-associated glycoprotein [Source:MGI Symbol;Acc:MGI:96 912]
Ypel24.47E-980.90 782 6930.5560.0751.44E-93yippee like 2 [Source:MGI Symbol;Acc:MGI:1 925 114]
Ppp1r16b9.04E-981.05 503 1860.5990.0892.92E-93protein phosphatase 1, regulatory subunit 16B [Source:MGI Symbol;Acc:MGI:2 151 841]
D7Ertd443e7.06E-960.95 018 3190.5420.0332.28E-91DNA segment, Chr 7, ERATO Doi 443, expressed [Source:MGI Symbol;Acc:MGI:1 196 431]
Sec14l57.85E-960.8 238 5310.4930.0242.53E-91SEC14-like lipid binding 5 [Source:MGI Symbol;Acc:MGI:3 616 084]
Bcas12.14E-950.8 599 4870.5280.0586.91E-91brain enriched myelin associated protein 1 [Source:MGI Symbol;Acc:MGI:1 924 210]
Plekhh11.69E-930.67 017 4680.4440.0225.46E-89pleckstrin homology domain containing, family H (with MyTH4 domain) member 1 [Source:MGI Symbol;Acc:MGI:2 144 989]
Rnf2203.11E-901.51 733 1620.7390.1521.00E-85ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Fa2h3.38E-870.75 377 5980.4370.031.09E-82fatty acid 2-hydroxylase [Source:MGI Symbol;Acc:MGI:2 443 327]
Gjc31.13E-850.75 679 7550.4720.0353.66E-81gap junction protein, gamma 3 [Source:MGI Symbol;Acc:MGI:2 153 041]
Zeb21.86E-841.28 891 0950.880.536.02E-80zinc finger E-box binding homeobox 2 [Source:MGI Symbol;Acc:MGI:1 344 407]
Agap13.01E-811.00 618 5370.7320.2079.71E-77ArfGAP with GTPase domain, ankyrin repeat and PH domain 1 [Source:MGI Symbol;Acc:MGI:2 653 690]
Ptprk2.86E-791.01 913 2210.6130.0939.23E-75protein tyrosine phosphatase, receptor type, K [Source:MGI Symbol;Acc:MGI:103 310]
Sox2ot4.38E-781.13 822 8030.8660.4751.41E-73SOX2 overlapping transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 112]
A230001M10Rik3.33E-770.72 716 2610.4370.0081.08E-72RIKEN cDNA A230001M10 gene [Source:MGI Symbol;Acc:MGI:2 443 043]
Pakap9.74E-771.0 263 7660.5630.0513.15E-72paralemmin A kinase anchor protein [Source:MGI Symbol;Acc:MGI:5 141 924]
4930419G24Rik1.16E-760.70 591 9710.4150.0173.74E-72RIKEN cDNA 4930419G24 gene [Source:MGI Symbol;Acc:MGI:1 921 124]
Adipor22.95E-761.02 693 2160.5630.1539.52E-72adiponectin receptor 2 [Source:MGI Symbol;Acc:MGI:93 830]
Arhgap234.40E-761.02 552 1970.6690.2341.42E-71Rho GTPase activating protein 23 [Source:MGI Symbol;Acc:MGI:3 697 726]
Phldb11.03E-750.68 383 2940.4720.0653.34E-71pleckstrin homology like domain, family B, member 1 [Source:MGI Symbol;Acc:MGI:2 143 230]
Ugt8a2.30E-750.73 747 8390.4860.0637.42E-71UDP galactosyltransferase 8A [Source:MGI Symbol;Acc:MGI:109 522]
Shtn11.26E-720.71 115 0320.4580.0424.07E-68shootin 1 [Source:MGI Symbol;Acc:MGI:1 918 903]
Pak72.67E-700.8 747 0790.4860.0778.63E-66NA
March16.51E-691.176 5950.6340.0912.10E-64NA
Mobp2.10E-681.06 170 7860.6480.1396.77E-64myelin-associated oligodendrocytic basic protein [Source:MGI Symbol;Acc:MGI:108 511]
Csmd34.28E-671.0 810 8120.8170.4041.38E-62CUB and Sushi multiple domains 3 [Source:MGI Symbol;Acc:MGI:2 386 403]
Slain12.35E-660.61 273 4580.4510.0617.58E-62SLAIN motif family, member 1 [Source:MGI Symbol;Acc:MGI:2 145 578]
A330015K06Rik1.42E-620.64 696 3620.3590.0234.60E-58RIKEN cDNA A330015K06 gene [Source:MGI Symbol;Acc:MGI:2 443 553]
Enpp24.34E-621.01 557 3970.690.2471.40E-57ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
A330049N07Rik1.28E-610.50 447 5180.3170.0124.14E-57RIKEN cDNA A330049N07 gene [Source:MGI Symbol;Acc:MGI:3 041 175]
Slco3a12.53E-610.71 425 8820.430.0658.17E-57solute carrier organic anion transporter family, member 3a1 [Source:MGI Symbol;Acc:MGI:1 351 867]
Mapt3.51E-611.03 710 9950.8240.441.13E-56microtubule-associated protein tau [Source:MGI Symbol;Acc:MGI:97 180]
Neat19.26E-610.90 096 1160.8730.532.99E-56nuclear paraspeckle assembly transcript 1 (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 914 211]
Sox101.48E-600.48 456 8920.3170.0124.78E-56SRY (sex determining region Y)-box 10 [Source:MGI Symbol;Acc:MGI:98 358]
Sh3d192.37E-600.73 672 3660.4580.0527.64E-56SH3 domain protein D19 [Source:MGI Symbol;Acc:MGI:1 350 923]
Aspa2.86E-600.83 141 4260.5630.1259.23E-56aspartoacylase [Source:MGI Symbol;Acc:MGI:87 914]
St6galnac39.88E-591.36 442 6560.8310.1693.19E-54ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Dnm32.80E-581.08 067 8960.7960.3129.05E-54dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Mast46.02E-581.17 111 1780.9230.6621.94E-53microtubule associated serine/threonine kinase family member 4 [Source:MGI Symbol;Acc:MGI:1 918 885]
Spock31.06E-550.82 781 5740.50.1463.42E-51sparc/osteonectin, cwcv and kazal-like domains proteoglycan 3 [Source:MGI Symbol;Acc:MGI:1 920 152]
Tspan21.59E-550.53 547 8250.3870.0425.14E-51tetraspanin 2 [Source:MGI Symbol;Acc:MGI:1 917 997]
Pstpip27.48E-550.6 397 3930.3520.0272.41E-50proline-serine-threonine phosphatase-interacting protein 2 [Source:MGI Symbol;Acc:MGI:1 335 088]
Myo1d2.03E-530.5 941 8160.3380.0196.54E-49myosin ID [Source:MGI Symbol;Acc:MGI:107 728]
Trf2.50E-520.74 161 8910.570.2238.09E-48transferrin [Source:MGI Symbol;Acc:MGI:98 821]
Gm374596.58E-510.47 492 8590.2890.0132.12E-46predicted gene, 37 459 [Source:MGI Symbol;Acc:MGI:5 610 687]
Gatm3.61E-490.6 767 9770.5490.1621.17E-44glycine amidinotransferase (L-arginine:glycine amidinotransferase) [Source:MGI Symbol;Acc:MGI:1 914 342]
Tbc1d52.37E-470.96 314 2080.7820.3937.67E-43TBC1 domain family, member 5 [Source:MGI Symbol;Acc:MGI:1 919 488]
Arhgef104.17E-470.61 505 5650.4720.0961.35E-42Rho guanine nucleotide exchange factor (GEF) 10 [Source:MGI Symbol;Acc:MGI:2 444 453]
Magi28.29E-470.76 494 3460.9930.9582.68E-42membrane associated guanylate kinase, WW and PDZ domain containing 2 [Source:MGI Symbol;Acc:MGI:1 354 953]
Frmd4b3.84E-460.83 612 7370.5560.1141.24E-41FERM domain containing 4B [Source:MGI Symbol;Acc:MGI:2 141 794]
Slc25a131.13E-450.47 421 7710.2820.0233.66E-41solute carrier family 25 (mitochondrial carrier, adenine nucleotide translocator), member 13 [Source:MGI Symbol;Acc:MGI:1 354 721]
Mast31.21E-450.54 141 4790.3940.0613.91E-41microtubule associated serine/threonine kinase 3 [Source:MGI Symbol;Acc:MGI:2 683 541]
9330111N05Rik2.85E-450.86 924 3090.2390.029.20E-41RIKEN cDNA 9330111N05 gene [Source:MGI Symbol;Acc:MGI:2 443 112]
Plxdc22.90E-450.99 119 4110.6970.2899.37E-41plexin domain containing 2 [Source:MGI Symbol;Acc:MGI:1 914 698]
Hapln21.55E-420.42 343 6150.3030.0445.01E-38hyaluronan and proteoglycan link protein 2 [Source:MGI Symbol;Acc:MGI:2 137 300]
Pls11.69E-420.48 138 9080.3310.0365.45E-38plastin 1 (I-isoform) [Source:MGI Symbol;Acc:MGI:104 809]
Zdhhc201.12E-410.71 868 9140.6480.2713.63E-37zinc finger, DHHC domain containing 20 [Source:MGI Symbol;Acc:MGI:1 923 215]
Kif13b1.84E-410.65 625 5650.5920.2235.93E-37kinesin family member 13B [Source:MGI Symbol;Acc:MGI:1 098 265]
Nkain17.94E-410.39 682 3360.2750.022.56E-36Na+/K + transporting ATPase interacting 1 [Source:MGI Symbol;Acc:MGI:1 914 399]
Erbin1.15E-400.86 650 2980.7040.3183.73E-36Erbb2 interacting protein [Source:MGI Symbol;Acc:MGI:1 890 169]
Fnbp11.39E-390.87 125 7280.8730.7124.50E-35formin binding protein 1 [Source:MGI Symbol;Acc:MGI:109 606]
Ttll72.04E-390.60 669 7220.4790.1496.58E-35tubulin tyrosine ligase-like family, member 7 [Source:MGI Symbol;Acc:MGI:1 918 142]
Srcin12.73E-390.51 518 0350.4230.0938.83E-35SRC kinase signaling inhibitor 1 [Source:MGI Symbol;Acc:MGI:1 933 179]
Zdhhc144.12E-390.68 121 4790.5490.1531.33E-34zinc finger, DHHC domain containing 14 [Source:MGI Symbol;Acc:MGI:2 653 229]
Arsg8.39E-390.38 634 5390.2680.0222.71E-34arylsulfatase G [Source:MGI Symbol;Acc:MGI:1 921 258]
Gm424131.02E-380.3 871 6350.2680.0283.31E-34predicted gene, 42 413 [Source:MGI Symbol;Acc:MGI:5 648 986]
Tubb4a1.15E-380.54 604 1650.4580.1333.72E-34tubulin, beta 4A class IVA [Source:MGI Symbol;Acc:MGI:107 848]
Slc12a21.22E-380.58 801 6450.5210.1353.94E-34solute carrier family 12, member 2 [Source:MGI Symbol;Acc:MGI:101 924]
Gm161682.12E-380.87 079 4980.5990.2056.86E-34predicted gene 16 168 [Source:MGI Symbol;Acc:MGI:3 802 010]
Pcdh92.68E-380.97 488 42210.9848.66E-34protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Pik3c2b4.28E-380.37 728 2020.2460.0241.38E-33phosphatidylinositol-4-phosphate 3-kinase catalytic subunit type 2 beta [Source:MGI Symbol;Acc:MGI:2 685 045]
4930511M06Rik1.11E-370.3 310 7130.2540.0183.60E-33RIKEN cDNA 4930511M06 gene [Source:MGI Symbol;Acc:MGI:1 922 334]
Cdc42bpa2.23E-370.78 839 3340.810.5737.19E-33CDC42 binding protein kinase alpha [Source:MGI Symbol;Acc:MGI:2 441 841]
Sept42.64E-370.54 089 8980.4650.1378.53E-33NA
Ninj23.79E-370.51 902 0610.3030.0231.22E-32ninjurin 2 [Source:MGI Symbol;Acc:MGI:1 352 751]
Kcnk134.12E-370.43 764 7880.2820.0271.33E-32potassium channel, subfamily K, member 13 [Source:MGI Symbol;Acc:MGI:2 384 976]
Unc5c6.43E-371.11 147 0440.7390.2122.08E-32unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Gm195002.08E-360.30 602 4910.2110.0086.72E-32predicted gene, 19 500 [Source:MGI Symbol;Acc:MGI:5 011 685]
Il1rap2.56E-360.57 608 2550.4150.0768.25E-32interleukin 1 receptor accessory protein [Source:MGI Symbol;Acc:MGI:104 975]
Vmp15.27E-360.66 465 0540.5770.2511.70E-31vacuole membrane protein 1 [Source:MGI Symbol;Acc:MGI:1 923 159]
Anln1.38E-350.48 487 9750.3030.0574.46E-31anillin, actin binding protein [Source:MGI Symbol;Acc:MGI:1 920 174]
Tmeff14.17E-350.51 360 5280.3450.0751.35E-30transmembrane protein with EGF-like and two follistatin-like domains 1 [Source:MGI Symbol;Acc:MGI:1 926 810]
Pak14.91E-350.62 796 5020.6270.2151.58E-30p21 (RAC1) activated kinase 1 [Source:MGI Symbol;Acc:MGI:1 339 975]
Sept71.27E-340.73 987 8470.7750.4714.09E-30NA
Creb51.29E-340.56 432 8150.3870.0414.18E-30cAMP responsive element binding protein 5 [Source:MGI Symbol;Acc:MGI:2 443 973]
Eml11.29E-340.56 745 0440.3520.0834.18E-30echinoderm microtubule associated protein like 1 [Source:MGI Symbol;Acc:MGI:1 915 769]
Slc44a13.97E-340.58 788 5490.4860.1261.28E-29solute carrier family 44, member 1 [Source:MGI Symbol;Acc:MGI:2 140 592]
Exoc6b5.55E-340.73 711 6010.7390.4411.79E-29exocyst complex component 6B [Source:MGI Symbol;Acc:MGI:1 923 164]
Pde8a1.37E-330.68 761 1450.4580.0944.42E-29phosphodiesterase 8A [Source:MGI Symbol;Acc:MGI:1 277 116]
Phlpp11.83E-330.81 013 8890.9720.7765.92E-29PH domain and leucine rich repeat protein phosphatase 1 [Source:MGI Symbol;Acc:MGI:2 138 327]
Synj23.19E-330.37 727 9530.3030.0491.03E-28synaptojanin 2 [Source:MGI Symbol;Acc:MGI:1 201 671]
Gm427563.27E-330.33 667 0230.2040.0041.05E-28predicted gene 42 756 [Source:MGI Symbol;Acc:MGI:5 662 893]
Rffl4.32E-330.53 223 0760.3870.0651.39E-28ring finger and FYVE like domain containing protein [Source:MGI Symbol;Acc:MGI:1 914 588]
Cntn21.03E-320.40 649 6330.2820.0443.31E-28contactin 2 [Source:MGI Symbol;Acc:MGI:104 518]
Litaf1.69E-320.40 625 2680.2890.0495.44E-28LPS-induced TN factor [Source:MGI Symbol;Acc:MGI:1 929 512]
Anks1b3.33E-320.75 156 8140.5210.2561.08E-27ankyrin repeat and sterile alpha motif domain containing 1B [Source:MGI Symbol;Acc:MGI:1 924 781]
Otud7b7.11E-320.65 083 1440.5630.2222.29E-27OTU domain containing 7B [Source:MGI Symbol;Acc:MGI:2 654 703]
Klhl28.54E-320.65 820 8990.5420.2222.76E-27kelch-like 2, Mayven [Source:MGI Symbol;Acc:MGI:1 924 363]
Grb141.01E-310.4 093 8340.2610.0323.28E-27growth factor receptor bound protein 14 [Source:MGI Symbol;Acc:MGI:1 355 324]
Cdc37l11.36E-310.66 387 6890.6830.3694.39E-27cell division cycle 37-like 1 [Source:MGI Symbol;Acc:MGI:1 914 322]
Sorcs12.12E-310.81 115 6190.50.126.85E-27sortilin-related VPS10 domain containing receptor 1 [Source:MGI Symbol;Acc:MGI:1 929 666]
Kctd36.37E-310.43 513 9220.3170.0792.06E-26potassium channel tetramerisation domain containing 3 [Source:MGI Symbol;Acc:MGI:2 444 629]
Tmem63a1.55E-300.30 592 6710.2180.0244.99E-26transmembrane protein 63a [Source:MGI Symbol;Acc:MGI:2 384 789]
Agpat41.74E-300.4 155 8550.3030.0525.61E-261-acylglycerol-3-phosphate O-acyltransferase 4 (lysophosphatidic acid acyltransferase, delta) [Source:MGI Symbol;Acc:MGI:1 915 512]
Ssh21.52E-290.68 483 3430.5560.1984.92E-25slingshot protein phosphatase 2 [Source:MGI Symbol;Acc:MGI:2 679 255]
Ptgds2.16E-290.78 930 2020.5770.3966.98E-25prostaglandin D2 synthase (brain) [Source:MGI Symbol;Acc:MGI:99 261]
Opalin2.55E-290.29 885 5370.2110.0248.24E-25oligodendrocytic myelin paranodal and inner loop protein [Source:MGI Symbol;Acc:MGI:2 657 025]
Gm485083.89E-290.2 522 3650.1620.0051.26E-24predicted gene, 48 508 [Source:MGI Symbol;Acc:MGI:6 098 039]
Cpm7.69E-290.26 961 4350.1760.0112.48E-24carboxypeptidase M [Source:MGI Symbol;Acc:MGI:1 917 824]
Prickle21.51E-280.81 121 3710.7320.3894.87E-24prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
Abca8a2.27E-280.30 631 7360.2110.0127.32E-24ATP-binding cassette, sub-family A (ABC1), member 8a [Source:MGI Symbol;Acc:MGI:2 386 846]
Kndc17.59E-280.38 605 8260.2250.0332.45E-23kinase non-catalytic C-lobe domain (KIND) containing 1 [Source:MGI Symbol;Acc:MGI:1 923 734]
Lpgat11.47E-270.52 009 4610.430.174.76E-23lysophosphatidylglycerol acyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 446 186]
Efnb31.57E-270.33 242 6310.2460.055.06E-23ephrin B3 [Source:MGI Symbol;Acc:MGI:109 196]
Slc8a12.10E-261.08 822 7360.7460.2666.77E-22solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Ubash3b2.74E-260.59 280 7850.4150.1158.85E-22ubiquitin associated and SH3 domain containing, B [Source:MGI Symbol;Acc:MGI:1 920 078]
Dixdc17.79E-260.37 251 0420.2750.0582.51E-21DIX domain containing 1 [Source:MGI Symbol;Acc:MGI:2 679 721]
Rtn49.96E-260.64 795 1080.7610.5273.21E-21reticulon 4 [Source:MGI Symbol;Acc:MGI:1 915 835]
Tmem132d1.74E-250.35 903 8040.2320.035.61E-21transmembrane protein 132D [Source:MGI Symbol;Acc:MGI:3 044 963]
Lrp1b2.41E-250.74 690 3160.930.8177.78E-21low density lipoprotein-related protein 1B [Source:MGI Symbol;Acc:MGI:2 151 136]
Tmem178b3.75E-250.74 144 4540.7040.4041.21E-20transmembrane protein 178B [Source:MGI Symbol;Acc:MGI:3 647 581]
Car24.82E-250.56 411 7070.5420.2781.56E-20carbonic anhydrase 2 [Source:MGI Symbol;Acc:MGI:88 269]
Dock96.04E-250.60 210 9950.6060.3221.95E-20dedicator of cytokinesis 9 [Source:MGI Symbol;Acc:MGI:106 321]
Gab18.06E-250.60 942 8240.5280.2412.60E-20growth factor receptor bound protein 2-associated protein 1 [Source:MGI Symbol;Acc:MGI:108 088]
Trim21.01E-240.67 060 9730.6480.3363.27E-20tripartite motif-containing 2 [Source:MGI Symbol;Acc:MGI:1 933 163]
Gm283761.45E-240.3 902 1970.2250.0174.69E-20predicted gene 28 376 [Source:MGI Symbol;Acc:MGI:5 579 082]
Atp8a11.75E-240.58 217 7910.7250.4545.64E-20ATPase, aminophospholipid transporter (APLT), class I, type 8A, member 1 [Source:MGI Symbol;Acc:MGI:1 330 848]
Kif21a2.22E-240.64 239 6680.7540.4277.16E-20kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
1700047M11Rik2.26E-240.33 808 7650.2320.0447.29E-20RIKEN cDNA 1700047M11 gene [Source:MGI Symbol;Acc:MGI:1 914 580]
Rasgrp32.48E-240.32 476 8140.2110.028.02E-20RAS, guanyl releasing protein 3 [Source:MGI Symbol;Acc:MGI:3 028 579]
Gm42584.16E-240.63 782 3750.5630.2521.34E-19predicted gene 4258 [Source:MGI Symbol;Acc:MGI:3 782 435]
Dip2b4.33E-240.58 787 8750.6060.3651.40E-19disco interacting protein 2 homolog B [Source:MGI Symbol;Acc:MGI:2 145 977]
Elovl71.48E-230.30 062 5330.2250.0264.79E-19ELOVL family member 7, elongation of long chain fatty acids (yeast) [Source:MGI Symbol;Acc:MGI:1 921 809]
Tenm21.85E-230.63 263 0640.4790.2445.96E-19teneurin transmembrane protein 2 [Source:MGI Symbol;Acc:MGI:1 345 184]
Rcbtb12.41E-230.42 611 2480.3310.127.78E-19regulator of chromosome condensation (RCC1) and BTB (POZ) domain containing protein 1 [Source:MGI Symbol;Acc:MGI:1 918 580]
Pacs21.61E-220.40 374 9690.3590.1215.20E-18phosphofurin acidic cluster sorting protein 2 [Source:MGI Symbol;Acc:MGI:1 924 399]
Inpp5f2.18E-220.43 895 6510.3730.1527.05E-18inositol polyphosphate-5-phosphatase F [Source:MGI Symbol;Acc:MGI:2 141 867]
Kcnab12.87E-220.52 369 3830.4440.1339.27E-18potassium voltage-gated channel, shaker-related subfamily, beta member 1 [Source:MGI Symbol;Acc:MGI:109 155]
Snx303.23E-220.36 229 5220.2960.0571.04E-17sorting nexin family member 30 [Source:MGI Symbol;Acc:MGI:2 443 882]
Nbas3.59E-220.46 269 9510.50.2231.16E-17neuroblastoma amplified sequence [Source:MGI Symbol;Acc:MGI:1 918 419]
Fign8.79E-220.42 219 0880.2680.0282.84E-17fidgetin [Source:MGI Symbol;Acc:MGI:1 890 647]
Dgki9.62E-220.80 427 9610.6340.2773.11E-17diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Jph19.64E-220.25 605 1770.2040.0253.11E-17junctophilin 1 [Source:MGI Symbol;Acc:MGI:1 891 495]
Prkcq1.26E-210.2 556 6030.2040.0274.06E-17protein kinase C, theta [Source:MGI Symbol;Acc:MGI:97 601]
Smad71.48E-210.3 719 7710.3240.0964.78E-17SMAD family member 7 [Source:MGI Symbol;Acc:MGI:1 100 518]
Kif13a1.69E-210.53 230 7980.5490.2685.45E-17kinesin family member 13A [Source:MGI Symbol;Acc:MGI:1 098 264]
Rftn11.78E-210.26 476 3140.1620.0195.75E-17raftlin lipid raft linker 1 [Source:MGI Symbol;Acc:MGI:1 923 688]
4930420G21Rik1.96E-210.30 770 5490.1760.0016.32E-17RIKEN cDNA 4930420G21 gene [Source:MGI Symbol;Acc:MGI:1 926 174]
Lpar12.02E-210.25 219 6870.1970.0286.51E-17lysophosphatidic acid receptor 1 [Source:MGI Symbol;Acc:MGI:108 429]
Clasp26.71E-210.62 845 5450.8380.6692.16E-16CLIP associating protein 2 [Source:MGI Symbol;Acc:MGI:1 923 749]
Stmn41.51E-200.39 314 1710.3030.0974.88E-16stathmin-like 4 [Source:MGI Symbol;Acc:MGI:1 931 224]
Il332.18E-200.45 476 1030.3380.1127.04E-16interleukin 33 [Source:MGI Symbol;Acc:MGI:1 924 375]
Opcml3.18E-200.63 576 0150.5560.3231.03E-15opioid binding protein/cell adhesion molecule-like [Source:MGI Symbol;Acc:MGI:97 397]
Mbnl23.25E-200.59 288 2240.8380.5961.05E-15muscleblind like splicing factor 2 [Source:MGI Symbol;Acc:MGI:2 145 597]
Ttll55.13E-200.44 199 4730.4720.1831.66E-15tubulin tyrosine ligase-like family, member 5 [Source:MGI Symbol;Acc:MGI:2 443 657]
Itpk16.27E-200.40 133 3660.3520.1172.02E-15inositol 1,3,4-triphosphate 5/6 kinase [Source:MGI Symbol;Acc:MGI:2 446 159]
Jakmip37.34E-200.25 099 9910.1620.0172.37E-15janus kinase and microtubule interacting protein 3 [Source:MGI Symbol;Acc:MGI:1 921 254]
Ppp1cc9.20E-200.38 432 9670.2890.0982.97E-15protein phosphatase 1 catalytic subunit gamma [Source:MGI Symbol;Acc:MGI:104 872]
Sez6l21.10E-190.36 167 9540.3380.1163.55E-15seizure related 6 homolog like 2 [Source:MGI Symbol;Acc:MGI:2 385 295]
Adamtsl12.14E-190.30 111 1080.3520.0756.91E-15ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
Aatk3.55E-190.50 286 0640.5990.2741.15E-14apoptosis-associated tyrosine kinase [Source:MGI Symbol;Acc:MGI:1 197 518]
Nfe2l35.30E-190.25 950 2370.1970.0271.71E-14nuclear factor, erythroid derived 2, like 3 [Source:MGI Symbol;Acc:MGI:1 339 958]
Dip2a7.75E-190.39 330 7940.3380.1282.50E-14disco interacting protein 2 homolog A [Source:MGI Symbol;Acc:MGI:2 385 920]
App8.63E-190.57 992 0890.7610.5392.79E-14amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Tmod29.60E-190.50 543 3440.5850.3543.10E-14tropomodulin 2 [Source:MGI Symbol;Acc:MGI:1 355 335]
Nbea1.14E-180.55 141 5480.7180.5273.68E-14neurobeachin [Source:MGI Symbol;Acc:MGI:1 347 075]
Grm31.15E-180.49 127 6030.8170.5333.70E-14glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Tcf121.77E-180.49 589 4460.7610.5615.70E-14transcription factor 12 [Source:MGI Symbol;Acc:MGI:101 877]
Nfasc1.91E-180.35 074 2820.620.46.16E-14neurofascin [Source:MGI Symbol;Acc:MGI:104 753]
Tmem1173.88E-180.40 506 2310.2960.0891.25E-13transmembrane protein 117 [Source:MGI Symbol;Acc:MGI:2 444 580]
Arrdc34.42E-180.29 785 6180.2820.0771.43E-13arrestin domain containing 3 [Source:MGI Symbol;Acc:MGI:2 145 242]
Qk4.48E-180.53 794 0640.9720.9431.45E-13NA
Arhgap394.73E-180.47 953 3330.4440.1461.53E-13Rho GTPase activating protein 39 [Source:MGI Symbol;Acc:MGI:107 858]
Lrrc8b8.33E-180.32 156 3340.2750.0652.69E-13leucine rich repeat containing 8 family, member B [Source:MGI Symbol;Acc:MGI:2 141 353]
Pacrg1.41E-170.71 534 1720.6060.3284.55E-13PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Cipc1.41E-170.40 268 3330.4080.2154.56E-13CLOCK interacting protein, circadian [Source:MGI Symbol;Acc:MGI:1 919 185]
Cdk192.11E-170.59 985 4530.7460.4696.80E-13cyclin-dependent kinase 19 [Source:MGI Symbol;Acc:MGI:1 925 584]
Apba13.45E-170.47 134 4710.4010.1471.12E-12amyloid beta (A4) precursor protein binding, family A, member 1 [Source:MGI Symbol;Acc:MGI:1 860 297]
Kcna13.87E-170.34 416 2440.3170.0941.25E-12potassium voltage-gated channel, shaker-related subfamily, member 1 [Source:MGI Symbol;Acc:MGI:96 654]
Prkcz4.84E-170.32 116 0270.2890.0931.56E-12protein kinase C, zeta [Source:MGI Symbol;Acc:MGI:97 602]
9330182L06Rik4.86E-170.29 562 8380.2320.0581.57E-12NA
Ube2d18.60E-170.29 694 1920.2540.0792.78E-12ubiquitin-conjugating enzyme E2D 1 [Source:MGI Symbol;Acc:MGI:2 384 911]
Dpy19l11.64E-160.33 789 7630.2890.15.29E-12dpy-19-like 1 (C. elegans) [Source:MGI Symbol;Acc:MGI:1 915 685]
1500004A13Rik3.15E-160.37 441 6140.430.1931.02E-11RIKEN cDNA 1500004A13 gene [Source:MGI Symbol;Acc:MGI:2 442 808]
Kazn3.33E-160.25 772 9650.2540.0711.08E-11kazrin, periplakin interacting protein [Source:MGI Symbol;Acc:MGI:1 918 779]
Ccp1104.68E-160.26 463 5820.2180.071.51E-11centriolar coiled coil protein 110 [Source:MGI Symbol;Acc:MGI:2 141 942]
Robo14.70E-160.59 124 2020.5560.3881.52E-11roundabout guidance receptor 1 [Source:MGI Symbol;Acc:MGI:1 274 781]
Sorcs37.52E-160.34 798 2850.2750.0692.43E-11sortilin-related VPS10 domain containing receptor 3 [Source:MGI Symbol;Acc:MGI:1 913 923]
Dlg27.57E-160.66 353 4290.8730.6082.44E-11discs large MAGUK scaffold protein 2 [Source:MGI Symbol;Acc:MGI:1 344 351]
Phactr11.20E-150.52 911 6610.7320.463.87E-11phosphatase and actin regulator 1 [Source:MGI Symbol;Acc:MGI:2 659 021]
Cobl1.33E-150.3 222 9750.2180.0594.28E-11cordon-bleu WH2 repeat [Source:MGI Symbol;Acc:MGI:105 056]
Pcdh151.33E-150.43 452 6530.2250.1174.29E-11protocadherin 15 [Source:MGI Symbol;Acc:MGI:1 891 428]
Ralgps12.05E-150.41 133 6380.4370.2136.62E-11Ral GEF with PH domain and SH3 binding motif 1 [Source:MGI Symbol;Acc:MGI:1 922 008]
Ppfibp22.54E-150.35 273 1630.3940.1588.20E-11PTPRF interacting protein, binding protein 2 (liprin beta 2) [Source:MGI Symbol;Acc:MGI:894 649]
Ube2e23.46E-150.53 184 9220.7540.4941.12E-10ubiquitin-conjugating enzyme E2E 2 [Source:MGI Symbol;Acc:MGI:2 384 997]
Olfml14.70E-150.28 671 0910.2390.0691.52E-10olfactomedin-like 1 [Source:MGI Symbol;Acc:MGI:2 679 264]
Jam37.35E-150.2 902 0260.2750.0752.37E-10junction adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 933 825]
Dleu29.17E-150.49 958 3780.5770.2532.96E-10deleted in lymphocytic leukemia, 2 [Source:MGI Symbol;Acc:MGI:1 934 030]
Cobll11.02E-140.33 155 7310.310.0973.31E-10Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Tnfaip61.75E-140.26 196 3610.1690.0315.66E-10tumor necrosis factor alpha induced protein 6 [Source:MGI Symbol;Acc:MGI:1 195 266]
Grm71.98E-140.75 582 8590.5070.2526.38E-10glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Wnk12.81E-140.44 146 8250.690.4769.08E-10WNK lysine deficient protein kinase 1 [Source:MGI Symbol;Acc:MGI:2 442 092]
Galnt73.18E-140.34 120 7010.2750.0781.03E-09polypeptide N-acetylgalactosaminyltransferase 7 [Source:MGI Symbol;Acc:MGI:1 349 449]
Dlg13.25E-140.47 381 5360.6270.431.05E-09discs large MAGUK scaffold protein 1 [Source:MGI Symbol;Acc:MGI:107 231]
Ttyh24.00E-140.30 576 1960.3730.1681.29E-09tweety family member 2 [Source:MGI Symbol;Acc:MGI:2 157 091]
Kif64.36E-140.26 052 7370.1970.0271.41E-09kinesin family member 6 [Source:MGI Symbol;Acc:MGI:1 098 238]
Sytl24.73E-140.29 329 8070.2320.0531.53E -09synaptotagmin-like 2 [Source:MGI Symbol;Acc:MGI:1 933 366]
Tmcc15.11E-140.49 862 9240.7390.5391.65E-09transmembrane and coiled coil domains 1 [Source:MGI Symbol;Acc:MGI:2 442 368]
Pip4k2a6.16E-140.40 115 8480.5140.2981.99E-09phosphatidylinositol-5-phosphate 4-kinase, type II, alpha [Source:MGI Symbol;Acc:MGI:1 298 206]
Tulp46.52E-140.47 631 8820.6340.4112.10E-09tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Dpyd6.89E-140.40 904 6820.4230.2772.23E-09dihydropyrimidine dehydrogenase [Source:MGI Symbol;Acc:MGI:2 139 667]
Rere8.76E-140.46 371 6460.7750.6032.83E-09arginine glutamic acid dipeptide (RE) repeats [Source:MGI Symbol;Acc:MGI:2 683 486]
Klf138.90E-140.35 945 1720.3870.1712.87E-09Kruppel-like factor 13 [Source:MGI Symbol;Acc:MGI:1 354 948]
Picalm1.00E-130.38 008 8280.4650.2183.23E-09phosphatidylinositol binding clathrin assembly protein [Source:MGI Symbol;Acc:MGI:2 385 902]
Abca21.07E-130.3 176 4730.3170.1383.47E-09ATP-binding cassette, sub-family A (ABC1), member 2 [Source:MGI Symbol;Acc:MGI:99 606]
Schip11.19E-130.41 507 8190.6130.3613.84E-09schwannomin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 353 557]
Trim351.19E-130.33 581 6820.3380.1433.85E-09tripartite motif-containing 35 [Source:MGI Symbol;Acc:MGI:1 914 104]
Sik31.26E-130.55 695 0360.810.6624.08E-09SIK family kinase 3 [Source:MGI Symbol;Acc:MGI:2 446 296]
Dscam1.81E-130.35 722 6750.1690.0875.84E-09DS cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 196 281]
Gas71.93E-130.31 931 1760.2680.1016.24E-09growth arrest specific 7 [Source:MGI Symbol;Acc:MGI:1 202 388]
Map4k52.07E-130.35 137 5910.3870.26.69E-09mitogen-activated protein kinase kinase kinase kinase 5 [Source:MGI Symbol;Acc:MGI:1 925 503]
Ptk22.31E-130.46 037 8210.7180.5357.46E-09PTK2 protein tyrosine kinase 2 [Source:MGI Symbol;Acc:MGI:95 481]
Rab312.35E-130.51 587 3040.5770.3887.58E-09RAB31, member RAS oncogene family [Source:MGI Symbol;Acc:MGI:1 914 603]
Cerk2.67E-130.30 557 3820.3240.1088.62E-09ceramide kinase [Source:MGI Symbol;Acc:MGI:2 386 052]
Chn22.83E-130.28 594 9570.1760.0239.13E-09chimerin 2 [Source:MGI Symbol;Acc:MGI:1 917 243]
Epb41l33.41E-130.3 103 6420.3170.1431.10E-08erythrocyte membrane protein band 4.1 like 3 [Source:MGI Symbol;Acc:MGI:103 008]
Naaladl23.52E-130.59 644 9580.6480.3491.14E-08N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Fam102a5.93E-130.27 780 9080.2610.1021.92E-08family with sequence similarity 102, member A [Source:MGI Symbol;Acc:MGI:2 138 935]
Slc38a26.77E-130.33 572 3820.310.1522.19E-08solute carrier family 38, member 2 [Source:MGI Symbol;Acc:MGI:1 915 010]
St6gal17.93E-130.48 959 3820.4860.252.56E-08beta galactoside alpha 2,6 sialyltransferase 1 [Source:MGI Symbol;Acc:MGI:108 470]
Tanc18.90E-130.26 089 0240.190.0632.87E-08tetratricopeptide repeat, ankyrin repeat and coiled-coil containing 1 [Source:MGI Symbol;Acc:MGI:1 914 110]
Rassf29.55E-130.31 791 0160.310.1183.08E-08Ras association (RalGDS/AF-6) domain family member 2 [Source:MGI Symbol;Acc:MGI:2 442 060]
Epn21.30E-120.40 804 8350.4010.2434.21E-08epsin 2 [Source:MGI Symbol;Acc:MGI:1 333 766]
Usp311.39E-120.28 668 2090.2890.0974.49E-08ubiquitin specific peptidase 31 [Source:MGI Symbol;Acc:MGI:1 923 429]
Enox11.48E-120.64 119 8450.6410.2914.77E-08ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Pbx31.60E-120.36 348 6690.2180.0825.18E-08pre B cell leukemia homeobox 3 [Source:MGI Symbol;Acc:MGI:97 496]
Lrrc8d1.69E-120.26 743 0180.2680.0675.46E-08leucine rich repeat containing 8D [Source:MGI Symbol;Acc:MGI:1 922 368]
Kctd131.89E-120.25 910 8240.2320.0716.12E-08potassium channel tetramerisation domain containing 13 [Source:MGI Symbol;Acc:MGI:1 923 739]
Wipf12.10E-120.42 212 8350.4720.2256.79E-08WAS/WASL interacting protein family, member 1 [Source:MGI Symbol;Acc:MGI:2 178 801]
Fmnl22.98E-120.50 797 6460.810.5629.62E-08formin-like 2 [Source:MGI Symbol;Acc:MGI:1 918 659]
Ralyl3.13E-120.37 461 3310.3590.1971.01E-07RALY RNA binding protein-like [Source:MGI Symbol;Acc:MGI:1 924 147]
Snrnp484.35E-120.30 167 1090.380.1631.40E-07small nuclear ribonucleoprotein 48 (U11/U12) [Source:MGI Symbol;Acc:MGI:1 915 047]
Apbb25.86E-120.37 732 9760.50.2681.89E-07amyloid beta (A4) precursor protein-binding, family B, member 2 [Source:MGI Symbol;Acc:MGI:108 405]
St3gal38.35E-120.33 765 2660.3870.2122.70E-07ST3 beta-galactoside alpha-2,3-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 316 659]
Hipk29.23E-120.42 920 2630.6970.4812.98E-07homeodomain interacting protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 314 872]
Zfp6381.00E-110.39 071 8480.6060.3823.23E-07zinc finger protein 638 [Source:MGI Symbol;Acc:MGI:1 203 484]
Bcl2l11.02E-110.37 843 4610.3870.2093.30E-07BCL2-like 1 [Source:MGI Symbol;Acc:MGI:88 139]
Plaat31.10E-110.2 560 6220.2460.0833.54E-07phospholipase A and acyltransferase 3 [Source:MGI Symbol;Acc:MGI:2 179 715]
Pkp41.53E-110.42 997 3950.5140.2794.95E-07plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Dst2.29E-110.41 891 4810.8380.6347.38E-07dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Snx12.37E-110.26 798 7520.2610.0947.65E-07sorting nexin 1 [Source:MGI Symbol;Acc:MGI:1 928 395]
Itsn23.99E-110.3 832 3910.5630.3131.29E-06intersectin 2 [Source:MGI Symbol;Acc:MGI:1 338 049]
Itch4.64E-110.34 894 2160.5560.3511.50E-06itchy, E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 202 301]
Ankib16.01E-110.32 551 4010.380.1871.94E-06ankyrin repeat and IBR domain containing 1 [Source:MGI Symbol;Acc:MGI:1 918 047]
Rapgef57.30E-110.28 518 1350.2040.0782.36E-06Rap guanine nucleotide exchange factor (GEF) 5 [Source:MGI Symbol;Acc:MGI:2 444 365]
Alcam7.37E-110.49 777 9240.5770.4922.38E-06activated leukocyte cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 313 266]
Slc25a278.64E-110.25 283 8640.2540.1062.79E-06solute carrier family 25, member 27 [Source:MGI Symbol;Acc:MGI:1 921 261]
Ppp2r3a1.54E-100.37 290 2470.5420.3684.96E-06protein phosphatase 2, regulatory subunit B'', alpha [Source:MGI Symbol;Acc:MGI:2 442 104]
Foxp11.58E-100.36 946 8910.6340.4465.11E-06forkhead box P1 [Source:MGI Symbol;Acc:MGI:1 914 004]
Sh3kbp11.76E-100.32 577 3130.3310.1455.69E-06SH3-domain kinase binding protein 1 [Source:MGI Symbol;Acc:MGI:1 889 583]
Oxr12.01E-100.43 543 6510.6480.4026.48E-06oxidation resistance 1 [Source:MGI Symbol;Acc:MGI:2 179 326]
Ppp1r212.34E-100.26 332 9970.2890.1297.54E-06protein phosphatase 1, regulatory subunit 21 [Source:MGI Symbol;Acc:MGI:1 921 075]
Elavl32.44E-100.30 396 8320.3030.1437.88E-06ELAV like RNA binding protein 3 [Source:MGI Symbol;Acc:MGI:109 157]
Clic42.45E-100.28 194 3690.4080.2327.90E-06chloride intracellular channel 4 (mitochondrial) [Source:MGI Symbol;Acc:MGI:1 352 754]
Dnajc62.62E-100.29 955 5620.2390.1098.44E-06DnaJ heat shock protein family (Hsp40) member C6 [Source:MGI Symbol;Acc:MGI:1 919 935]
Ncam12.62E-100.3 620 7210.8730.7798.45E-06neural cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:97 281]
Gm485122.85E-100.31 683 1480.310.1069.19E-06predicted gene, 48 512 [Source:MGI Symbol;Acc:MGI:6 098 046]
Usp547.29E-100.35 238 7250.4580.3172.35E-05ubiquitin specific peptidase 54 [Source:MGI Symbol;Acc:MGI:1 926 037]
Mtss19.29E-100.25 566 7840.2610.1143.00E-05MTSS I-BAR domain containing 1 [Source:MGI Symbol;Acc:MGI:2 384 818]
Kat2b1.19E-090.31 444 9630.4230.2243.85E-05K(lysine) acetyltransferase 2B [Source:MGI Symbol;Acc:MGI:1 343 094]
Dpysl21.24E-090.3 221 7760.5490.3434.00E-05dihydropyrimidinase-like 2 [Source:MGI Symbol;Acc:MGI:1 349 763]
Gna121.28E-090.29 101 1180.380.1754.14E-05guanine nucleotide binding protein, alpha 12 [Source:MGI Symbol;Acc:MGI:95 767]
Ywhaq1.52E-090.30 001 3210.4150.2214.92E-05tyrosine 3-monooxygenase/tryptophan 5-monooxygenase activation protein theta [Source:MGI Symbol;Acc:MGI:891 963]
Kif1b1.55E-090.36 174 4040.9230.815.01E-05kinesin family member 1B [Source:MGI Symbol;Acc:MGI:108 426]
5031439G07Rik1.55E-090.30 489 7880.5350.3895.02E-05RIKEN cDNA 5031439G07 gene [Source:MGI Symbol;Acc:MGI:2 444 899]
Nrbp21.59E-090.32 356 9840.3940.2155.12E-05nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Ncoa31.61E-090.25 337 7610.2750.1045.19E-05nuclear receptor coactivator 3 [Source:MGI Symbol;Acc:MGI:1 276 535]
Otud7a1.77E-090.50 197 6170.7040.4735.73E-05OTU domain containing 7A [Source:MGI Symbol;Acc:MGI:2 158 505]
Daam11.89E-090.38 269 9520.5630.4046.11E-05dishevelled associated activator of morphogenesis 1 [Source:MGI Symbol;Acc:MGI:1 914 596]
Ankrd284.30E-090.34 478 5890.5560.3650.00 013 897ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Fryl4.33E-090.32 061 0060.570.3320.00 013 975FRY like transcription coactivator [Source:MGI Symbol;Acc:MGI:1 919 563]
Ncam25.63E-090.52 172 6850.7540.5570.00 018 185neural cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:97 282]
Pakap.15.86E-090.25 161 4460.2680.1010.0 001 892NA
Cpeb26.71E-090.27 668 3380.3660.2540.00 021 677cytoplasmic polyadenylation element binding protein 2 [Source:MGI Symbol;Acc:MGI:2 442 640]
Pld17.92E-090.26 934 3650.2610.0930.00 025 557phospholipase D1 [Source:MGI Symbol;Acc:MGI:109 585]
Retreg18.48E-090.28 313 5660.3240.1260.0 002 738reticulophagy regulator 1 [Source:MGI Symbol;Acc:MGI:1 913 520]
Apod8.62E-090.27 079 6840.3450.2130.0 002 784apolipoprotein D [Source:MGI Symbol;Acc:MGI:88 056]
Atp11a1.01E-080.25 199 2730.2820.1510.00 032 617ATPase, class VI, type 11A [Source:MGI Symbol;Acc:MGI:1 354 735]
Sema6a1.31E-080.30 897 1740.2960.1020.00 042 137sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
2610035D17Rik1.51E-080.40 048 9710.5770.4280.00 048 781RIKEN cDNA 2610035D17 gene [Source:MGI Symbol;Acc:MGI:1 919 636]
Baz2b1.57E-080.37 303 6250.6970.5510.00 050 559bromodomain adjacent to zinc finger domain, 2B [Source:MGI Symbol;Acc:MGI:2 442 782]
Wdr202.34E-080.25 520 2230.3380.1590.00 075 438WD repeat domain 20 [Source:MGI Symbol;Acc:MGI:1 916 891]
Cttnbp22.40E-080.32 095 6070.4580.2660.0 007 738cortactin binding protein 2 [Source:MGI Symbol;Acc:MGI:1 353 467]
Osbpl1a2.57E-080.31 900 4890.4930.3250.00 082 996oxysterol binding protein-like 1A [Source:MGI Symbol;Acc:MGI:1 927 551]
Abhd17b2.70E-080.29 402 5890.4650.290.00 087 174abhydrolase domain containing 17B [Source:MGI Symbol;Acc:MGI:1 917 816]
Rnf133.01E-080.27 892 3080.4230.2290.000 972ring finger protein 13 [Source:MGI Symbol;Acc:MGI:1 346 341]
Tmem132b4.93E-080.26 716 1940.2680.1010.00 159 086transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Gnao15.42E-080.3 966 2220.8380.6540.00 175 013guanine nucleotide binding protein, alpha O [Source:MGI Symbol;Acc:MGI:95 775]
Pde1c5.66E-080.25 711 3140.2320.0510.00 182 824phosphodiesterase 1C [Source:MGI Symbol;Acc:MGI:108 413]
Pvt17.44E-080.25 652 9580.310.1540.00 240 229Pvt1 oncogene [Source:MGI Symbol;Acc:MGI:97 824]
Pard38.43E-080.3 133 2860.5920.4540.00 272 182par-3 family cell polarity regulator [Source:MGI Symbol;Acc:MGI:2 135 608]
Malat18.64E-080.26 747 411110.00 279 021metastasis associated lung adenocarcinoma transcript 1 (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 919 539]
Dcc9.55E-080.34 680 7950.50.2940.00 308 213deleted in colorectal carcinoma [Source:MGI Symbol;Acc:MGI:94 869]
Zcchc71.00E-070.32 309 1350.690.50.00 323 528zinc finger, CCHC domain containing 7 [Source:MGI Symbol;Acc:MGI:2 442 912]
Limch11.08E-070.35 675 4480.7390.6320.00 349 991LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Table 1.

Differentially upregulated genes (P value < 0.005) in AG1 in comparison with AG2 and AG3

Genep_valavg_log2FCpct.1pct.2p_val_adjDescription
Tmeff21.96E-2792.190 3530.8660.1716.32E-275transmembrane protein with EGF-like and two follistatin-like domains 2 [Source:MGI Symbol;Acc:MGI:1 861 735]
Slc24a22.18E-2712.39 047 0550.9010.3137.04E-267solute carrier family 24 (sodium/potassium/calcium exchanger), member 2 [Source:MGI Symbol;Acc:MGI:1 923 626]
St186.00E-2471.99 495 0270.8310.0651.94E-242suppression of tumorigenicity 18 [Source:MGI Symbol;Acc:MGI:2 446 700]
Pde4b1.48E-2342.43 293 9180.9580.5184.79E-230phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Edil31.19E-2271.90 688 8690.8380.193.86E-223EGF-like repeats and discoidin I-like domains 3 [Source:MGI Symbol;Acc:MGI:1 329 025]
Zfp5364.61E-2041.59 566 4070.7890.0461.49E-199zinc finger protein 536 [Source:MGI Symbol;Acc:MGI:1 926 102]
Dock102.99E-2021.82 246 2490.8590.1079.65E-198dedicator of cytokinesis 10 [Source:MGI Symbol;Acc:MGI:2 146 320]
Frmd52.29E-1871.91 664 3750.810.1057.40E-183FERM domain containing 5 [Source:MGI Symbol;Acc:MGI:2 442 557]
Pex5l2.43E-1792.1 784 6580.8170.1877.84E-175peroxisomal biogenesis factor 5-like [Source:MGI Symbol;Acc:MGI:1 916 672]
Prr5l8.98E-1642.11 001 0490.8380.0842.90E-159proline rich 5 like [Source:MGI Symbol;Acc:MGI:1 919 696]
Map73.57E-1561.42 866 7840.7390.1551.15E-151microtubule-associated protein 7 [Source:MGI Symbol;Acc:MGI:1 328 328]
Hecw21.21E-1411.3 025 4460.6970.0913.89E-137HECT, C2 and WW domain containing E3 ubiquitin protein ligase 2 [Source:MGI Symbol;Acc:MGI:2 685 817]
Ank35.63E-1311.39 801 6830.8240.2411.82E-126ankyrin 3, epithelial [Source:MGI Symbol;Acc:MGI:88 026]
Mbp3.03E-1221.61 563 5750.8730.3849.80E-118myelin basic protein [Source:MGI Symbol;Acc:MGI:96 925]
Dscaml15.79E-1221.14 094 5760.5920.0311.87E-117DS cell adhesion molecule like 1 [Source:MGI Symbol;Acc:MGI:2 150 309]
Ano42.70E-1201.19 501 1790.6620.0788.70E-116anoctamin 4 [Source:MGI Symbol;Acc:MGI:2 443 344]
Nkain21.23E-1182.459 1050.9230.4793.99E-114Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Plp14.27E-1111.18 847 6230.930.6141.38E-106proteolipid protein (myelin) 1 [Source:MGI Symbol;Acc:MGI:97 623]
Elmo17.68E-1101.49 626 4760.7750.1112.48E-105engulfment and cell motility 1 [Source:MGI Symbol;Acc:MGI:2 153 044]
Plcl15.42E-1091.79 213 8730.9580.5511.75E-104phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Mog5.45E-1050.83 664 2470.5280.0571.76E-100myelin oligodendrocyte glycoprotein [Source:MGI Symbol;Acc:MGI:97 435]
Spock13.35E-1041.06 025 6450.620.1141.08E-99sparc/osteonectin, cwcv and kazal-like domains proteoglycan 1 [Source:MGI Symbol;Acc:MGI:105 371]
C030029H02Rik6.53E-1040.87 497 8050.5350.0132.11E-99RIKEN cDNA C030029H02 gene [Source:MGI Symbol;Acc:MGI:1 924 633]
Bin11.85E-1000.96 607 4690.6760.1355.98E-96bridging integrator 1 [Source:MGI Symbol;Acc:MGI:108 092]
Ptprd1.32E-991.33 071 4840.9790.8424.26E-95protein tyrosine phosphatase, receptor type, D [Source:MGI Symbol;Acc:MGI:97 812]
Mag2.63E-980.8 681 8370.5630.1048.50E-94myelin-associated glycoprotein [Source:MGI Symbol;Acc:MGI:96 912]
Ypel24.47E-980.90 782 6930.5560.0751.44E-93yippee like 2 [Source:MGI Symbol;Acc:MGI:1 925 114]
Ppp1r16b9.04E-981.05 503 1860.5990.0892.92E-93protein phosphatase 1, regulatory subunit 16B [Source:MGI Symbol;Acc:MGI:2 151 841]
D7Ertd443e7.06E-960.95 018 3190.5420.0332.28E-91DNA segment, Chr 7, ERATO Doi 443, expressed [Source:MGI Symbol;Acc:MGI:1 196 431]
Sec14l57.85E-960.8 238 5310.4930.0242.53E-91SEC14-like lipid binding 5 [Source:MGI Symbol;Acc:MGI:3 616 084]
Bcas12.14E-950.8 599 4870.5280.0586.91E-91brain enriched myelin associated protein 1 [Source:MGI Symbol;Acc:MGI:1 924 210]
Plekhh11.69E-930.67 017 4680.4440.0225.46E-89pleckstrin homology domain containing, family H (with MyTH4 domain) member 1 [Source:MGI Symbol;Acc:MGI:2 144 989]
Rnf2203.11E-901.51 733 1620.7390.1521.00E-85ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Fa2h3.38E-870.75 377 5980.4370.031.09E-82fatty acid 2-hydroxylase [Source:MGI Symbol;Acc:MGI:2 443 327]
Gjc31.13E-850.75 679 7550.4720.0353.66E-81gap junction protein, gamma 3 [Source:MGI Symbol;Acc:MGI:2 153 041]
Zeb21.86E-841.28 891 0950.880.536.02E-80zinc finger E-box binding homeobox 2 [Source:MGI Symbol;Acc:MGI:1 344 407]
Agap13.01E-811.00 618 5370.7320.2079.71E-77ArfGAP with GTPase domain, ankyrin repeat and PH domain 1 [Source:MGI Symbol;Acc:MGI:2 653 690]
Ptprk2.86E-791.01 913 2210.6130.0939.23E-75protein tyrosine phosphatase, receptor type, K [Source:MGI Symbol;Acc:MGI:103 310]
Sox2ot4.38E-781.13 822 8030.8660.4751.41E-73SOX2 overlapping transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 112]
A230001M10Rik3.33E-770.72 716 2610.4370.0081.08E-72RIKEN cDNA A230001M10 gene [Source:MGI Symbol;Acc:MGI:2 443 043]
Pakap9.74E-771.0 263 7660.5630.0513.15E-72paralemmin A kinase anchor protein [Source:MGI Symbol;Acc:MGI:5 141 924]
4930419G24Rik1.16E-760.70 591 9710.4150.0173.74E-72RIKEN cDNA 4930419G24 gene [Source:MGI Symbol;Acc:MGI:1 921 124]
Adipor22.95E-761.02 693 2160.5630.1539.52E-72adiponectin receptor 2 [Source:MGI Symbol;Acc:MGI:93 830]
Arhgap234.40E-761.02 552 1970.6690.2341.42E-71Rho GTPase activating protein 23 [Source:MGI Symbol;Acc:MGI:3 697 726]
Phldb11.03E-750.68 383 2940.4720.0653.34E-71pleckstrin homology like domain, family B, member 1 [Source:MGI Symbol;Acc:MGI:2 143 230]
Ugt8a2.30E-750.73 747 8390.4860.0637.42E-71UDP galactosyltransferase 8A [Source:MGI Symbol;Acc:MGI:109 522]
Shtn11.26E-720.71 115 0320.4580.0424.07E-68shootin 1 [Source:MGI Symbol;Acc:MGI:1 918 903]
Pak72.67E-700.8 747 0790.4860.0778.63E-66NA
March16.51E-691.176 5950.6340.0912.10E-64NA
Mobp2.10E-681.06 170 7860.6480.1396.77E-64myelin-associated oligodendrocytic basic protein [Source:MGI Symbol;Acc:MGI:108 511]
Csmd34.28E-671.0 810 8120.8170.4041.38E-62CUB and Sushi multiple domains 3 [Source:MGI Symbol;Acc:MGI:2 386 403]
Slain12.35E-660.61 273 4580.4510.0617.58E-62SLAIN motif family, member 1 [Source:MGI Symbol;Acc:MGI:2 145 578]
A330015K06Rik1.42E-620.64 696 3620.3590.0234.60E-58RIKEN cDNA A330015K06 gene [Source:MGI Symbol;Acc:MGI:2 443 553]
Enpp24.34E-621.01 557 3970.690.2471.40E-57ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
A330049N07Rik1.28E-610.50 447 5180.3170.0124.14E-57RIKEN cDNA A330049N07 gene [Source:MGI Symbol;Acc:MGI:3 041 175]
Slco3a12.53E-610.71 425 8820.430.0658.17E-57solute carrier organic anion transporter family, member 3a1 [Source:MGI Symbol;Acc:MGI:1 351 867]
Mapt3.51E-611.03 710 9950.8240.441.13E-56microtubule-associated protein tau [Source:MGI Symbol;Acc:MGI:97 180]
Neat19.26E-610.90 096 1160.8730.532.99E-56nuclear paraspeckle assembly transcript 1 (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 914 211]
Sox101.48E-600.48 456 8920.3170.0124.78E-56SRY (sex determining region Y)-box 10 [Source:MGI Symbol;Acc:MGI:98 358]
Sh3d192.37E-600.73 672 3660.4580.0527.64E-56SH3 domain protein D19 [Source:MGI Symbol;Acc:MGI:1 350 923]
Aspa2.86E-600.83 141 4260.5630.1259.23E-56aspartoacylase [Source:MGI Symbol;Acc:MGI:87 914]
St6galnac39.88E-591.36 442 6560.8310.1693.19E-54ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Dnm32.80E-581.08 067 8960.7960.3129.05E-54dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Mast46.02E-581.17 111 1780.9230.6621.94E-53microtubule associated serine/threonine kinase family member 4 [Source:MGI Symbol;Acc:MGI:1 918 885]
Spock31.06E-550.82 781 5740.50.1463.42E-51sparc/osteonectin, cwcv and kazal-like domains proteoglycan 3 [Source:MGI Symbol;Acc:MGI:1 920 152]
Tspan21.59E-550.53 547 8250.3870.0425.14E-51tetraspanin 2 [Source:MGI Symbol;Acc:MGI:1 917 997]
Pstpip27.48E-550.6 397 3930.3520.0272.41E-50proline-serine-threonine phosphatase-interacting protein 2 [Source:MGI Symbol;Acc:MGI:1 335 088]
Myo1d2.03E-530.5 941 8160.3380.0196.54E-49myosin ID [Source:MGI Symbol;Acc:MGI:107 728]
Trf2.50E-520.74 161 8910.570.2238.09E-48transferrin [Source:MGI Symbol;Acc:MGI:98 821]
Gm374596.58E-510.47 492 8590.2890.0132.12E-46predicted gene, 37 459 [Source:MGI Symbol;Acc:MGI:5 610 687]
Gatm3.61E-490.6 767 9770.5490.1621.17E-44glycine amidinotransferase (L-arginine:glycine amidinotransferase) [Source:MGI Symbol;Acc:MGI:1 914 342]
Tbc1d52.37E-470.96 314 2080.7820.3937.67E-43TBC1 domain family, member 5 [Source:MGI Symbol;Acc:MGI:1 919 488]
Arhgef104.17E-470.61 505 5650.4720.0961.35E-42Rho guanine nucleotide exchange factor (GEF) 10 [Source:MGI Symbol;Acc:MGI:2 444 453]
Magi28.29E-470.76 494 3460.9930.9582.68E-42membrane associated guanylate kinase, WW and PDZ domain containing 2 [Source:MGI Symbol;Acc:MGI:1 354 953]
Frmd4b3.84E-460.83 612 7370.5560.1141.24E-41FERM domain containing 4B [Source:MGI Symbol;Acc:MGI:2 141 794]
Slc25a131.13E-450.47 421 7710.2820.0233.66E-41solute carrier family 25 (mitochondrial carrier, adenine nucleotide translocator), member 13 [Source:MGI Symbol;Acc:MGI:1 354 721]
Mast31.21E-450.54 141 4790.3940.0613.91E-41microtubule associated serine/threonine kinase 3 [Source:MGI Symbol;Acc:MGI:2 683 541]
9330111N05Rik2.85E-450.86 924 3090.2390.029.20E-41RIKEN cDNA 9330111N05 gene [Source:MGI Symbol;Acc:MGI:2 443 112]
Plxdc22.90E-450.99 119 4110.6970.2899.37E-41plexin domain containing 2 [Source:MGI Symbol;Acc:MGI:1 914 698]
Hapln21.55E-420.42 343 6150.3030.0445.01E-38hyaluronan and proteoglycan link protein 2 [Source:MGI Symbol;Acc:MGI:2 137 300]
Pls11.69E-420.48 138 9080.3310.0365.45E-38plastin 1 (I-isoform) [Source:MGI Symbol;Acc:MGI:104 809]
Zdhhc201.12E-410.71 868 9140.6480.2713.63E-37zinc finger, DHHC domain containing 20 [Source:MGI Symbol;Acc:MGI:1 923 215]
Kif13b1.84E-410.65 625 5650.5920.2235.93E-37kinesin family member 13B [Source:MGI Symbol;Acc:MGI:1 098 265]
Nkain17.94E-410.39 682 3360.2750.022.56E-36Na+/K + transporting ATPase interacting 1 [Source:MGI Symbol;Acc:MGI:1 914 399]
Erbin1.15E-400.86 650 2980.7040.3183.73E-36Erbb2 interacting protein [Source:MGI Symbol;Acc:MGI:1 890 169]
Fnbp11.39E-390.87 125 7280.8730.7124.50E-35formin binding protein 1 [Source:MGI Symbol;Acc:MGI:109 606]
Ttll72.04E-390.60 669 7220.4790.1496.58E-35tubulin tyrosine ligase-like family, member 7 [Source:MGI Symbol;Acc:MGI:1 918 142]
Srcin12.73E-390.51 518 0350.4230.0938.83E-35SRC kinase signaling inhibitor 1 [Source:MGI Symbol;Acc:MGI:1 933 179]
Zdhhc144.12E-390.68 121 4790.5490.1531.33E-34zinc finger, DHHC domain containing 14 [Source:MGI Symbol;Acc:MGI:2 653 229]
Arsg8.39E-390.38 634 5390.2680.0222.71E-34arylsulfatase G [Source:MGI Symbol;Acc:MGI:1 921 258]
Gm424131.02E-380.3 871 6350.2680.0283.31E-34predicted gene, 42 413 [Source:MGI Symbol;Acc:MGI:5 648 986]
Tubb4a1.15E-380.54 604 1650.4580.1333.72E-34tubulin, beta 4A class IVA [Source:MGI Symbol;Acc:MGI:107 848]
Slc12a21.22E-380.58 801 6450.5210.1353.94E-34solute carrier family 12, member 2 [Source:MGI Symbol;Acc:MGI:101 924]
Gm161682.12E-380.87 079 4980.5990.2056.86E-34predicted gene 16 168 [Source:MGI Symbol;Acc:MGI:3 802 010]
Pcdh92.68E-380.97 488 42210.9848.66E-34protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Pik3c2b4.28E-380.37 728 2020.2460.0241.38E-33phosphatidylinositol-4-phosphate 3-kinase catalytic subunit type 2 beta [Source:MGI Symbol;Acc:MGI:2 685 045]
4930511M06Rik1.11E-370.3 310 7130.2540.0183.60E-33RIKEN cDNA 4930511M06 gene [Source:MGI Symbol;Acc:MGI:1 922 334]
Cdc42bpa2.23E-370.78 839 3340.810.5737.19E-33CDC42 binding protein kinase alpha [Source:MGI Symbol;Acc:MGI:2 441 841]
Sept42.64E-370.54 089 8980.4650.1378.53E-33NA
Ninj23.79E-370.51 902 0610.3030.0231.22E-32ninjurin 2 [Source:MGI Symbol;Acc:MGI:1 352 751]
Kcnk134.12E-370.43 764 7880.2820.0271.33E-32potassium channel, subfamily K, member 13 [Source:MGI Symbol;Acc:MGI:2 384 976]
Unc5c6.43E-371.11 147 0440.7390.2122.08E-32unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Gm195002.08E-360.30 602 4910.2110.0086.72E-32predicted gene, 19 500 [Source:MGI Symbol;Acc:MGI:5 011 685]
Il1rap2.56E-360.57 608 2550.4150.0768.25E-32interleukin 1 receptor accessory protein [Source:MGI Symbol;Acc:MGI:104 975]
Vmp15.27E-360.66 465 0540.5770.2511.70E-31vacuole membrane protein 1 [Source:MGI Symbol;Acc:MGI:1 923 159]
Anln1.38E-350.48 487 9750.3030.0574.46E-31anillin, actin binding protein [Source:MGI Symbol;Acc:MGI:1 920 174]
Tmeff14.17E-350.51 360 5280.3450.0751.35E-30transmembrane protein with EGF-like and two follistatin-like domains 1 [Source:MGI Symbol;Acc:MGI:1 926 810]
Pak14.91E-350.62 796 5020.6270.2151.58E-30p21 (RAC1) activated kinase 1 [Source:MGI Symbol;Acc:MGI:1 339 975]
Sept71.27E-340.73 987 8470.7750.4714.09E-30NA
Creb51.29E-340.56 432 8150.3870.0414.18E-30cAMP responsive element binding protein 5 [Source:MGI Symbol;Acc:MGI:2 443 973]
Eml11.29E-340.56 745 0440.3520.0834.18E-30echinoderm microtubule associated protein like 1 [Source:MGI Symbol;Acc:MGI:1 915 769]
Slc44a13.97E-340.58 788 5490.4860.1261.28E-29solute carrier family 44, member 1 [Source:MGI Symbol;Acc:MGI:2 140 592]
Exoc6b5.55E-340.73 711 6010.7390.4411.79E-29exocyst complex component 6B [Source:MGI Symbol;Acc:MGI:1 923 164]
Pde8a1.37E-330.68 761 1450.4580.0944.42E-29phosphodiesterase 8A [Source:MGI Symbol;Acc:MGI:1 277 116]
Phlpp11.83E-330.81 013 8890.9720.7765.92E-29PH domain and leucine rich repeat protein phosphatase 1 [Source:MGI Symbol;Acc:MGI:2 138 327]
Synj23.19E-330.37 727 9530.3030.0491.03E-28synaptojanin 2 [Source:MGI Symbol;Acc:MGI:1 201 671]
Gm427563.27E-330.33 667 0230.2040.0041.05E-28predicted gene 42 756 [Source:MGI Symbol;Acc:MGI:5 662 893]
Rffl4.32E-330.53 223 0760.3870.0651.39E-28ring finger and FYVE like domain containing protein [Source:MGI Symbol;Acc:MGI:1 914 588]
Cntn21.03E-320.40 649 6330.2820.0443.31E-28contactin 2 [Source:MGI Symbol;Acc:MGI:104 518]
Litaf1.69E-320.40 625 2680.2890.0495.44E-28LPS-induced TN factor [Source:MGI Symbol;Acc:MGI:1 929 512]
Anks1b3.33E-320.75 156 8140.5210.2561.08E-27ankyrin repeat and sterile alpha motif domain containing 1B [Source:MGI Symbol;Acc:MGI:1 924 781]
Otud7b7.11E-320.65 083 1440.5630.2222.29E-27OTU domain containing 7B [Source:MGI Symbol;Acc:MGI:2 654 703]
Klhl28.54E-320.65 820 8990.5420.2222.76E-27kelch-like 2, Mayven [Source:MGI Symbol;Acc:MGI:1 924 363]
Grb141.01E-310.4 093 8340.2610.0323.28E-27growth factor receptor bound protein 14 [Source:MGI Symbol;Acc:MGI:1 355 324]
Cdc37l11.36E-310.66 387 6890.6830.3694.39E-27cell division cycle 37-like 1 [Source:MGI Symbol;Acc:MGI:1 914 322]
Sorcs12.12E-310.81 115 6190.50.126.85E-27sortilin-related VPS10 domain containing receptor 1 [Source:MGI Symbol;Acc:MGI:1 929 666]
Kctd36.37E-310.43 513 9220.3170.0792.06E-26potassium channel tetramerisation domain containing 3 [Source:MGI Symbol;Acc:MGI:2 444 629]
Tmem63a1.55E-300.30 592 6710.2180.0244.99E-26transmembrane protein 63a [Source:MGI Symbol;Acc:MGI:2 384 789]
Agpat41.74E-300.4 155 8550.3030.0525.61E-261-acylglycerol-3-phosphate O-acyltransferase 4 (lysophosphatidic acid acyltransferase, delta) [Source:MGI Symbol;Acc:MGI:1 915 512]
Ssh21.52E-290.68 483 3430.5560.1984.92E-25slingshot protein phosphatase 2 [Source:MGI Symbol;Acc:MGI:2 679 255]
Ptgds2.16E-290.78 930 2020.5770.3966.98E-25prostaglandin D2 synthase (brain) [Source:MGI Symbol;Acc:MGI:99 261]
Opalin2.55E-290.29 885 5370.2110.0248.24E-25oligodendrocytic myelin paranodal and inner loop protein [Source:MGI Symbol;Acc:MGI:2 657 025]
Gm485083.89E-290.2 522 3650.1620.0051.26E-24predicted gene, 48 508 [Source:MGI Symbol;Acc:MGI:6 098 039]
Cpm7.69E-290.26 961 4350.1760.0112.48E-24carboxypeptidase M [Source:MGI Symbol;Acc:MGI:1 917 824]
Prickle21.51E-280.81 121 3710.7320.3894.87E-24prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
Abca8a2.27E-280.30 631 7360.2110.0127.32E-24ATP-binding cassette, sub-family A (ABC1), member 8a [Source:MGI Symbol;Acc:MGI:2 386 846]
Kndc17.59E-280.38 605 8260.2250.0332.45E-23kinase non-catalytic C-lobe domain (KIND) containing 1 [Source:MGI Symbol;Acc:MGI:1 923 734]
Lpgat11.47E-270.52 009 4610.430.174.76E-23lysophosphatidylglycerol acyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 446 186]
Efnb31.57E-270.33 242 6310.2460.055.06E-23ephrin B3 [Source:MGI Symbol;Acc:MGI:109 196]
Slc8a12.10E-261.08 822 7360.7460.2666.77E-22solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Ubash3b2.74E-260.59 280 7850.4150.1158.85E-22ubiquitin associated and SH3 domain containing, B [Source:MGI Symbol;Acc:MGI:1 920 078]
Dixdc17.79E-260.37 251 0420.2750.0582.51E-21DIX domain containing 1 [Source:MGI Symbol;Acc:MGI:2 679 721]
Rtn49.96E-260.64 795 1080.7610.5273.21E-21reticulon 4 [Source:MGI Symbol;Acc:MGI:1 915 835]
Tmem132d1.74E-250.35 903 8040.2320.035.61E-21transmembrane protein 132D [Source:MGI Symbol;Acc:MGI:3 044 963]
Lrp1b2.41E-250.74 690 3160.930.8177.78E-21low density lipoprotein-related protein 1B [Source:MGI Symbol;Acc:MGI:2 151 136]
Tmem178b3.75E-250.74 144 4540.7040.4041.21E-20transmembrane protein 178B [Source:MGI Symbol;Acc:MGI:3 647 581]
Car24.82E-250.56 411 7070.5420.2781.56E-20carbonic anhydrase 2 [Source:MGI Symbol;Acc:MGI:88 269]
Dock96.04E-250.60 210 9950.6060.3221.95E-20dedicator of cytokinesis 9 [Source:MGI Symbol;Acc:MGI:106 321]
Gab18.06E-250.60 942 8240.5280.2412.60E-20growth factor receptor bound protein 2-associated protein 1 [Source:MGI Symbol;Acc:MGI:108 088]
Trim21.01E-240.67 060 9730.6480.3363.27E-20tripartite motif-containing 2 [Source:MGI Symbol;Acc:MGI:1 933 163]
Gm283761.45E-240.3 902 1970.2250.0174.69E-20predicted gene 28 376 [Source:MGI Symbol;Acc:MGI:5 579 082]
Atp8a11.75E-240.58 217 7910.7250.4545.64E-20ATPase, aminophospholipid transporter (APLT), class I, type 8A, member 1 [Source:MGI Symbol;Acc:MGI:1 330 848]
Kif21a2.22E-240.64 239 6680.7540.4277.16E-20kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
1700047M11Rik2.26E-240.33 808 7650.2320.0447.29E-20RIKEN cDNA 1700047M11 gene [Source:MGI Symbol;Acc:MGI:1 914 580]
Rasgrp32.48E-240.32 476 8140.2110.028.02E-20RAS, guanyl releasing protein 3 [Source:MGI Symbol;Acc:MGI:3 028 579]
Gm42584.16E-240.63 782 3750.5630.2521.34E-19predicted gene 4258 [Source:MGI Symbol;Acc:MGI:3 782 435]
Dip2b4.33E-240.58 787 8750.6060.3651.40E-19disco interacting protein 2 homolog B [Source:MGI Symbol;Acc:MGI:2 145 977]
Elovl71.48E-230.30 062 5330.2250.0264.79E-19ELOVL family member 7, elongation of long chain fatty acids (yeast) [Source:MGI Symbol;Acc:MGI:1 921 809]
Tenm21.85E-230.63 263 0640.4790.2445.96E-19teneurin transmembrane protein 2 [Source:MGI Symbol;Acc:MGI:1 345 184]
Rcbtb12.41E-230.42 611 2480.3310.127.78E-19regulator of chromosome condensation (RCC1) and BTB (POZ) domain containing protein 1 [Source:MGI Symbol;Acc:MGI:1 918 580]
Pacs21.61E-220.40 374 9690.3590.1215.20E-18phosphofurin acidic cluster sorting protein 2 [Source:MGI Symbol;Acc:MGI:1 924 399]
Inpp5f2.18E-220.43 895 6510.3730.1527.05E-18inositol polyphosphate-5-phosphatase F [Source:MGI Symbol;Acc:MGI:2 141 867]
Kcnab12.87E-220.52 369 3830.4440.1339.27E-18potassium voltage-gated channel, shaker-related subfamily, beta member 1 [Source:MGI Symbol;Acc:MGI:109 155]
Snx303.23E-220.36 229 5220.2960.0571.04E-17sorting nexin family member 30 [Source:MGI Symbol;Acc:MGI:2 443 882]
Nbas3.59E-220.46 269 9510.50.2231.16E-17neuroblastoma amplified sequence [Source:MGI Symbol;Acc:MGI:1 918 419]
Fign8.79E-220.42 219 0880.2680.0282.84E-17fidgetin [Source:MGI Symbol;Acc:MGI:1 890 647]
Dgki9.62E-220.80 427 9610.6340.2773.11E-17diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Jph19.64E-220.25 605 1770.2040.0253.11E-17junctophilin 1 [Source:MGI Symbol;Acc:MGI:1 891 495]
Prkcq1.26E-210.2 556 6030.2040.0274.06E-17protein kinase C, theta [Source:MGI Symbol;Acc:MGI:97 601]
Smad71.48E-210.3 719 7710.3240.0964.78E-17SMAD family member 7 [Source:MGI Symbol;Acc:MGI:1 100 518]
Kif13a1.69E-210.53 230 7980.5490.2685.45E-17kinesin family member 13A [Source:MGI Symbol;Acc:MGI:1 098 264]
Rftn11.78E-210.26 476 3140.1620.0195.75E-17raftlin lipid raft linker 1 [Source:MGI Symbol;Acc:MGI:1 923 688]
4930420G21Rik1.96E-210.30 770 5490.1760.0016.32E-17RIKEN cDNA 4930420G21 gene [Source:MGI Symbol;Acc:MGI:1 926 174]
Lpar12.02E-210.25 219 6870.1970.0286.51E-17lysophosphatidic acid receptor 1 [Source:MGI Symbol;Acc:MGI:108 429]
Clasp26.71E-210.62 845 5450.8380.6692.16E-16CLIP associating protein 2 [Source:MGI Symbol;Acc:MGI:1 923 749]
Stmn41.51E-200.39 314 1710.3030.0974.88E-16stathmin-like 4 [Source:MGI Symbol;Acc:MGI:1 931 224]
Il332.18E-200.45 476 1030.3380.1127.04E-16interleukin 33 [Source:MGI Symbol;Acc:MGI:1 924 375]
Opcml3.18E-200.63 576 0150.5560.3231.03E-15opioid binding protein/cell adhesion molecule-like [Source:MGI Symbol;Acc:MGI:97 397]
Mbnl23.25E-200.59 288 2240.8380.5961.05E-15muscleblind like splicing factor 2 [Source:MGI Symbol;Acc:MGI:2 145 597]
Ttll55.13E-200.44 199 4730.4720.1831.66E-15tubulin tyrosine ligase-like family, member 5 [Source:MGI Symbol;Acc:MGI:2 443 657]
Itpk16.27E-200.40 133 3660.3520.1172.02E-15inositol 1,3,4-triphosphate 5/6 kinase [Source:MGI Symbol;Acc:MGI:2 446 159]
Jakmip37.34E-200.25 099 9910.1620.0172.37E-15janus kinase and microtubule interacting protein 3 [Source:MGI Symbol;Acc:MGI:1 921 254]
Ppp1cc9.20E-200.38 432 9670.2890.0982.97E-15protein phosphatase 1 catalytic subunit gamma [Source:MGI Symbol;Acc:MGI:104 872]
Sez6l21.10E-190.36 167 9540.3380.1163.55E-15seizure related 6 homolog like 2 [Source:MGI Symbol;Acc:MGI:2 385 295]
Adamtsl12.14E-190.30 111 1080.3520.0756.91E-15ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
Aatk3.55E-190.50 286 0640.5990.2741.15E-14apoptosis-associated tyrosine kinase [Source:MGI Symbol;Acc:MGI:1 197 518]
Nfe2l35.30E-190.25 950 2370.1970.0271.71E-14nuclear factor, erythroid derived 2, like 3 [Source:MGI Symbol;Acc:MGI:1 339 958]
Dip2a7.75E-190.39 330 7940.3380.1282.50E-14disco interacting protein 2 homolog A [Source:MGI Symbol;Acc:MGI:2 385 920]
App8.63E-190.57 992 0890.7610.5392.79E-14amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Tmod29.60E-190.50 543 3440.5850.3543.10E-14tropomodulin 2 [Source:MGI Symbol;Acc:MGI:1 355 335]
Nbea1.14E-180.55 141 5480.7180.5273.68E-14neurobeachin [Source:MGI Symbol;Acc:MGI:1 347 075]
Grm31.15E-180.49 127 6030.8170.5333.70E-14glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Tcf121.77E-180.49 589 4460.7610.5615.70E-14transcription factor 12 [Source:MGI Symbol;Acc:MGI:101 877]
Nfasc1.91E-180.35 074 2820.620.46.16E-14neurofascin [Source:MGI Symbol;Acc:MGI:104 753]
Tmem1173.88E-180.40 506 2310.2960.0891.25E-13transmembrane protein 117 [Source:MGI Symbol;Acc:MGI:2 444 580]
Arrdc34.42E-180.29 785 6180.2820.0771.43E-13arrestin domain containing 3 [Source:MGI Symbol;Acc:MGI:2 145 242]
Qk4.48E-180.53 794 0640.9720.9431.45E-13NA
Arhgap394.73E-180.47 953 3330.4440.1461.53E-13Rho GTPase activating protein 39 [Source:MGI Symbol;Acc:MGI:107 858]
Lrrc8b8.33E-180.32 156 3340.2750.0652.69E-13leucine rich repeat containing 8 family, member B [Source:MGI Symbol;Acc:MGI:2 141 353]
Pacrg1.41E-170.71 534 1720.6060.3284.55E-13PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Cipc1.41E-170.40 268 3330.4080.2154.56E-13CLOCK interacting protein, circadian [Source:MGI Symbol;Acc:MGI:1 919 185]
Cdk192.11E-170.59 985 4530.7460.4696.80E-13cyclin-dependent kinase 19 [Source:MGI Symbol;Acc:MGI:1 925 584]
Apba13.45E-170.47 134 4710.4010.1471.12E-12amyloid beta (A4) precursor protein binding, family A, member 1 [Source:MGI Symbol;Acc:MGI:1 860 297]
Kcna13.87E-170.34 416 2440.3170.0941.25E-12potassium voltage-gated channel, shaker-related subfamily, member 1 [Source:MGI Symbol;Acc:MGI:96 654]
Prkcz4.84E-170.32 116 0270.2890.0931.56E-12protein kinase C, zeta [Source:MGI Symbol;Acc:MGI:97 602]
9330182L06Rik4.86E-170.29 562 8380.2320.0581.57E-12NA
Ube2d18.60E-170.29 694 1920.2540.0792.78E-12ubiquitin-conjugating enzyme E2D 1 [Source:MGI Symbol;Acc:MGI:2 384 911]
Dpy19l11.64E-160.33 789 7630.2890.15.29E-12dpy-19-like 1 (C. elegans) [Source:MGI Symbol;Acc:MGI:1 915 685]
1500004A13Rik3.15E-160.37 441 6140.430.1931.02E-11RIKEN cDNA 1500004A13 gene [Source:MGI Symbol;Acc:MGI:2 442 808]
Kazn3.33E-160.25 772 9650.2540.0711.08E-11kazrin, periplakin interacting protein [Source:MGI Symbol;Acc:MGI:1 918 779]
Ccp1104.68E-160.26 463 5820.2180.071.51E-11centriolar coiled coil protein 110 [Source:MGI Symbol;Acc:MGI:2 141 942]
Robo14.70E-160.59 124 2020.5560.3881.52E-11roundabout guidance receptor 1 [Source:MGI Symbol;Acc:MGI:1 274 781]
Sorcs37.52E-160.34 798 2850.2750.0692.43E-11sortilin-related VPS10 domain containing receptor 3 [Source:MGI Symbol;Acc:MGI:1 913 923]
Dlg27.57E-160.66 353 4290.8730.6082.44E-11discs large MAGUK scaffold protein 2 [Source:MGI Symbol;Acc:MGI:1 344 351]
Phactr11.20E-150.52 911 6610.7320.463.87E-11phosphatase and actin regulator 1 [Source:MGI Symbol;Acc:MGI:2 659 021]
Cobl1.33E-150.3 222 9750.2180.0594.28E-11cordon-bleu WH2 repeat [Source:MGI Symbol;Acc:MGI:105 056]
Pcdh151.33E-150.43 452 6530.2250.1174.29E-11protocadherin 15 [Source:MGI Symbol;Acc:MGI:1 891 428]
Ralgps12.05E-150.41 133 6380.4370.2136.62E-11Ral GEF with PH domain and SH3 binding motif 1 [Source:MGI Symbol;Acc:MGI:1 922 008]
Ppfibp22.54E-150.35 273 1630.3940.1588.20E-11PTPRF interacting protein, binding protein 2 (liprin beta 2) [Source:MGI Symbol;Acc:MGI:894 649]
Ube2e23.46E-150.53 184 9220.7540.4941.12E-10ubiquitin-conjugating enzyme E2E 2 [Source:MGI Symbol;Acc:MGI:2 384 997]
Olfml14.70E-150.28 671 0910.2390.0691.52E-10olfactomedin-like 1 [Source:MGI Symbol;Acc:MGI:2 679 264]
Jam37.35E-150.2 902 0260.2750.0752.37E-10junction adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 933 825]
Dleu29.17E-150.49 958 3780.5770.2532.96E-10deleted in lymphocytic leukemia, 2 [Source:MGI Symbol;Acc:MGI:1 934 030]
Cobll11.02E-140.33 155 7310.310.0973.31E-10Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Tnfaip61.75E-140.26 196 3610.1690.0315.66E-10tumor necrosis factor alpha induced protein 6 [Source:MGI Symbol;Acc:MGI:1 195 266]
Grm71.98E-140.75 582 8590.5070.2526.38E-10glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Wnk12.81E-140.44 146 8250.690.4769.08E-10WNK lysine deficient protein kinase 1 [Source:MGI Symbol;Acc:MGI:2 442 092]
Galnt73.18E-140.34 120 7010.2750.0781.03E-09polypeptide N-acetylgalactosaminyltransferase 7 [Source:MGI Symbol;Acc:MGI:1 349 449]
Dlg13.25E-140.47 381 5360.6270.431.05E-09discs large MAGUK scaffold protein 1 [Source:MGI Symbol;Acc:MGI:107 231]
Ttyh24.00E-140.30 576 1960.3730.1681.29E-09tweety family member 2 [Source:MGI Symbol;Acc:MGI:2 157 091]
Kif64.36E-140.26 052 7370.1970.0271.41E-09kinesin family member 6 [Source:MGI Symbol;Acc:MGI:1 098 238]
Sytl24.73E-140.29 329 8070.2320.0531.53E -09synaptotagmin-like 2 [Source:MGI Symbol;Acc:MGI:1 933 366]
Tmcc15.11E-140.49 862 9240.7390.5391.65E-09transmembrane and coiled coil domains 1 [Source:MGI Symbol;Acc:MGI:2 442 368]
Pip4k2a6.16E-140.40 115 8480.5140.2981.99E-09phosphatidylinositol-5-phosphate 4-kinase, type II, alpha [Source:MGI Symbol;Acc:MGI:1 298 206]
Tulp46.52E-140.47 631 8820.6340.4112.10E-09tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Dpyd6.89E-140.40 904 6820.4230.2772.23E-09dihydropyrimidine dehydrogenase [Source:MGI Symbol;Acc:MGI:2 139 667]
Rere8.76E-140.46 371 6460.7750.6032.83E-09arginine glutamic acid dipeptide (RE) repeats [Source:MGI Symbol;Acc:MGI:2 683 486]
Klf138.90E-140.35 945 1720.3870.1712.87E-09Kruppel-like factor 13 [Source:MGI Symbol;Acc:MGI:1 354 948]
Picalm1.00E-130.38 008 8280.4650.2183.23E-09phosphatidylinositol binding clathrin assembly protein [Source:MGI Symbol;Acc:MGI:2 385 902]
Abca21.07E-130.3 176 4730.3170.1383.47E-09ATP-binding cassette, sub-family A (ABC1), member 2 [Source:MGI Symbol;Acc:MGI:99 606]
Schip11.19E-130.41 507 8190.6130.3613.84E-09schwannomin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 353 557]
Trim351.19E-130.33 581 6820.3380.1433.85E-09tripartite motif-containing 35 [Source:MGI Symbol;Acc:MGI:1 914 104]
Sik31.26E-130.55 695 0360.810.6624.08E-09SIK family kinase 3 [Source:MGI Symbol;Acc:MGI:2 446 296]
Dscam1.81E-130.35 722 6750.1690.0875.84E-09DS cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 196 281]
Gas71.93E-130.31 931 1760.2680.1016.24E-09growth arrest specific 7 [Source:MGI Symbol;Acc:MGI:1 202 388]
Map4k52.07E-130.35 137 5910.3870.26.69E-09mitogen-activated protein kinase kinase kinase kinase 5 [Source:MGI Symbol;Acc:MGI:1 925 503]
Ptk22.31E-130.46 037 8210.7180.5357.46E-09PTK2 protein tyrosine kinase 2 [Source:MGI Symbol;Acc:MGI:95 481]
Rab312.35E-130.51 587 3040.5770.3887.58E-09RAB31, member RAS oncogene family [Source:MGI Symbol;Acc:MGI:1 914 603]
Cerk2.67E-130.30 557 3820.3240.1088.62E-09ceramide kinase [Source:MGI Symbol;Acc:MGI:2 386 052]
Chn22.83E-130.28 594 9570.1760.0239.13E-09chimerin 2 [Source:MGI Symbol;Acc:MGI:1 917 243]
Epb41l33.41E-130.3 103 6420.3170.1431.10E-08erythrocyte membrane protein band 4.1 like 3 [Source:MGI Symbol;Acc:MGI:103 008]
Naaladl23.52E-130.59 644 9580.6480.3491.14E-08N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Fam102a5.93E-130.27 780 9080.2610.1021.92E-08family with sequence similarity 102, member A [Source:MGI Symbol;Acc:MGI:2 138 935]
Slc38a26.77E-130.33 572 3820.310.1522.19E-08solute carrier family 38, member 2 [Source:MGI Symbol;Acc:MGI:1 915 010]
St6gal17.93E-130.48 959 3820.4860.252.56E-08beta galactoside alpha 2,6 sialyltransferase 1 [Source:MGI Symbol;Acc:MGI:108 470]
Tanc18.90E-130.26 089 0240.190.0632.87E-08tetratricopeptide repeat, ankyrin repeat and coiled-coil containing 1 [Source:MGI Symbol;Acc:MGI:1 914 110]
Rassf29.55E-130.31 791 0160.310.1183.08E-08Ras association (RalGDS/AF-6) domain family member 2 [Source:MGI Symbol;Acc:MGI:2 442 060]
Epn21.30E-120.40 804 8350.4010.2434.21E-08epsin 2 [Source:MGI Symbol;Acc:MGI:1 333 766]
Usp311.39E-120.28 668 2090.2890.0974.49E-08ubiquitin specific peptidase 31 [Source:MGI Symbol;Acc:MGI:1 923 429]
Enox11.48E-120.64 119 8450.6410.2914.77E-08ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Pbx31.60E-120.36 348 6690.2180.0825.18E-08pre B cell leukemia homeobox 3 [Source:MGI Symbol;Acc:MGI:97 496]
Lrrc8d1.69E-120.26 743 0180.2680.0675.46E-08leucine rich repeat containing 8D [Source:MGI Symbol;Acc:MGI:1 922 368]
Kctd131.89E-120.25 910 8240.2320.0716.12E-08potassium channel tetramerisation domain containing 13 [Source:MGI Symbol;Acc:MGI:1 923 739]
Wipf12.10E-120.42 212 8350.4720.2256.79E-08WAS/WASL interacting protein family, member 1 [Source:MGI Symbol;Acc:MGI:2 178 801]
Fmnl22.98E-120.50 797 6460.810.5629.62E-08formin-like 2 [Source:MGI Symbol;Acc:MGI:1 918 659]
Ralyl3.13E-120.37 461 3310.3590.1971.01E-07RALY RNA binding protein-like [Source:MGI Symbol;Acc:MGI:1 924 147]
Snrnp484.35E-120.30 167 1090.380.1631.40E-07small nuclear ribonucleoprotein 48 (U11/U12) [Source:MGI Symbol;Acc:MGI:1 915 047]
Apbb25.86E-120.37 732 9760.50.2681.89E-07amyloid beta (A4) precursor protein-binding, family B, member 2 [Source:MGI Symbol;Acc:MGI:108 405]
St3gal38.35E-120.33 765 2660.3870.2122.70E-07ST3 beta-galactoside alpha-2,3-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 316 659]
Hipk29.23E-120.42 920 2630.6970.4812.98E-07homeodomain interacting protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 314 872]
Zfp6381.00E-110.39 071 8480.6060.3823.23E-07zinc finger protein 638 [Source:MGI Symbol;Acc:MGI:1 203 484]
Bcl2l11.02E-110.37 843 4610.3870.2093.30E-07BCL2-like 1 [Source:MGI Symbol;Acc:MGI:88 139]
Plaat31.10E-110.2 560 6220.2460.0833.54E-07phospholipase A and acyltransferase 3 [Source:MGI Symbol;Acc:MGI:2 179 715]
Pkp41.53E-110.42 997 3950.5140.2794.95E-07plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Dst2.29E-110.41 891 4810.8380.6347.38E-07dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Snx12.37E-110.26 798 7520.2610.0947.65E-07sorting nexin 1 [Source:MGI Symbol;Acc:MGI:1 928 395]
Itsn23.99E-110.3 832 3910.5630.3131.29E-06intersectin 2 [Source:MGI Symbol;Acc:MGI:1 338 049]
Itch4.64E-110.34 894 2160.5560.3511.50E-06itchy, E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 202 301]
Ankib16.01E-110.32 551 4010.380.1871.94E-06ankyrin repeat and IBR domain containing 1 [Source:MGI Symbol;Acc:MGI:1 918 047]
Rapgef57.30E-110.28 518 1350.2040.0782.36E-06Rap guanine nucleotide exchange factor (GEF) 5 [Source:MGI Symbol;Acc:MGI:2 444 365]
Alcam7.37E-110.49 777 9240.5770.4922.38E-06activated leukocyte cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 313 266]
Slc25a278.64E-110.25 283 8640.2540.1062.79E-06solute carrier family 25, member 27 [Source:MGI Symbol;Acc:MGI:1 921 261]
Ppp2r3a1.54E-100.37 290 2470.5420.3684.96E-06protein phosphatase 2, regulatory subunit B'', alpha [Source:MGI Symbol;Acc:MGI:2 442 104]
Foxp11.58E-100.36 946 8910.6340.4465.11E-06forkhead box P1 [Source:MGI Symbol;Acc:MGI:1 914 004]
Sh3kbp11.76E-100.32 577 3130.3310.1455.69E-06SH3-domain kinase binding protein 1 [Source:MGI Symbol;Acc:MGI:1 889 583]
Oxr12.01E-100.43 543 6510.6480.4026.48E-06oxidation resistance 1 [Source:MGI Symbol;Acc:MGI:2 179 326]
Ppp1r212.34E-100.26 332 9970.2890.1297.54E-06protein phosphatase 1, regulatory subunit 21 [Source:MGI Symbol;Acc:MGI:1 921 075]
Elavl32.44E-100.30 396 8320.3030.1437.88E-06ELAV like RNA binding protein 3 [Source:MGI Symbol;Acc:MGI:109 157]
Clic42.45E-100.28 194 3690.4080.2327.90E-06chloride intracellular channel 4 (mitochondrial) [Source:MGI Symbol;Acc:MGI:1 352 754]
Dnajc62.62E-100.29 955 5620.2390.1098.44E-06DnaJ heat shock protein family (Hsp40) member C6 [Source:MGI Symbol;Acc:MGI:1 919 935]
Ncam12.62E-100.3 620 7210.8730.7798.45E-06neural cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:97 281]
Gm485122.85E-100.31 683 1480.310.1069.19E-06predicted gene, 48 512 [Source:MGI Symbol;Acc:MGI:6 098 046]
Usp547.29E-100.35 238 7250.4580.3172.35E-05ubiquitin specific peptidase 54 [Source:MGI Symbol;Acc:MGI:1 926 037]
Mtss19.29E-100.25 566 7840.2610.1143.00E-05MTSS I-BAR domain containing 1 [Source:MGI Symbol;Acc:MGI:2 384 818]
Kat2b1.19E-090.31 444 9630.4230.2243.85E-05K(lysine) acetyltransferase 2B [Source:MGI Symbol;Acc:MGI:1 343 094]
Dpysl21.24E-090.3 221 7760.5490.3434.00E-05dihydropyrimidinase-like 2 [Source:MGI Symbol;Acc:MGI:1 349 763]
Gna121.28E-090.29 101 1180.380.1754.14E-05guanine nucleotide binding protein, alpha 12 [Source:MGI Symbol;Acc:MGI:95 767]
Ywhaq1.52E-090.30 001 3210.4150.2214.92E-05tyrosine 3-monooxygenase/tryptophan 5-monooxygenase activation protein theta [Source:MGI Symbol;Acc:MGI:891 963]
Kif1b1.55E-090.36 174 4040.9230.815.01E-05kinesin family member 1B [Source:MGI Symbol;Acc:MGI:108 426]
5031439G07Rik1.55E-090.30 489 7880.5350.3895.02E-05RIKEN cDNA 5031439G07 gene [Source:MGI Symbol;Acc:MGI:2 444 899]
Nrbp21.59E-090.32 356 9840.3940.2155.12E-05nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Ncoa31.61E-090.25 337 7610.2750.1045.19E-05nuclear receptor coactivator 3 [Source:MGI Symbol;Acc:MGI:1 276 535]
Otud7a1.77E-090.50 197 6170.7040.4735.73E-05OTU domain containing 7A [Source:MGI Symbol;Acc:MGI:2 158 505]
Daam11.89E-090.38 269 9520.5630.4046.11E-05dishevelled associated activator of morphogenesis 1 [Source:MGI Symbol;Acc:MGI:1 914 596]
Ankrd284.30E-090.34 478 5890.5560.3650.00 013 897ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Fryl4.33E-090.32 061 0060.570.3320.00 013 975FRY like transcription coactivator [Source:MGI Symbol;Acc:MGI:1 919 563]
Ncam25.63E-090.52 172 6850.7540.5570.00 018 185neural cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:97 282]
Pakap.15.86E-090.25 161 4460.2680.1010.0 001 892NA
Cpeb26.71E-090.27 668 3380.3660.2540.00 021 677cytoplasmic polyadenylation element binding protein 2 [Source:MGI Symbol;Acc:MGI:2 442 640]
Pld17.92E-090.26 934 3650.2610.0930.00 025 557phospholipase D1 [Source:MGI Symbol;Acc:MGI:109 585]
Retreg18.48E-090.28 313 5660.3240.1260.0 002 738reticulophagy regulator 1 [Source:MGI Symbol;Acc:MGI:1 913 520]
Apod8.62E-090.27 079 6840.3450.2130.0 002 784apolipoprotein D [Source:MGI Symbol;Acc:MGI:88 056]
Atp11a1.01E-080.25 199 2730.2820.1510.00 032 617ATPase, class VI, type 11A [Source:MGI Symbol;Acc:MGI:1 354 735]
Sema6a1.31E-080.30 897 1740.2960.1020.00 042 137sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
2610035D17Rik1.51E-080.40 048 9710.5770.4280.00 048 781RIKEN cDNA 2610035D17 gene [Source:MGI Symbol;Acc:MGI:1 919 636]
Baz2b1.57E-080.37 303 6250.6970.5510.00 050 559bromodomain adjacent to zinc finger domain, 2B [Source:MGI Symbol;Acc:MGI:2 442 782]
Wdr202.34E-080.25 520 2230.3380.1590.00 075 438WD repeat domain 20 [Source:MGI Symbol;Acc:MGI:1 916 891]
Cttnbp22.40E-080.32 095 6070.4580.2660.0 007 738cortactin binding protein 2 [Source:MGI Symbol;Acc:MGI:1 353 467]
Osbpl1a2.57E-080.31 900 4890.4930.3250.00 082 996oxysterol binding protein-like 1A [Source:MGI Symbol;Acc:MGI:1 927 551]
Abhd17b2.70E-080.29 402 5890.4650.290.00 087 174abhydrolase domain containing 17B [Source:MGI Symbol;Acc:MGI:1 917 816]
Rnf133.01E-080.27 892 3080.4230.2290.000 972ring finger protein 13 [Source:MGI Symbol;Acc:MGI:1 346 341]
Tmem132b4.93E-080.26 716 1940.2680.1010.00 159 086transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Gnao15.42E-080.3 966 2220.8380.6540.00 175 013guanine nucleotide binding protein, alpha O [Source:MGI Symbol;Acc:MGI:95 775]
Pde1c5.66E-080.25 711 3140.2320.0510.00 182 824phosphodiesterase 1C [Source:MGI Symbol;Acc:MGI:108 413]
Pvt17.44E-080.25 652 9580.310.1540.00 240 229Pvt1 oncogene [Source:MGI Symbol;Acc:MGI:97 824]
Pard38.43E-080.3 133 2860.5920.4540.00 272 182par-3 family cell polarity regulator [Source:MGI Symbol;Acc:MGI:2 135 608]
Malat18.64E-080.26 747 411110.00 279 021metastasis associated lung adenocarcinoma transcript 1 (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 919 539]
Dcc9.55E-080.34 680 7950.50.2940.00 308 213deleted in colorectal carcinoma [Source:MGI Symbol;Acc:MGI:94 869]
Zcchc71.00E-070.32 309 1350.690.50.00 323 528zinc finger, CCHC domain containing 7 [Source:MGI Symbol;Acc:MGI:2 442 912]
Limch11.08E-070.35 675 4480.7390.6320.00 349 991LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Genep_valavg_log2FCpct.1pct.2p_val_adjDescription
Tmeff21.96E-2792.190 3530.8660.1716.32E-275transmembrane protein with EGF-like and two follistatin-like domains 2 [Source:MGI Symbol;Acc:MGI:1 861 735]
Slc24a22.18E-2712.39 047 0550.9010.3137.04E-267solute carrier family 24 (sodium/potassium/calcium exchanger), member 2 [Source:MGI Symbol;Acc:MGI:1 923 626]
St186.00E-2471.99 495 0270.8310.0651.94E-242suppression of tumorigenicity 18 [Source:MGI Symbol;Acc:MGI:2 446 700]
Pde4b1.48E-2342.43 293 9180.9580.5184.79E-230phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Edil31.19E-2271.90 688 8690.8380.193.86E-223EGF-like repeats and discoidin I-like domains 3 [Source:MGI Symbol;Acc:MGI:1 329 025]
Zfp5364.61E-2041.59 566 4070.7890.0461.49E-199zinc finger protein 536 [Source:MGI Symbol;Acc:MGI:1 926 102]
Dock102.99E-2021.82 246 2490.8590.1079.65E-198dedicator of cytokinesis 10 [Source:MGI Symbol;Acc:MGI:2 146 320]
Frmd52.29E-1871.91 664 3750.810.1057.40E-183FERM domain containing 5 [Source:MGI Symbol;Acc:MGI:2 442 557]
Pex5l2.43E-1792.1 784 6580.8170.1877.84E-175peroxisomal biogenesis factor 5-like [Source:MGI Symbol;Acc:MGI:1 916 672]
Prr5l8.98E-1642.11 001 0490.8380.0842.90E-159proline rich 5 like [Source:MGI Symbol;Acc:MGI:1 919 696]
Map73.57E-1561.42 866 7840.7390.1551.15E-151microtubule-associated protein 7 [Source:MGI Symbol;Acc:MGI:1 328 328]
Hecw21.21E-1411.3 025 4460.6970.0913.89E-137HECT, C2 and WW domain containing E3 ubiquitin protein ligase 2 [Source:MGI Symbol;Acc:MGI:2 685 817]
Ank35.63E-1311.39 801 6830.8240.2411.82E-126ankyrin 3, epithelial [Source:MGI Symbol;Acc:MGI:88 026]
Mbp3.03E-1221.61 563 5750.8730.3849.80E-118myelin basic protein [Source:MGI Symbol;Acc:MGI:96 925]
Dscaml15.79E-1221.14 094 5760.5920.0311.87E-117DS cell adhesion molecule like 1 [Source:MGI Symbol;Acc:MGI:2 150 309]
Ano42.70E-1201.19 501 1790.6620.0788.70E-116anoctamin 4 [Source:MGI Symbol;Acc:MGI:2 443 344]
Nkain21.23E-1182.459 1050.9230.4793.99E-114Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Plp14.27E-1111.18 847 6230.930.6141.38E-106proteolipid protein (myelin) 1 [Source:MGI Symbol;Acc:MGI:97 623]
Elmo17.68E-1101.49 626 4760.7750.1112.48E-105engulfment and cell motility 1 [Source:MGI Symbol;Acc:MGI:2 153 044]
Plcl15.42E-1091.79 213 8730.9580.5511.75E-104phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Mog5.45E-1050.83 664 2470.5280.0571.76E-100myelin oligodendrocyte glycoprotein [Source:MGI Symbol;Acc:MGI:97 435]
Spock13.35E-1041.06 025 6450.620.1141.08E-99sparc/osteonectin, cwcv and kazal-like domains proteoglycan 1 [Source:MGI Symbol;Acc:MGI:105 371]
C030029H02Rik6.53E-1040.87 497 8050.5350.0132.11E-99RIKEN cDNA C030029H02 gene [Source:MGI Symbol;Acc:MGI:1 924 633]
Bin11.85E-1000.96 607 4690.6760.1355.98E-96bridging integrator 1 [Source:MGI Symbol;Acc:MGI:108 092]
Ptprd1.32E-991.33 071 4840.9790.8424.26E-95protein tyrosine phosphatase, receptor type, D [Source:MGI Symbol;Acc:MGI:97 812]
Mag2.63E-980.8 681 8370.5630.1048.50E-94myelin-associated glycoprotein [Source:MGI Symbol;Acc:MGI:96 912]
Ypel24.47E-980.90 782 6930.5560.0751.44E-93yippee like 2 [Source:MGI Symbol;Acc:MGI:1 925 114]
Ppp1r16b9.04E-981.05 503 1860.5990.0892.92E-93protein phosphatase 1, regulatory subunit 16B [Source:MGI Symbol;Acc:MGI:2 151 841]
D7Ertd443e7.06E-960.95 018 3190.5420.0332.28E-91DNA segment, Chr 7, ERATO Doi 443, expressed [Source:MGI Symbol;Acc:MGI:1 196 431]
Sec14l57.85E-960.8 238 5310.4930.0242.53E-91SEC14-like lipid binding 5 [Source:MGI Symbol;Acc:MGI:3 616 084]
Bcas12.14E-950.8 599 4870.5280.0586.91E-91brain enriched myelin associated protein 1 [Source:MGI Symbol;Acc:MGI:1 924 210]
Plekhh11.69E-930.67 017 4680.4440.0225.46E-89pleckstrin homology domain containing, family H (with MyTH4 domain) member 1 [Source:MGI Symbol;Acc:MGI:2 144 989]
Rnf2203.11E-901.51 733 1620.7390.1521.00E-85ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Fa2h3.38E-870.75 377 5980.4370.031.09E-82fatty acid 2-hydroxylase [Source:MGI Symbol;Acc:MGI:2 443 327]
Gjc31.13E-850.75 679 7550.4720.0353.66E-81gap junction protein, gamma 3 [Source:MGI Symbol;Acc:MGI:2 153 041]
Zeb21.86E-841.28 891 0950.880.536.02E-80zinc finger E-box binding homeobox 2 [Source:MGI Symbol;Acc:MGI:1 344 407]
Agap13.01E-811.00 618 5370.7320.2079.71E-77ArfGAP with GTPase domain, ankyrin repeat and PH domain 1 [Source:MGI Symbol;Acc:MGI:2 653 690]
Ptprk2.86E-791.01 913 2210.6130.0939.23E-75protein tyrosine phosphatase, receptor type, K [Source:MGI Symbol;Acc:MGI:103 310]
Sox2ot4.38E-781.13 822 8030.8660.4751.41E-73SOX2 overlapping transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 112]
A230001M10Rik3.33E-770.72 716 2610.4370.0081.08E-72RIKEN cDNA A230001M10 gene [Source:MGI Symbol;Acc:MGI:2 443 043]
Pakap9.74E-771.0 263 7660.5630.0513.15E-72paralemmin A kinase anchor protein [Source:MGI Symbol;Acc:MGI:5 141 924]
4930419G24Rik1.16E-760.70 591 9710.4150.0173.74E-72RIKEN cDNA 4930419G24 gene [Source:MGI Symbol;Acc:MGI:1 921 124]
Adipor22.95E-761.02 693 2160.5630.1539.52E-72adiponectin receptor 2 [Source:MGI Symbol;Acc:MGI:93 830]
Arhgap234.40E-761.02 552 1970.6690.2341.42E-71Rho GTPase activating protein 23 [Source:MGI Symbol;Acc:MGI:3 697 726]
Phldb11.03E-750.68 383 2940.4720.0653.34E-71pleckstrin homology like domain, family B, member 1 [Source:MGI Symbol;Acc:MGI:2 143 230]
Ugt8a2.30E-750.73 747 8390.4860.0637.42E-71UDP galactosyltransferase 8A [Source:MGI Symbol;Acc:MGI:109 522]
Shtn11.26E-720.71 115 0320.4580.0424.07E-68shootin 1 [Source:MGI Symbol;Acc:MGI:1 918 903]
Pak72.67E-700.8 747 0790.4860.0778.63E-66NA
March16.51E-691.176 5950.6340.0912.10E-64NA
Mobp2.10E-681.06 170 7860.6480.1396.77E-64myelin-associated oligodendrocytic basic protein [Source:MGI Symbol;Acc:MGI:108 511]
Csmd34.28E-671.0 810 8120.8170.4041.38E-62CUB and Sushi multiple domains 3 [Source:MGI Symbol;Acc:MGI:2 386 403]
Slain12.35E-660.61 273 4580.4510.0617.58E-62SLAIN motif family, member 1 [Source:MGI Symbol;Acc:MGI:2 145 578]
A330015K06Rik1.42E-620.64 696 3620.3590.0234.60E-58RIKEN cDNA A330015K06 gene [Source:MGI Symbol;Acc:MGI:2 443 553]
Enpp24.34E-621.01 557 3970.690.2471.40E-57ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
A330049N07Rik1.28E-610.50 447 5180.3170.0124.14E-57RIKEN cDNA A330049N07 gene [Source:MGI Symbol;Acc:MGI:3 041 175]
Slco3a12.53E-610.71 425 8820.430.0658.17E-57solute carrier organic anion transporter family, member 3a1 [Source:MGI Symbol;Acc:MGI:1 351 867]
Mapt3.51E-611.03 710 9950.8240.441.13E-56microtubule-associated protein tau [Source:MGI Symbol;Acc:MGI:97 180]
Neat19.26E-610.90 096 1160.8730.532.99E-56nuclear paraspeckle assembly transcript 1 (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 914 211]
Sox101.48E-600.48 456 8920.3170.0124.78E-56SRY (sex determining region Y)-box 10 [Source:MGI Symbol;Acc:MGI:98 358]
Sh3d192.37E-600.73 672 3660.4580.0527.64E-56SH3 domain protein D19 [Source:MGI Symbol;Acc:MGI:1 350 923]
Aspa2.86E-600.83 141 4260.5630.1259.23E-56aspartoacylase [Source:MGI Symbol;Acc:MGI:87 914]
St6galnac39.88E-591.36 442 6560.8310.1693.19E-54ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Dnm32.80E-581.08 067 8960.7960.3129.05E-54dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Mast46.02E-581.17 111 1780.9230.6621.94E-53microtubule associated serine/threonine kinase family member 4 [Source:MGI Symbol;Acc:MGI:1 918 885]
Spock31.06E-550.82 781 5740.50.1463.42E-51sparc/osteonectin, cwcv and kazal-like domains proteoglycan 3 [Source:MGI Symbol;Acc:MGI:1 920 152]
Tspan21.59E-550.53 547 8250.3870.0425.14E-51tetraspanin 2 [Source:MGI Symbol;Acc:MGI:1 917 997]
Pstpip27.48E-550.6 397 3930.3520.0272.41E-50proline-serine-threonine phosphatase-interacting protein 2 [Source:MGI Symbol;Acc:MGI:1 335 088]
Myo1d2.03E-530.5 941 8160.3380.0196.54E-49myosin ID [Source:MGI Symbol;Acc:MGI:107 728]
Trf2.50E-520.74 161 8910.570.2238.09E-48transferrin [Source:MGI Symbol;Acc:MGI:98 821]
Gm374596.58E-510.47 492 8590.2890.0132.12E-46predicted gene, 37 459 [Source:MGI Symbol;Acc:MGI:5 610 687]
Gatm3.61E-490.6 767 9770.5490.1621.17E-44glycine amidinotransferase (L-arginine:glycine amidinotransferase) [Source:MGI Symbol;Acc:MGI:1 914 342]
Tbc1d52.37E-470.96 314 2080.7820.3937.67E-43TBC1 domain family, member 5 [Source:MGI Symbol;Acc:MGI:1 919 488]
Arhgef104.17E-470.61 505 5650.4720.0961.35E-42Rho guanine nucleotide exchange factor (GEF) 10 [Source:MGI Symbol;Acc:MGI:2 444 453]
Magi28.29E-470.76 494 3460.9930.9582.68E-42membrane associated guanylate kinase, WW and PDZ domain containing 2 [Source:MGI Symbol;Acc:MGI:1 354 953]
Frmd4b3.84E-460.83 612 7370.5560.1141.24E-41FERM domain containing 4B [Source:MGI Symbol;Acc:MGI:2 141 794]
Slc25a131.13E-450.47 421 7710.2820.0233.66E-41solute carrier family 25 (mitochondrial carrier, adenine nucleotide translocator), member 13 [Source:MGI Symbol;Acc:MGI:1 354 721]
Mast31.21E-450.54 141 4790.3940.0613.91E-41microtubule associated serine/threonine kinase 3 [Source:MGI Symbol;Acc:MGI:2 683 541]
9330111N05Rik2.85E-450.86 924 3090.2390.029.20E-41RIKEN cDNA 9330111N05 gene [Source:MGI Symbol;Acc:MGI:2 443 112]
Plxdc22.90E-450.99 119 4110.6970.2899.37E-41plexin domain containing 2 [Source:MGI Symbol;Acc:MGI:1 914 698]
Hapln21.55E-420.42 343 6150.3030.0445.01E-38hyaluronan and proteoglycan link protein 2 [Source:MGI Symbol;Acc:MGI:2 137 300]
Pls11.69E-420.48 138 9080.3310.0365.45E-38plastin 1 (I-isoform) [Source:MGI Symbol;Acc:MGI:104 809]
Zdhhc201.12E-410.71 868 9140.6480.2713.63E-37zinc finger, DHHC domain containing 20 [Source:MGI Symbol;Acc:MGI:1 923 215]
Kif13b1.84E-410.65 625 5650.5920.2235.93E-37kinesin family member 13B [Source:MGI Symbol;Acc:MGI:1 098 265]
Nkain17.94E-410.39 682 3360.2750.022.56E-36Na+/K + transporting ATPase interacting 1 [Source:MGI Symbol;Acc:MGI:1 914 399]
Erbin1.15E-400.86 650 2980.7040.3183.73E-36Erbb2 interacting protein [Source:MGI Symbol;Acc:MGI:1 890 169]
Fnbp11.39E-390.87 125 7280.8730.7124.50E-35formin binding protein 1 [Source:MGI Symbol;Acc:MGI:109 606]
Ttll72.04E-390.60 669 7220.4790.1496.58E-35tubulin tyrosine ligase-like family, member 7 [Source:MGI Symbol;Acc:MGI:1 918 142]
Srcin12.73E-390.51 518 0350.4230.0938.83E-35SRC kinase signaling inhibitor 1 [Source:MGI Symbol;Acc:MGI:1 933 179]
Zdhhc144.12E-390.68 121 4790.5490.1531.33E-34zinc finger, DHHC domain containing 14 [Source:MGI Symbol;Acc:MGI:2 653 229]
Arsg8.39E-390.38 634 5390.2680.0222.71E-34arylsulfatase G [Source:MGI Symbol;Acc:MGI:1 921 258]
Gm424131.02E-380.3 871 6350.2680.0283.31E-34predicted gene, 42 413 [Source:MGI Symbol;Acc:MGI:5 648 986]
Tubb4a1.15E-380.54 604 1650.4580.1333.72E-34tubulin, beta 4A class IVA [Source:MGI Symbol;Acc:MGI:107 848]
Slc12a21.22E-380.58 801 6450.5210.1353.94E-34solute carrier family 12, member 2 [Source:MGI Symbol;Acc:MGI:101 924]
Gm161682.12E-380.87 079 4980.5990.2056.86E-34predicted gene 16 168 [Source:MGI Symbol;Acc:MGI:3 802 010]
Pcdh92.68E-380.97 488 42210.9848.66E-34protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Pik3c2b4.28E-380.37 728 2020.2460.0241.38E-33phosphatidylinositol-4-phosphate 3-kinase catalytic subunit type 2 beta [Source:MGI Symbol;Acc:MGI:2 685 045]
4930511M06Rik1.11E-370.3 310 7130.2540.0183.60E-33RIKEN cDNA 4930511M06 gene [Source:MGI Symbol;Acc:MGI:1 922 334]
Cdc42bpa2.23E-370.78 839 3340.810.5737.19E-33CDC42 binding protein kinase alpha [Source:MGI Symbol;Acc:MGI:2 441 841]
Sept42.64E-370.54 089 8980.4650.1378.53E-33NA
Ninj23.79E-370.51 902 0610.3030.0231.22E-32ninjurin 2 [Source:MGI Symbol;Acc:MGI:1 352 751]
Kcnk134.12E-370.43 764 7880.2820.0271.33E-32potassium channel, subfamily K, member 13 [Source:MGI Symbol;Acc:MGI:2 384 976]
Unc5c6.43E-371.11 147 0440.7390.2122.08E-32unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Gm195002.08E-360.30 602 4910.2110.0086.72E-32predicted gene, 19 500 [Source:MGI Symbol;Acc:MGI:5 011 685]
Il1rap2.56E-360.57 608 2550.4150.0768.25E-32interleukin 1 receptor accessory protein [Source:MGI Symbol;Acc:MGI:104 975]
Vmp15.27E-360.66 465 0540.5770.2511.70E-31vacuole membrane protein 1 [Source:MGI Symbol;Acc:MGI:1 923 159]
Anln1.38E-350.48 487 9750.3030.0574.46E-31anillin, actin binding protein [Source:MGI Symbol;Acc:MGI:1 920 174]
Tmeff14.17E-350.51 360 5280.3450.0751.35E-30transmembrane protein with EGF-like and two follistatin-like domains 1 [Source:MGI Symbol;Acc:MGI:1 926 810]
Pak14.91E-350.62 796 5020.6270.2151.58E-30p21 (RAC1) activated kinase 1 [Source:MGI Symbol;Acc:MGI:1 339 975]
Sept71.27E-340.73 987 8470.7750.4714.09E-30NA
Creb51.29E-340.56 432 8150.3870.0414.18E-30cAMP responsive element binding protein 5 [Source:MGI Symbol;Acc:MGI:2 443 973]
Eml11.29E-340.56 745 0440.3520.0834.18E-30echinoderm microtubule associated protein like 1 [Source:MGI Symbol;Acc:MGI:1 915 769]
Slc44a13.97E-340.58 788 5490.4860.1261.28E-29solute carrier family 44, member 1 [Source:MGI Symbol;Acc:MGI:2 140 592]
Exoc6b5.55E-340.73 711 6010.7390.4411.79E-29exocyst complex component 6B [Source:MGI Symbol;Acc:MGI:1 923 164]
Pde8a1.37E-330.68 761 1450.4580.0944.42E-29phosphodiesterase 8A [Source:MGI Symbol;Acc:MGI:1 277 116]
Phlpp11.83E-330.81 013 8890.9720.7765.92E-29PH domain and leucine rich repeat protein phosphatase 1 [Source:MGI Symbol;Acc:MGI:2 138 327]
Synj23.19E-330.37 727 9530.3030.0491.03E-28synaptojanin 2 [Source:MGI Symbol;Acc:MGI:1 201 671]
Gm427563.27E-330.33 667 0230.2040.0041.05E-28predicted gene 42 756 [Source:MGI Symbol;Acc:MGI:5 662 893]
Rffl4.32E-330.53 223 0760.3870.0651.39E-28ring finger and FYVE like domain containing protein [Source:MGI Symbol;Acc:MGI:1 914 588]
Cntn21.03E-320.40 649 6330.2820.0443.31E-28contactin 2 [Source:MGI Symbol;Acc:MGI:104 518]
Litaf1.69E-320.40 625 2680.2890.0495.44E-28LPS-induced TN factor [Source:MGI Symbol;Acc:MGI:1 929 512]
Anks1b3.33E-320.75 156 8140.5210.2561.08E-27ankyrin repeat and sterile alpha motif domain containing 1B [Source:MGI Symbol;Acc:MGI:1 924 781]
Otud7b7.11E-320.65 083 1440.5630.2222.29E-27OTU domain containing 7B [Source:MGI Symbol;Acc:MGI:2 654 703]
Klhl28.54E-320.65 820 8990.5420.2222.76E-27kelch-like 2, Mayven [Source:MGI Symbol;Acc:MGI:1 924 363]
Grb141.01E-310.4 093 8340.2610.0323.28E-27growth factor receptor bound protein 14 [Source:MGI Symbol;Acc:MGI:1 355 324]
Cdc37l11.36E-310.66 387 6890.6830.3694.39E-27cell division cycle 37-like 1 [Source:MGI Symbol;Acc:MGI:1 914 322]
Sorcs12.12E-310.81 115 6190.50.126.85E-27sortilin-related VPS10 domain containing receptor 1 [Source:MGI Symbol;Acc:MGI:1 929 666]
Kctd36.37E-310.43 513 9220.3170.0792.06E-26potassium channel tetramerisation domain containing 3 [Source:MGI Symbol;Acc:MGI:2 444 629]
Tmem63a1.55E-300.30 592 6710.2180.0244.99E-26transmembrane protein 63a [Source:MGI Symbol;Acc:MGI:2 384 789]
Agpat41.74E-300.4 155 8550.3030.0525.61E-261-acylglycerol-3-phosphate O-acyltransferase 4 (lysophosphatidic acid acyltransferase, delta) [Source:MGI Symbol;Acc:MGI:1 915 512]
Ssh21.52E-290.68 483 3430.5560.1984.92E-25slingshot protein phosphatase 2 [Source:MGI Symbol;Acc:MGI:2 679 255]
Ptgds2.16E-290.78 930 2020.5770.3966.98E-25prostaglandin D2 synthase (brain) [Source:MGI Symbol;Acc:MGI:99 261]
Opalin2.55E-290.29 885 5370.2110.0248.24E-25oligodendrocytic myelin paranodal and inner loop protein [Source:MGI Symbol;Acc:MGI:2 657 025]
Gm485083.89E-290.2 522 3650.1620.0051.26E-24predicted gene, 48 508 [Source:MGI Symbol;Acc:MGI:6 098 039]
Cpm7.69E-290.26 961 4350.1760.0112.48E-24carboxypeptidase M [Source:MGI Symbol;Acc:MGI:1 917 824]
Prickle21.51E-280.81 121 3710.7320.3894.87E-24prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
Abca8a2.27E-280.30 631 7360.2110.0127.32E-24ATP-binding cassette, sub-family A (ABC1), member 8a [Source:MGI Symbol;Acc:MGI:2 386 846]
Kndc17.59E-280.38 605 8260.2250.0332.45E-23kinase non-catalytic C-lobe domain (KIND) containing 1 [Source:MGI Symbol;Acc:MGI:1 923 734]
Lpgat11.47E-270.52 009 4610.430.174.76E-23lysophosphatidylglycerol acyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 446 186]
Efnb31.57E-270.33 242 6310.2460.055.06E-23ephrin B3 [Source:MGI Symbol;Acc:MGI:109 196]
Slc8a12.10E-261.08 822 7360.7460.2666.77E-22solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Ubash3b2.74E-260.59 280 7850.4150.1158.85E-22ubiquitin associated and SH3 domain containing, B [Source:MGI Symbol;Acc:MGI:1 920 078]
Dixdc17.79E-260.37 251 0420.2750.0582.51E-21DIX domain containing 1 [Source:MGI Symbol;Acc:MGI:2 679 721]
Rtn49.96E-260.64 795 1080.7610.5273.21E-21reticulon 4 [Source:MGI Symbol;Acc:MGI:1 915 835]
Tmem132d1.74E-250.35 903 8040.2320.035.61E-21transmembrane protein 132D [Source:MGI Symbol;Acc:MGI:3 044 963]
Lrp1b2.41E-250.74 690 3160.930.8177.78E-21low density lipoprotein-related protein 1B [Source:MGI Symbol;Acc:MGI:2 151 136]
Tmem178b3.75E-250.74 144 4540.7040.4041.21E-20transmembrane protein 178B [Source:MGI Symbol;Acc:MGI:3 647 581]
Car24.82E-250.56 411 7070.5420.2781.56E-20carbonic anhydrase 2 [Source:MGI Symbol;Acc:MGI:88 269]
Dock96.04E-250.60 210 9950.6060.3221.95E-20dedicator of cytokinesis 9 [Source:MGI Symbol;Acc:MGI:106 321]
Gab18.06E-250.60 942 8240.5280.2412.60E-20growth factor receptor bound protein 2-associated protein 1 [Source:MGI Symbol;Acc:MGI:108 088]
Trim21.01E-240.67 060 9730.6480.3363.27E-20tripartite motif-containing 2 [Source:MGI Symbol;Acc:MGI:1 933 163]
Gm283761.45E-240.3 902 1970.2250.0174.69E-20predicted gene 28 376 [Source:MGI Symbol;Acc:MGI:5 579 082]
Atp8a11.75E-240.58 217 7910.7250.4545.64E-20ATPase, aminophospholipid transporter (APLT), class I, type 8A, member 1 [Source:MGI Symbol;Acc:MGI:1 330 848]
Kif21a2.22E-240.64 239 6680.7540.4277.16E-20kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
1700047M11Rik2.26E-240.33 808 7650.2320.0447.29E-20RIKEN cDNA 1700047M11 gene [Source:MGI Symbol;Acc:MGI:1 914 580]
Rasgrp32.48E-240.32 476 8140.2110.028.02E-20RAS, guanyl releasing protein 3 [Source:MGI Symbol;Acc:MGI:3 028 579]
Gm42584.16E-240.63 782 3750.5630.2521.34E-19predicted gene 4258 [Source:MGI Symbol;Acc:MGI:3 782 435]
Dip2b4.33E-240.58 787 8750.6060.3651.40E-19disco interacting protein 2 homolog B [Source:MGI Symbol;Acc:MGI:2 145 977]
Elovl71.48E-230.30 062 5330.2250.0264.79E-19ELOVL family member 7, elongation of long chain fatty acids (yeast) [Source:MGI Symbol;Acc:MGI:1 921 809]
Tenm21.85E-230.63 263 0640.4790.2445.96E-19teneurin transmembrane protein 2 [Source:MGI Symbol;Acc:MGI:1 345 184]
Rcbtb12.41E-230.42 611 2480.3310.127.78E-19regulator of chromosome condensation (RCC1) and BTB (POZ) domain containing protein 1 [Source:MGI Symbol;Acc:MGI:1 918 580]
Pacs21.61E-220.40 374 9690.3590.1215.20E-18phosphofurin acidic cluster sorting protein 2 [Source:MGI Symbol;Acc:MGI:1 924 399]
Inpp5f2.18E-220.43 895 6510.3730.1527.05E-18inositol polyphosphate-5-phosphatase F [Source:MGI Symbol;Acc:MGI:2 141 867]
Kcnab12.87E-220.52 369 3830.4440.1339.27E-18potassium voltage-gated channel, shaker-related subfamily, beta member 1 [Source:MGI Symbol;Acc:MGI:109 155]
Snx303.23E-220.36 229 5220.2960.0571.04E-17sorting nexin family member 30 [Source:MGI Symbol;Acc:MGI:2 443 882]
Nbas3.59E-220.46 269 9510.50.2231.16E-17neuroblastoma amplified sequence [Source:MGI Symbol;Acc:MGI:1 918 419]
Fign8.79E-220.42 219 0880.2680.0282.84E-17fidgetin [Source:MGI Symbol;Acc:MGI:1 890 647]
Dgki9.62E-220.80 427 9610.6340.2773.11E-17diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Jph19.64E-220.25 605 1770.2040.0253.11E-17junctophilin 1 [Source:MGI Symbol;Acc:MGI:1 891 495]
Prkcq1.26E-210.2 556 6030.2040.0274.06E-17protein kinase C, theta [Source:MGI Symbol;Acc:MGI:97 601]
Smad71.48E-210.3 719 7710.3240.0964.78E-17SMAD family member 7 [Source:MGI Symbol;Acc:MGI:1 100 518]
Kif13a1.69E-210.53 230 7980.5490.2685.45E-17kinesin family member 13A [Source:MGI Symbol;Acc:MGI:1 098 264]
Rftn11.78E-210.26 476 3140.1620.0195.75E-17raftlin lipid raft linker 1 [Source:MGI Symbol;Acc:MGI:1 923 688]
4930420G21Rik1.96E-210.30 770 5490.1760.0016.32E-17RIKEN cDNA 4930420G21 gene [Source:MGI Symbol;Acc:MGI:1 926 174]
Lpar12.02E-210.25 219 6870.1970.0286.51E-17lysophosphatidic acid receptor 1 [Source:MGI Symbol;Acc:MGI:108 429]
Clasp26.71E-210.62 845 5450.8380.6692.16E-16CLIP associating protein 2 [Source:MGI Symbol;Acc:MGI:1 923 749]
Stmn41.51E-200.39 314 1710.3030.0974.88E-16stathmin-like 4 [Source:MGI Symbol;Acc:MGI:1 931 224]
Il332.18E-200.45 476 1030.3380.1127.04E-16interleukin 33 [Source:MGI Symbol;Acc:MGI:1 924 375]
Opcml3.18E-200.63 576 0150.5560.3231.03E-15opioid binding protein/cell adhesion molecule-like [Source:MGI Symbol;Acc:MGI:97 397]
Mbnl23.25E-200.59 288 2240.8380.5961.05E-15muscleblind like splicing factor 2 [Source:MGI Symbol;Acc:MGI:2 145 597]
Ttll55.13E-200.44 199 4730.4720.1831.66E-15tubulin tyrosine ligase-like family, member 5 [Source:MGI Symbol;Acc:MGI:2 443 657]
Itpk16.27E-200.40 133 3660.3520.1172.02E-15inositol 1,3,4-triphosphate 5/6 kinase [Source:MGI Symbol;Acc:MGI:2 446 159]
Jakmip37.34E-200.25 099 9910.1620.0172.37E-15janus kinase and microtubule interacting protein 3 [Source:MGI Symbol;Acc:MGI:1 921 254]
Ppp1cc9.20E-200.38 432 9670.2890.0982.97E-15protein phosphatase 1 catalytic subunit gamma [Source:MGI Symbol;Acc:MGI:104 872]
Sez6l21.10E-190.36 167 9540.3380.1163.55E-15seizure related 6 homolog like 2 [Source:MGI Symbol;Acc:MGI:2 385 295]
Adamtsl12.14E-190.30 111 1080.3520.0756.91E-15ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
Aatk3.55E-190.50 286 0640.5990.2741.15E-14apoptosis-associated tyrosine kinase [Source:MGI Symbol;Acc:MGI:1 197 518]
Nfe2l35.30E-190.25 950 2370.1970.0271.71E-14nuclear factor, erythroid derived 2, like 3 [Source:MGI Symbol;Acc:MGI:1 339 958]
Dip2a7.75E-190.39 330 7940.3380.1282.50E-14disco interacting protein 2 homolog A [Source:MGI Symbol;Acc:MGI:2 385 920]
App8.63E-190.57 992 0890.7610.5392.79E-14amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Tmod29.60E-190.50 543 3440.5850.3543.10E-14tropomodulin 2 [Source:MGI Symbol;Acc:MGI:1 355 335]
Nbea1.14E-180.55 141 5480.7180.5273.68E-14neurobeachin [Source:MGI Symbol;Acc:MGI:1 347 075]
Grm31.15E-180.49 127 6030.8170.5333.70E-14glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Tcf121.77E-180.49 589 4460.7610.5615.70E-14transcription factor 12 [Source:MGI Symbol;Acc:MGI:101 877]
Nfasc1.91E-180.35 074 2820.620.46.16E-14neurofascin [Source:MGI Symbol;Acc:MGI:104 753]
Tmem1173.88E-180.40 506 2310.2960.0891.25E-13transmembrane protein 117 [Source:MGI Symbol;Acc:MGI:2 444 580]
Arrdc34.42E-180.29 785 6180.2820.0771.43E-13arrestin domain containing 3 [Source:MGI Symbol;Acc:MGI:2 145 242]
Qk4.48E-180.53 794 0640.9720.9431.45E-13NA
Arhgap394.73E-180.47 953 3330.4440.1461.53E-13Rho GTPase activating protein 39 [Source:MGI Symbol;Acc:MGI:107 858]
Lrrc8b8.33E-180.32 156 3340.2750.0652.69E-13leucine rich repeat containing 8 family, member B [Source:MGI Symbol;Acc:MGI:2 141 353]
Pacrg1.41E-170.71 534 1720.6060.3284.55E-13PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Cipc1.41E-170.40 268 3330.4080.2154.56E-13CLOCK interacting protein, circadian [Source:MGI Symbol;Acc:MGI:1 919 185]
Cdk192.11E-170.59 985 4530.7460.4696.80E-13cyclin-dependent kinase 19 [Source:MGI Symbol;Acc:MGI:1 925 584]
Apba13.45E-170.47 134 4710.4010.1471.12E-12amyloid beta (A4) precursor protein binding, family A, member 1 [Source:MGI Symbol;Acc:MGI:1 860 297]
Kcna13.87E-170.34 416 2440.3170.0941.25E-12potassium voltage-gated channel, shaker-related subfamily, member 1 [Source:MGI Symbol;Acc:MGI:96 654]
Prkcz4.84E-170.32 116 0270.2890.0931.56E-12protein kinase C, zeta [Source:MGI Symbol;Acc:MGI:97 602]
9330182L06Rik4.86E-170.29 562 8380.2320.0581.57E-12NA
Ube2d18.60E-170.29 694 1920.2540.0792.78E-12ubiquitin-conjugating enzyme E2D 1 [Source:MGI Symbol;Acc:MGI:2 384 911]
Dpy19l11.64E-160.33 789 7630.2890.15.29E-12dpy-19-like 1 (C. elegans) [Source:MGI Symbol;Acc:MGI:1 915 685]
1500004A13Rik3.15E-160.37 441 6140.430.1931.02E-11RIKEN cDNA 1500004A13 gene [Source:MGI Symbol;Acc:MGI:2 442 808]
Kazn3.33E-160.25 772 9650.2540.0711.08E-11kazrin, periplakin interacting protein [Source:MGI Symbol;Acc:MGI:1 918 779]
Ccp1104.68E-160.26 463 5820.2180.071.51E-11centriolar coiled coil protein 110 [Source:MGI Symbol;Acc:MGI:2 141 942]
Robo14.70E-160.59 124 2020.5560.3881.52E-11roundabout guidance receptor 1 [Source:MGI Symbol;Acc:MGI:1 274 781]
Sorcs37.52E-160.34 798 2850.2750.0692.43E-11sortilin-related VPS10 domain containing receptor 3 [Source:MGI Symbol;Acc:MGI:1 913 923]
Dlg27.57E-160.66 353 4290.8730.6082.44E-11discs large MAGUK scaffold protein 2 [Source:MGI Symbol;Acc:MGI:1 344 351]
Phactr11.20E-150.52 911 6610.7320.463.87E-11phosphatase and actin regulator 1 [Source:MGI Symbol;Acc:MGI:2 659 021]
Cobl1.33E-150.3 222 9750.2180.0594.28E-11cordon-bleu WH2 repeat [Source:MGI Symbol;Acc:MGI:105 056]
Pcdh151.33E-150.43 452 6530.2250.1174.29E-11protocadherin 15 [Source:MGI Symbol;Acc:MGI:1 891 428]
Ralgps12.05E-150.41 133 6380.4370.2136.62E-11Ral GEF with PH domain and SH3 binding motif 1 [Source:MGI Symbol;Acc:MGI:1 922 008]
Ppfibp22.54E-150.35 273 1630.3940.1588.20E-11PTPRF interacting protein, binding protein 2 (liprin beta 2) [Source:MGI Symbol;Acc:MGI:894 649]
Ube2e23.46E-150.53 184 9220.7540.4941.12E-10ubiquitin-conjugating enzyme E2E 2 [Source:MGI Symbol;Acc:MGI:2 384 997]
Olfml14.70E-150.28 671 0910.2390.0691.52E-10olfactomedin-like 1 [Source:MGI Symbol;Acc:MGI:2 679 264]
Jam37.35E-150.2 902 0260.2750.0752.37E-10junction adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 933 825]
Dleu29.17E-150.49 958 3780.5770.2532.96E-10deleted in lymphocytic leukemia, 2 [Source:MGI Symbol;Acc:MGI:1 934 030]
Cobll11.02E-140.33 155 7310.310.0973.31E-10Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Tnfaip61.75E-140.26 196 3610.1690.0315.66E-10tumor necrosis factor alpha induced protein 6 [Source:MGI Symbol;Acc:MGI:1 195 266]
Grm71.98E-140.75 582 8590.5070.2526.38E-10glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Wnk12.81E-140.44 146 8250.690.4769.08E-10WNK lysine deficient protein kinase 1 [Source:MGI Symbol;Acc:MGI:2 442 092]
Galnt73.18E-140.34 120 7010.2750.0781.03E-09polypeptide N-acetylgalactosaminyltransferase 7 [Source:MGI Symbol;Acc:MGI:1 349 449]
Dlg13.25E-140.47 381 5360.6270.431.05E-09discs large MAGUK scaffold protein 1 [Source:MGI Symbol;Acc:MGI:107 231]
Ttyh24.00E-140.30 576 1960.3730.1681.29E-09tweety family member 2 [Source:MGI Symbol;Acc:MGI:2 157 091]
Kif64.36E-140.26 052 7370.1970.0271.41E-09kinesin family member 6 [Source:MGI Symbol;Acc:MGI:1 098 238]
Sytl24.73E-140.29 329 8070.2320.0531.53E -09synaptotagmin-like 2 [Source:MGI Symbol;Acc:MGI:1 933 366]
Tmcc15.11E-140.49 862 9240.7390.5391.65E-09transmembrane and coiled coil domains 1 [Source:MGI Symbol;Acc:MGI:2 442 368]
Pip4k2a6.16E-140.40 115 8480.5140.2981.99E-09phosphatidylinositol-5-phosphate 4-kinase, type II, alpha [Source:MGI Symbol;Acc:MGI:1 298 206]
Tulp46.52E-140.47 631 8820.6340.4112.10E-09tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Dpyd6.89E-140.40 904 6820.4230.2772.23E-09dihydropyrimidine dehydrogenase [Source:MGI Symbol;Acc:MGI:2 139 667]
Rere8.76E-140.46 371 6460.7750.6032.83E-09arginine glutamic acid dipeptide (RE) repeats [Source:MGI Symbol;Acc:MGI:2 683 486]
Klf138.90E-140.35 945 1720.3870.1712.87E-09Kruppel-like factor 13 [Source:MGI Symbol;Acc:MGI:1 354 948]
Picalm1.00E-130.38 008 8280.4650.2183.23E-09phosphatidylinositol binding clathrin assembly protein [Source:MGI Symbol;Acc:MGI:2 385 902]
Abca21.07E-130.3 176 4730.3170.1383.47E-09ATP-binding cassette, sub-family A (ABC1), member 2 [Source:MGI Symbol;Acc:MGI:99 606]
Schip11.19E-130.41 507 8190.6130.3613.84E-09schwannomin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 353 557]
Trim351.19E-130.33 581 6820.3380.1433.85E-09tripartite motif-containing 35 [Source:MGI Symbol;Acc:MGI:1 914 104]
Sik31.26E-130.55 695 0360.810.6624.08E-09SIK family kinase 3 [Source:MGI Symbol;Acc:MGI:2 446 296]
Dscam1.81E-130.35 722 6750.1690.0875.84E-09DS cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 196 281]
Gas71.93E-130.31 931 1760.2680.1016.24E-09growth arrest specific 7 [Source:MGI Symbol;Acc:MGI:1 202 388]
Map4k52.07E-130.35 137 5910.3870.26.69E-09mitogen-activated protein kinase kinase kinase kinase 5 [Source:MGI Symbol;Acc:MGI:1 925 503]
Ptk22.31E-130.46 037 8210.7180.5357.46E-09PTK2 protein tyrosine kinase 2 [Source:MGI Symbol;Acc:MGI:95 481]
Rab312.35E-130.51 587 3040.5770.3887.58E-09RAB31, member RAS oncogene family [Source:MGI Symbol;Acc:MGI:1 914 603]
Cerk2.67E-130.30 557 3820.3240.1088.62E-09ceramide kinase [Source:MGI Symbol;Acc:MGI:2 386 052]
Chn22.83E-130.28 594 9570.1760.0239.13E-09chimerin 2 [Source:MGI Symbol;Acc:MGI:1 917 243]
Epb41l33.41E-130.3 103 6420.3170.1431.10E-08erythrocyte membrane protein band 4.1 like 3 [Source:MGI Symbol;Acc:MGI:103 008]
Naaladl23.52E-130.59 644 9580.6480.3491.14E-08N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Fam102a5.93E-130.27 780 9080.2610.1021.92E-08family with sequence similarity 102, member A [Source:MGI Symbol;Acc:MGI:2 138 935]
Slc38a26.77E-130.33 572 3820.310.1522.19E-08solute carrier family 38, member 2 [Source:MGI Symbol;Acc:MGI:1 915 010]
St6gal17.93E-130.48 959 3820.4860.252.56E-08beta galactoside alpha 2,6 sialyltransferase 1 [Source:MGI Symbol;Acc:MGI:108 470]
Tanc18.90E-130.26 089 0240.190.0632.87E-08tetratricopeptide repeat, ankyrin repeat and coiled-coil containing 1 [Source:MGI Symbol;Acc:MGI:1 914 110]
Rassf29.55E-130.31 791 0160.310.1183.08E-08Ras association (RalGDS/AF-6) domain family member 2 [Source:MGI Symbol;Acc:MGI:2 442 060]
Epn21.30E-120.40 804 8350.4010.2434.21E-08epsin 2 [Source:MGI Symbol;Acc:MGI:1 333 766]
Usp311.39E-120.28 668 2090.2890.0974.49E-08ubiquitin specific peptidase 31 [Source:MGI Symbol;Acc:MGI:1 923 429]
Enox11.48E-120.64 119 8450.6410.2914.77E-08ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Pbx31.60E-120.36 348 6690.2180.0825.18E-08pre B cell leukemia homeobox 3 [Source:MGI Symbol;Acc:MGI:97 496]
Lrrc8d1.69E-120.26 743 0180.2680.0675.46E-08leucine rich repeat containing 8D [Source:MGI Symbol;Acc:MGI:1 922 368]
Kctd131.89E-120.25 910 8240.2320.0716.12E-08potassium channel tetramerisation domain containing 13 [Source:MGI Symbol;Acc:MGI:1 923 739]
Wipf12.10E-120.42 212 8350.4720.2256.79E-08WAS/WASL interacting protein family, member 1 [Source:MGI Symbol;Acc:MGI:2 178 801]
Fmnl22.98E-120.50 797 6460.810.5629.62E-08formin-like 2 [Source:MGI Symbol;Acc:MGI:1 918 659]
Ralyl3.13E-120.37 461 3310.3590.1971.01E-07RALY RNA binding protein-like [Source:MGI Symbol;Acc:MGI:1 924 147]
Snrnp484.35E-120.30 167 1090.380.1631.40E-07small nuclear ribonucleoprotein 48 (U11/U12) [Source:MGI Symbol;Acc:MGI:1 915 047]
Apbb25.86E-120.37 732 9760.50.2681.89E-07amyloid beta (A4) precursor protein-binding, family B, member 2 [Source:MGI Symbol;Acc:MGI:108 405]
St3gal38.35E-120.33 765 2660.3870.2122.70E-07ST3 beta-galactoside alpha-2,3-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 316 659]
Hipk29.23E-120.42 920 2630.6970.4812.98E-07homeodomain interacting protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 314 872]
Zfp6381.00E-110.39 071 8480.6060.3823.23E-07zinc finger protein 638 [Source:MGI Symbol;Acc:MGI:1 203 484]
Bcl2l11.02E-110.37 843 4610.3870.2093.30E-07BCL2-like 1 [Source:MGI Symbol;Acc:MGI:88 139]
Plaat31.10E-110.2 560 6220.2460.0833.54E-07phospholipase A and acyltransferase 3 [Source:MGI Symbol;Acc:MGI:2 179 715]
Pkp41.53E-110.42 997 3950.5140.2794.95E-07plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Dst2.29E-110.41 891 4810.8380.6347.38E-07dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Snx12.37E-110.26 798 7520.2610.0947.65E-07sorting nexin 1 [Source:MGI Symbol;Acc:MGI:1 928 395]
Itsn23.99E-110.3 832 3910.5630.3131.29E-06intersectin 2 [Source:MGI Symbol;Acc:MGI:1 338 049]
Itch4.64E-110.34 894 2160.5560.3511.50E-06itchy, E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 202 301]
Ankib16.01E-110.32 551 4010.380.1871.94E-06ankyrin repeat and IBR domain containing 1 [Source:MGI Symbol;Acc:MGI:1 918 047]
Rapgef57.30E-110.28 518 1350.2040.0782.36E-06Rap guanine nucleotide exchange factor (GEF) 5 [Source:MGI Symbol;Acc:MGI:2 444 365]
Alcam7.37E-110.49 777 9240.5770.4922.38E-06activated leukocyte cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 313 266]
Slc25a278.64E-110.25 283 8640.2540.1062.79E-06solute carrier family 25, member 27 [Source:MGI Symbol;Acc:MGI:1 921 261]
Ppp2r3a1.54E-100.37 290 2470.5420.3684.96E-06protein phosphatase 2, regulatory subunit B'', alpha [Source:MGI Symbol;Acc:MGI:2 442 104]
Foxp11.58E-100.36 946 8910.6340.4465.11E-06forkhead box P1 [Source:MGI Symbol;Acc:MGI:1 914 004]
Sh3kbp11.76E-100.32 577 3130.3310.1455.69E-06SH3-domain kinase binding protein 1 [Source:MGI Symbol;Acc:MGI:1 889 583]
Oxr12.01E-100.43 543 6510.6480.4026.48E-06oxidation resistance 1 [Source:MGI Symbol;Acc:MGI:2 179 326]
Ppp1r212.34E-100.26 332 9970.2890.1297.54E-06protein phosphatase 1, regulatory subunit 21 [Source:MGI Symbol;Acc:MGI:1 921 075]
Elavl32.44E-100.30 396 8320.3030.1437.88E-06ELAV like RNA binding protein 3 [Source:MGI Symbol;Acc:MGI:109 157]
Clic42.45E-100.28 194 3690.4080.2327.90E-06chloride intracellular channel 4 (mitochondrial) [Source:MGI Symbol;Acc:MGI:1 352 754]
Dnajc62.62E-100.29 955 5620.2390.1098.44E-06DnaJ heat shock protein family (Hsp40) member C6 [Source:MGI Symbol;Acc:MGI:1 919 935]
Ncam12.62E-100.3 620 7210.8730.7798.45E-06neural cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:97 281]
Gm485122.85E-100.31 683 1480.310.1069.19E-06predicted gene, 48 512 [Source:MGI Symbol;Acc:MGI:6 098 046]
Usp547.29E-100.35 238 7250.4580.3172.35E-05ubiquitin specific peptidase 54 [Source:MGI Symbol;Acc:MGI:1 926 037]
Mtss19.29E-100.25 566 7840.2610.1143.00E-05MTSS I-BAR domain containing 1 [Source:MGI Symbol;Acc:MGI:2 384 818]
Kat2b1.19E-090.31 444 9630.4230.2243.85E-05K(lysine) acetyltransferase 2B [Source:MGI Symbol;Acc:MGI:1 343 094]
Dpysl21.24E-090.3 221 7760.5490.3434.00E-05dihydropyrimidinase-like 2 [Source:MGI Symbol;Acc:MGI:1 349 763]
Gna121.28E-090.29 101 1180.380.1754.14E-05guanine nucleotide binding protein, alpha 12 [Source:MGI Symbol;Acc:MGI:95 767]
Ywhaq1.52E-090.30 001 3210.4150.2214.92E-05tyrosine 3-monooxygenase/tryptophan 5-monooxygenase activation protein theta [Source:MGI Symbol;Acc:MGI:891 963]
Kif1b1.55E-090.36 174 4040.9230.815.01E-05kinesin family member 1B [Source:MGI Symbol;Acc:MGI:108 426]
5031439G07Rik1.55E-090.30 489 7880.5350.3895.02E-05RIKEN cDNA 5031439G07 gene [Source:MGI Symbol;Acc:MGI:2 444 899]
Nrbp21.59E-090.32 356 9840.3940.2155.12E-05nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Ncoa31.61E-090.25 337 7610.2750.1045.19E-05nuclear receptor coactivator 3 [Source:MGI Symbol;Acc:MGI:1 276 535]
Otud7a1.77E-090.50 197 6170.7040.4735.73E-05OTU domain containing 7A [Source:MGI Symbol;Acc:MGI:2 158 505]
Daam11.89E-090.38 269 9520.5630.4046.11E-05dishevelled associated activator of morphogenesis 1 [Source:MGI Symbol;Acc:MGI:1 914 596]
Ankrd284.30E-090.34 478 5890.5560.3650.00 013 897ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Fryl4.33E-090.32 061 0060.570.3320.00 013 975FRY like transcription coactivator [Source:MGI Symbol;Acc:MGI:1 919 563]
Ncam25.63E-090.52 172 6850.7540.5570.00 018 185neural cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:97 282]
Pakap.15.86E-090.25 161 4460.2680.1010.0 001 892NA
Cpeb26.71E-090.27 668 3380.3660.2540.00 021 677cytoplasmic polyadenylation element binding protein 2 [Source:MGI Symbol;Acc:MGI:2 442 640]
Pld17.92E-090.26 934 3650.2610.0930.00 025 557phospholipase D1 [Source:MGI Symbol;Acc:MGI:109 585]
Retreg18.48E-090.28 313 5660.3240.1260.0 002 738reticulophagy regulator 1 [Source:MGI Symbol;Acc:MGI:1 913 520]
Apod8.62E-090.27 079 6840.3450.2130.0 002 784apolipoprotein D [Source:MGI Symbol;Acc:MGI:88 056]
Atp11a1.01E-080.25 199 2730.2820.1510.00 032 617ATPase, class VI, type 11A [Source:MGI Symbol;Acc:MGI:1 354 735]
Sema6a1.31E-080.30 897 1740.2960.1020.00 042 137sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
2610035D17Rik1.51E-080.40 048 9710.5770.4280.00 048 781RIKEN cDNA 2610035D17 gene [Source:MGI Symbol;Acc:MGI:1 919 636]
Baz2b1.57E-080.37 303 6250.6970.5510.00 050 559bromodomain adjacent to zinc finger domain, 2B [Source:MGI Symbol;Acc:MGI:2 442 782]
Wdr202.34E-080.25 520 2230.3380.1590.00 075 438WD repeat domain 20 [Source:MGI Symbol;Acc:MGI:1 916 891]
Cttnbp22.40E-080.32 095 6070.4580.2660.0 007 738cortactin binding protein 2 [Source:MGI Symbol;Acc:MGI:1 353 467]
Osbpl1a2.57E-080.31 900 4890.4930.3250.00 082 996oxysterol binding protein-like 1A [Source:MGI Symbol;Acc:MGI:1 927 551]
Abhd17b2.70E-080.29 402 5890.4650.290.00 087 174abhydrolase domain containing 17B [Source:MGI Symbol;Acc:MGI:1 917 816]
Rnf133.01E-080.27 892 3080.4230.2290.000 972ring finger protein 13 [Source:MGI Symbol;Acc:MGI:1 346 341]
Tmem132b4.93E-080.26 716 1940.2680.1010.00 159 086transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Gnao15.42E-080.3 966 2220.8380.6540.00 175 013guanine nucleotide binding protein, alpha O [Source:MGI Symbol;Acc:MGI:95 775]
Pde1c5.66E-080.25 711 3140.2320.0510.00 182 824phosphodiesterase 1C [Source:MGI Symbol;Acc:MGI:108 413]
Pvt17.44E-080.25 652 9580.310.1540.00 240 229Pvt1 oncogene [Source:MGI Symbol;Acc:MGI:97 824]
Pard38.43E-080.3 133 2860.5920.4540.00 272 182par-3 family cell polarity regulator [Source:MGI Symbol;Acc:MGI:2 135 608]
Malat18.64E-080.26 747 411110.00 279 021metastasis associated lung adenocarcinoma transcript 1 (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 919 539]
Dcc9.55E-080.34 680 7950.50.2940.00 308 213deleted in colorectal carcinoma [Source:MGI Symbol;Acc:MGI:94 869]
Zcchc71.00E-070.32 309 1350.690.50.00 323 528zinc finger, CCHC domain containing 7 [Source:MGI Symbol;Acc:MGI:2 442 912]
Limch11.08E-070.35 675 4480.7390.6320.00 349 991LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Detailed analysis of AG1. (A) Gene markers related with neurogenesis and neuronal development. Dark blue violin plots correspond to cell clusters of AG1 in individual samples (cx: cortex, sc:spinal cord). (B) Gene ontology enrichment analysis results of the significantly upregulated markers in AG1. (C) SEMA6 signaling pathway ligand-receptor components RNA expression across neuronal clusters and AGs. (D) SEMA6 cell-cell communication network analysis between neuronal clusters and AGs. The only AG actively communicating is AG1. (E) Heatmap of the SEMA6 signaling pathway and the role in the communication of the different neuronal and AGs.
Figure 4.

Detailed analysis of AG1. (A) Gene markers related with neurogenesis and neuronal development. Dark blue violin plots correspond to cell clusters of AG1 in individual samples (cx: cortex, sc:spinal cord). (B) Gene ontology enrichment analysis results of the significantly upregulated markers in AG1. (C) SEMA6 signaling pathway ligand-receptor components RNA expression across neuronal clusters and AGs. (D) SEMA6 cell-cell communication network analysis between neuronal clusters and AGs. The only AG actively communicating is AG1. (E) Heatmap of the SEMA6 signaling pathway and the role in the communication of the different neuronal and AGs.

Interestingly, Foxp1, a TF with major roles in gene transcription regulation of tissue and cell type-specificity, and involved in subtype identity coordination, migration, and organization of motor neurons [75–77], showed a diverse expression across all groups, but it was significantly upregulated in AG1 of motor cortex. Additional TFs found significantly upregulated included Creb5, Litaf, Nfe2l3, Tulp4, Tcf12, Rere, and Pbx3.

Tmem117 transmembrane protein was found expressed uniquely in AG1 from spinal cord, being both group 1 and tissue specific marker.

Achaete-scute family bHLH TF 1 (Ascl1) gene was significantly upregulated in AG1. Magnusson et al. demonstrated that Ascl1 + mature astrocytes take on a progenitor-cell like role and become neurogenic after stroke in adult mice [78]. Similar small populations related with progenitor cells have been described in rodent hippocampus, linked with GFAP expression [79], or defined by high expression of Frzb, Ascl1, and Slc1a3 [80], although there is no consensus if misidentification of progenitors in adult brain could be due to de-differentiation of mature neurons [81].

To extend the understanding of these findings in a multicellular scenario and how AG1 might interact with specific sets of neurons, we analyzed cell-cell communication patterns and signaling pathways based on ligand-receptor interactions using the motor cortex expression data from the tree mice, between neuron clusters and the three different AG. Results show SEMA6 signaling and communication pathway exclusively active between AG1 and specific neuron clusters 3, 4, and 8 (Fig. 4CE). SEMA6 signaling network, with known roles in CNS development, neuron migration and axon guidance [82–84], was shown to be active among AG1 with a signaling sender role mediated by expression of Sema6a in AG1 (Fig. 4C and E). All AG1, AG2 and AG3 showed moderated expression of receptors Nrg1 and Nrg3, but Erbb4 receptor was exclusively expressed in AG1. AG3 had exclusively a sender role in the NRG signaling pathway, AG1 on the contrary had a receiver role. Neuregulins (NRGs) are a large family of growth factors that stimulate ERBB receptor tyrosine kinases and are critical for the assembly of the GABAergic circuitry including interneuron migration, neural differentiation, axon and dendrite development, myelination and synapse formation [85–88].

These gene markers and findings have been previously described in scientific literature, in which they have been linked with mature astrocytes promoting a neurogenic environment or acquiring progenitor-cell like properties [78, 89–94].

GFAP-positive astrocyte population

Astrocyte group 2 (AG2) yielded 223 genes that were differentially upregulated (P-value < 0.005, Table 2). Within this list, Gfap was among the top, particularly in the motor cortex, where it was almost exclusively expressed in AG2 cell clusters. Additional markers of astrocyte activation [67] were found upregulated on the AG2 population, including Aldoc, Stat3, and C3.

Table 2.

Differentially upregulated genes (P value < 0.005) in AG2 in comparison with AG1 and AG3

Genep_valavg_log2FCpct.1pct.2p_val_adjdescription
Ablim202.01 268 2050.5920.1420actin-binding LIM protein 2 [Source:MGI Symbol;Acc:MGI:2 385 758]
Gpc50−2.42154350.5230.9780glypican 5 [Source:MGI Symbol;Acc:MGI:1 194 894]
Trpm30−2.77725470.4750.9310transient receptor potential cation channel, subfamily M, member 3 [Source:MGI Symbol;Acc:MGI:2 443 101]
Lsamp5.69E-249−1.48518030.99311.84E-244limbic system-associated membrane protein [Source:MGI Symbol;Acc:MGI:1 261 760]
Plcb16.73E-181−1.7406110.670.9462.17E-176phospholipase C, beta 1 [Source:MGI Symbol;Acc:MGI:97 613]
6330411D24Rik6.01E-1802.09 342 4640.4010.0221.94E-175RIKEN cDNA 6330411D24 gene [Source:MGI Symbol;Acc:MGI:1 917 975]
Kcnd25.20E-170−1.93504750.3730.7061.68E-165potassium voltage-gated channel, Shal-related family, member 2 [Source:MGI Symbol;Acc:MGI:102 663]
Prune22.77E-1681.331 2720.6140.1358.94E-164prune homolog 2 [Source:MGI Symbol;Acc:MGI:1 925 004]
Sorbs21.02E-1671.50 461 4180.6180.1733.30E-163sorbin and SH3 domain containing 2 [Source:MGI Symbol;Acc:MGI:1 924 574]
Kirrel36.70E-158−1.79298880.4010.8792.16E-153kirre like nephrin family adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 914 953]
Gfap7.52E-1541.81 373 9420.6660.2152.43E-149glial fibrillary acidic protein [Source:MGI Symbol;Acc:MGI:95 697]
Mdga24.23E-152−1.30816060.8110.9741.36E-147MAM domain containing glycosylphosphatidylinositol anchor 2 [Source:MGI Symbol;Acc:MGI:2 444 706]
Nrxn12.30E-143−1.27407430.8630.9987.42E-139neurexin I [Source:MGI Symbol;Acc:MGI:1 096 391]
Gm37647.00E-142−1.25984060.7270.9372.26E-137predicted gene 3764 [Source:MGI Symbol;Acc:MGI:3 781 938]
Grik24.07E-1331.35 293 1470.7960.4631.31E-128glutamate receptor, ionotropic, kainate 2 (beta 2) [Source:MGI Symbol;Acc:MGI:95 815]
Cacnb25.58E-1301.4 550 6950.6440.2571.80E-125calcium channel, voltage-dependent, beta 2 subunit [Source:MGI Symbol;Acc:MGI:894 644]
Ccdc1486.30E-1221.04 581 6740.4010.0552.04E-117coiled-coil domain containing 148 [Source:MGI Symbol;Acc:MGI:3 039 583]
Pkp41.87E-1211.16 887 2370.610.2336.05E-117plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Gm122391.17E-119−1.56307290.150.5663.78E-115predicted gene 12 239 [Source:MGI Symbol;Acc:MGI:3 651 547]
Adamtsl11.78E-1181.0 194 3730.3690.0385.76E-114ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
A2m1.89E-1091.16 768 9790.4210.0656.11E-105alpha-2-macroglobulin [Source:MGI Symbol;Acc:MGI:2 449 119]
Rora3.95E-109−1.07252170.9520.9891.28E-104RAR-related orphan receptor alpha [Source:MGI Symbol;Acc:MGI:104 661]
Pcdh94.52E-109−1.08897650.9440.9921.46E-104protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Slc38a16.45E-1081.18 683 5730.6290.2362.08E-103solute carrier family 38, member 1 [Source:MGI Symbol;Acc:MGI:2 145 895]
Cadps3.49E-1011.07 111 9480.6810.3051.13E-96Ca2+-dependent secretion activator [Source:MGI Symbol;Acc:MGI:1 350 922]
Pitpnc15.38E-101−1.20861830.6940.9131.74E-96phosphatidylinositol transfer protein, cytoplasmic 1 [Source:MGI Symbol;Acc:MGI:1 919 045]
Kcnj33.06E-980.90 152 9530.5620.1669.89E-94potassium inwardly-rectifying channel, subfamily J, member 3 [Source:MGI Symbol;Acc:MGI:104 742]
Gm149641.15E-960.76 450 6180.5080.1593.70E-92predicted gene 14 964 [Source:MGI Symbol;Acc:MGI:3 641 621]
Ccdc35.80E-960.76 885 9680.3410.0241.87E-91coiled-coil domain containing 3 [Source:MGI Symbol;Acc:MGI:1 921 436]
Asap31.18E-930.63 349 4210.3430.0273.82E-89ArfGAP with SH3 domain, ankyrin repeat and PH domain 3 [Source:MGI Symbol;Acc:MGI:2 684 986]
Atp1a21.41E-92−0.95126260.7790.9324.56E-88ATPase, Na+/K + transporting, alpha 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 106]
Gm48764.73E-880.82 426 1180.4770.1311.53E-83predicted gene 4876 [Source:MGI Symbol;Acc:MGI:3 647 654]
Car109.87E-88−1.17006910.2520.4793.19E-83carbonic anhydrase 10 [Source:MGI Symbol;Acc:MGI:1 919 855]
Ldb21.61E-860.78 138 8860.4620.1195.19E-82LIM domain binding 2 [Source:MGI Symbol;Acc:MGI:894 670]
Arhgef46.30E-861.03 026 8930.7720.5642.03E-81Rho guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:2 442 507]
Prkag26.94E-850.77 822 6080.4920.1562.24E-80protein kinase, AMP-activated, gamma 2 non-catalytic subunit [Source:MGI Symbol;Acc:MGI:1 336 153]
Col23a18.05E-851.11 579 5670.4690.112.60E-80collagen, type XXIII, alpha 1 [Source:MGI Symbol;Acc:MGI:2 653 243]
Brinp34.08E-84−1.05676250.2670.6981.32E-79bone morphogenetic protein/retinoic acid inducible neural specific 3 [Source:MGI Symbol;Acc:MGI:2 443 035]
Myoc9.22E-830.80 203 1310.2730.0122.98E-78myocilin [Source:MGI Symbol;Acc:MGI:1 202 864]
Pdzrn34.51E-820.69 065 9930.4340.11.46E-77PDZ domain containing RING finger 3 [Source:MGI Symbol;Acc:MGI:1 933 157]
C4b9.92E-820.67 373 8660.4010.0733.20E-77complement component 4B (Chido blood group) [Source:MGI Symbol;Acc:MGI:88 228]
Gm207131.04E-81−1.16710950.1480.713.35E-77predicted gene 20 713 [Source:MGI Symbol;Acc:MGI:5 313 160]
Cadm29.70E-81−0.86774230.8870.9913.13E-76cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:2 442 722]
Cobll11.01E-800.69 941 5610.380.0583.26E-76Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Tmem1087.84E-790.68 764 5550.3250.0482.53E-74transmembrane protein 108 [Source:MGI Symbol;Acc:MGI:1 932 411]
Slc6a111.58E-78−0.95280880.260.5775.11E-74solute carrier family 6 (neurotransmitter transporter, GABA), member 11 [Source:MGI Symbol;Acc:MGI:95 630]
Gria28.90E-78−1.17085270.4010.7652.87E-73glutamate receptor, ionotropic, AMPA2 (alpha 2) [Source:MGI Symbol;Acc:MGI:95 809]
Ptch11.21E-77−1.03795650.1780.5723.91E-73patched 1 [Source:MGI Symbol;Acc:MGI:105 373]
Nhsl12.00E-77−1.00848890.3620.7246.47E-73NHS-like 1 [Source:MGI Symbol;Acc:MGI:106 390]
Cd443.84E-750.61 517 8670.2890.0221.24E-70CD44 antigen [Source:MGI Symbol;Acc:MGI:88 338]
Adgrb38.83E-75−0.93077680.8760.9562.85E-70adhesion G protein-coupled receptor B3 [Source:MGI Symbol;Acc:MGI:2 441 837]
Man1c12.14E-730.63 698 9220.3360.0636.91E-69mannosidase, alpha, class 1C, member 1 [Source:MGI Symbol;Acc:MGI:2 446 214]
Prkca4.62E-710.97 231 7920.80.5611.49E-66protein kinase C, alpha [Source:MGI Symbol;Acc:MGI:97 595]
Sntg21.58E-700.49 453 6240.2820.0155.10E-66syntrophin, gamma 2 [Source:MGI Symbol;Acc:MGI:1 919 541]
Sulf21.19E-690.53 943 0030.2910.0443.85E-65sulfatase 2 [Source:MGI Symbol;Acc:MGI:1 919 293]
Glis32.10E-690.81 574 3810.790.5286.77E-65GLIS family zinc finger 3 [Source:MGI Symbol;Acc:MGI:2 444 289]
Nrp28.88E-690.52 318 1580.3230.0452.87E-64neuropilin 2 [Source:MGI Symbol;Acc:MGI:1 100 492]
Reep17.50E-670.64 992 3470.3430.0692.42E-62receptor accessory protein 1 [Source:MGI Symbol;Acc:MGI:1 098 827]
Slc7a105.38E-65−1.11624910.0650.5521.74E-60solute carrier family 7 (cationic amino acid transporter, y + system), member 10 [Source:MGI Symbol;Acc:MGI:1 858 261]
Pde7b6.13E-65−0.99651790.2730.7011.98E-60phosphodiesterase 7B [Source:MGI Symbol;Acc:MGI:1 352 752]
Ctnna22.42E-631.08 054 9980.8440.6767.81E-59catenin (cadherin associated protein), alpha 2 [Source:MGI Symbol;Acc:MGI:88 275]
Csmd17.81E-630.67 950 1760.5770.3952.52E-58CUB and Sushi multiple domains 1 [Source:MGI Symbol;Acc:MGI:2 137 383]
Sorbs11.00E-620.95 190 3380.8290.6383.24E-58sorbin and SH3 domain containing 1 [Source:MGI Symbol;Acc:MGI:700 014]
Aebp11.73E-620.45 464 3510.2580.0135.59E-58AE binding protein 1 [Source:MGI Symbol;Acc:MGI:1 197 012]
Sema3a1.11E-600.54 359 6090.2520.033.59E-56sema domain, immunoglobulin domain (Ig), short basic domain, secreted, (semaphorin) 3A [Source:MGI Symbol;Acc:MGI:107 558]
Rgs72.21E-60−1.01278830.2430.6427.14E-56regulator of G protein signaling 7 [Source:MGI Symbol;Acc:MGI:1 346 089]
Slc8a15.29E-600.95 401 4560.5210.2471.71E-55solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Synpo25.36E-600.82 634 0960.4970.1651.73E-55synaptopodin 2 [Source:MGI Symbol;Acc:MGI:2 153 070]
Dock47.62E-60−0.79633060.5790.812.46E-55dedicator of cytokinesis 4 [Source:MGI Symbol;Acc:MGI:1 918 006]
C530044C16Rik1.87E-590.4 873 9990.2340.0126.04E-55RIKEN cDNA C530044C16 gene [Source:MGI Symbol;Acc:MGI:2 443 109]
Tagln34.73E-590.61 896 3830.5770.2991.53E-54transgelin 3 [Source:MGI Symbol;Acc:MGI:1 926 784]
Adgrl31.51E-57−0.71364630.7790.8994.88E-53adhesion G protein-coupled receptor L3 [Source:MGI Symbol;Acc:MGI:2 441 950]
Cpne82.52E-560.41 103 0570.2620.0378.13E-52copine VIII [Source:MGI Symbol;Acc:MGI:1 914 121]
Phyhd14.30E-560.6 780 0510.5340.2281.39E-51phytanoyl-CoA dioxygenase domain containing 1 [Source:MGI Symbol;Acc:MGI:3 612 860]
Gria44.97E-56−0.85760140.2060.421.60E-51glutamate receptor, ionotropic, AMPA4 (alpha 4) [Source:MGI Symbol;Acc:MGI:95 811]
Padi28.82E-560.61 810 8460.4230.1282.85E-51peptidyl arginine deiminase, type II [Source:MGI Symbol;Acc:MGI:1 338 892]
Robo21.23E-540.9 155 6120.7870.5693.98E-50roundabout guidance receptor 2 [Source:MGI Symbol;Acc:MGI:1 890 110]
Ccser11.27E-540.80 908 8570.4730.2874.09E-50coiled-coil serine rich 1 [Source:MGI Symbol;Acc:MGI:3 045 354]
St6galnac32.01E-541.53 920 7550.540.1396.49E-50ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Cdh108.08E-54−0.77856710.4450.7362.61E-49cadherin 10 [Source:MGI Symbol;Acc:MGI:107 436]
Dok61.84E-530.70 032 1640.4620.1635.93E-49docking protein 6 [Source:MGI Symbol;Acc:MGI:3 639 495]
Smad63.72E-530.34 957 9810.2470.0341.20E-48SMAD family member 6 [Source:MGI Symbol;Acc:MGI:1 336 883]
Aqp46.40E-530.78 867 0240.7010.4032.07E-48aquaporin 4 [Source:MGI Symbol;Acc:MGI:107 387]
Grm79.42E-510.88 253 3170.4620.2293.04E-46glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Dgki6.91E-500.76 957 4490.5730.2442.23E-45diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Tex111.04E-490.36 512 0030.2150.0123.35E-45testis expressed gene 11 [Source:MGI Symbol;Acc:MGI:1 933 237]
Ahnak1.08E-480.32 270 0590.2340.0273.48E-44AHNAK nucleoprotein (desmoyokin) [Source:MGI Symbol;Acc:MGI:1 316 648]
Trp632.37E-48−0.91803720.0350.3187.64E-44transformation related protein 63 [Source:MGI Symbol;Acc:MGI:1 330 810]
Tnc2.67E-480.37 489 8670.2340.0238.61E-44tenascin C [Source:MGI Symbol;Acc:MGI:101 922]
Reln3.62E-480.6 459 5270.3970.1091.17E-43reelin [Source:MGI Symbol;Acc:MGI:103 022]
Pxdn3.76E-480.4 112 2210.2930.0721.21E-43peroxidasin [Source:MGI Symbol;Acc:MGI:1 916 925]
Atp13a47.34E-48−0.66697550.1450.4862.37E-43ATPase type 13A4 [Source:MGI Symbol;Acc:MGI:1 924 456]
Cacnb49.29E-470.71 396 1130.4840.2383.00E-42calcium channel, voltage-dependent, beta 4 subunit [Source:MGI Symbol;Acc:MGI:103 301]
Adamts92.03E-460.68 554 0960.4990.2026.57E-42a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 9 [Source:MGI Symbol;Acc:MGI:1 916 320]
Tmtc23.43E-46−0.73294880.2430.5761.11E-41transmembrane and tetratricopeptide repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 914 057]
Limch17.50E-46−0.68115580.3950.6812.42E-41LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Grid21.96E-45−0.66948460.7090.9066.34E-41glutamate receptor, ionotropic, delta 2 [Source:MGI Symbol;Acc:MGI:95 813]
Cadm12.29E-45−0.80658970.5490.8357.40E-41cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:1 889 272]
Sema6a1.15E-440.44 205 1310.3150.0743.73E-40sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
Ggta13.51E-440.29 853 8780.1930.0181.13E-39glycoprotein galactosyltransferase alpha 1, 3 [Source:MGI Symbol;Acc:MGI:95 704]
Npas35.45E-44−0.57127180.9440.9811.76E-39neuronal PAS domain protein 3 [Source:MGI Symbol;Acc:MGI:1 351 610]
Garnl37.71E-440.42 029 5370.3060.0932.49E-39GTPase activating RANGAP domain-like 3 [Source:MGI Symbol;Acc:MGI:2 139 309]
Kcnma11.92E-43−0.78100460.310.6676.19E-39potassium large conductance calcium-activated channel, subfamily M, alpha member 1 [Source:MGI Symbol;Acc:MGI:99 923]
Auts22.67E-43−0.7000360.7350.9138.63E-39autism susceptibility candidate 2 [Source:MGI Symbol;Acc:MGI:1 919 847]
Fmn12.69E-430.79 828 6930.4270.1988.69E-39formin 1 [Source:MGI Symbol;Acc:MGI:101 815]
Disp32.97E-430.4 166 9970.2520.0799.59E-39dispatched RND transporter family member 3 [Source:MGI Symbol;Acc:MGI:2 444 403]
Grin3a4.31E-430.59 174 3050.3860.1361.39E-38glutamate receptor ionotropic, NMDA3A [Source:MGI Symbol;Acc:MGI:1 933 206]
Sema6d8.82E-430.98 719 6660.7110.5332.85E-38sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6D [Source:MGI Symbol;Acc:MGI:2 387 661]
Pcdh71.43E-42−0.62898410.7350.8744.62E-38protocadherin 7 [Source:MGI Symbol;Acc:MGI:1 860 487]
Ank21.64E-420.95 150 8240.9390.9555.30E-38ankyrin 2, brain [Source:MGI Symbol;Acc:MGI:88 025]
Mast41.87E-41−0.67183640.440.7166.04E-37microtubule associated serine/threonine kinase family member 4 [Source:MGI Symbol;Acc:MGI:1 918 885]
Slc4a42.81E-41−0.55013950.8520.9199.08E-37solute carrier family 4 (anion exchanger), member 4 [Source:MGI Symbol;Acc:MGI:1 927 555]
Ano15.02E-410.46 720 2610.2150.0031.62E-36anoctamin 1, calcium activated chloride channel [Source:MGI Symbol;Acc:MGI:2 142 149]
Cmya58.05E-410.45 054 9590.3410.0972.60E-36cardiomyopathy associated 5 [Source:MGI Symbol;Acc:MGI:1 923 719]
Dner1.62E-400.46 188 8890.3990.1765.22E-36delta/notch-like EGF repeat containing [Source:MGI Symbol;Acc:MGI:2 152 889]
Gpld12.60E-40−0.63787620.080.3858.38E-36glycosylphosphatidylinositol specific phospholipase D1 [Source:MGI Symbol;Acc:MGI:106 604]
Negr12.65E-40−0.69709820.620.8528.56E-36neuronal growth regulator 1 [Source:MGI Symbol;Acc:MGI:2 444 846]
Anxa21.10E-390.27 925 3720.1760.0123.54E-35annexin A2 [Source:MGI Symbol;Acc:MGI:88 246]
Vav32.04E-39−0.6866090.0910.4396.58E-35vav 3 oncogene [Source:MGI Symbol;Acc:MGI:1 888 518]
Airn2.14E-390.4 276 2380.2320.0576.90E-35antisense Igf2r RNA [Source:MGI Symbol;Acc:MGI:1 353 471]
Mgat4a2.28E-390.32 616 9760.2170.0397.37E-35mannoside acetylglucosaminyltransferase 4, isoenzyme A [Source:MGI Symbol;Acc:MGI:2 662 992]
Enox14.40E-390.73 574 6870.4990.2741.42E-34ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Frmd4a6.76E-39−0.75556080.7350.9292.18E-34FERM domain containing 4A [Source:MGI Symbol;Acc:MGI:1 919 850]
Eps87.63E-39−0.59955040.2190.5232.46E-34epidermal growth factor receptor pathway substrate 8 [Source:MGI Symbol;Acc:MGI:104 684]
Gm106358.27E-390.4 519 9270.2190.0222.67E-34predicted gene 10 635 [Source:MGI Symbol;Acc:MGI:3 641 740]
Atoh89.59E-390.28 185 6110.1650.0083.10E-34atonal bHLH transcription factor 8 [Source:MGI Symbol;Acc:MGI:1 918 343]
Slc16a23.09E-380.31 372 7040.2280.0519.98E-34solute carrier family 16 (monocarboxylic acid transporters), member 2 [Source:MGI Symbol;Acc:MGI:1 203 732]
Tab28.33E-380.49 912 7840.5210.2572.69E-33TGF-beta activated kinase 1/MAP3K7 binding protein 2 [Source:MGI Symbol;Acc:MGI:1 915 902]
Gm110999.08E-380.33 560 9310.1560.0072.93E-33predicted gene 11 099 [Source:MGI Symbol;Acc:MGI:3 779 335]
Itih39.39E-38−0.61596580.0740.3323.03E-33inter-alpha trypsin inhibitor, heavy chain 3 [Source:MGI Symbol;Acc:MGI:96 620]
P3h21.14E-360.29 550 0610.1780.0183.69E-32prolyl 3-hydroxylase 2 [Source:MGI Symbol;Acc:MGI:2 146 663]
Cables11.22E-36−0.5880480.1450.4593.95E-32CDK5 and Abl enzyme substrate 1 [Source:MGI Symbol;Acc:MGI:1 927 065]
4930402H24Rik1.48E-360.65 012 5090.8550.8344.78E-32NA
Syne11.85E-36−0.55320050.7480.8785.97E-32spectrin repeat containing, nuclear envelope 1 [Source:MGI Symbol;Acc:MGI:1 927 152]
Grm33.44E-36−0.89460450.3340.5831.11E-31glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Eya44.53E-360.43 761 3450.310.1021.46E-31EYA transcriptional coactivator and phosphatase 4 [Source:MGI Symbol;Acc:MGI:1 337 104]
Mamdc23.19E-350.27 013 5470.1560.0071.03E-30MAM domain containing 2 [Source:MGI Symbol;Acc:MGI:1 918 988]
Slc1a24.34E-35−0.55237630.9670.9981.40E-30solute carrier family 1 (glial high affinity glutamate transporter), member 2 [Source:MGI Symbol;Acc:MGI:101 931]
Nxn5.99E-350.62 688 2070.6510.4271.93E-30nucleoredoxin [Source:MGI Symbol;Acc:MGI:109 331]
Phactr36.21E-35−0.57997520.1760.5162.01E-30phosphatase and actin regulator 3 [Source:MGI Symbol;Acc:MGI:1 921 439]
Ccdc85a1.62E-34−0.62650680.1870.5195.22E-30coiled-coil domain containing 85A [Source:MGI Symbol;Acc:MGI:2 445 069]
Ndrg24.31E-34−0.49506960.5790.7271.39E-29N-myc downstream regulated gene 2 [Source:MGI Symbol;Acc:MGI:1 352 498]
Htra15.00E-34−0.57374980.3770.6611.61E-29HtrA serine peptidase 1 [Source:MGI Symbol;Acc:MGI:1 929 076]
St3gal48.55E-34−0.58873510.2650.5412.76E-29ST3 beta-galactoside alpha-2,3-sialyltransferase 4 [Source:MGI Symbol;Acc:MGI:1 316 743]
Tmem132b1.11E-330.31 405 0380.2650.0813.59E-29transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Nav31.86E-33−0.60843310.3170.5146.00E-29neuron navigator 3 [Source:MGI Symbol;Acc:MGI:2 183 703]
Atp2b42.16E-330.32 348 1480.2650.0816.97E-29ATPase, Ca++ transporting, plasma membrane 4 [Source:MGI Symbol;Acc:MGI:88 111]
Met2.35E-330.29 645 2570.1630.0057.60E-29met proto-oncogene [Source:MGI Symbol;Acc:MGI:96 969]
Flnc7.50E-330.27 142 0560.1410.012.42E-28filamin C, gamma [Source:MGI Symbol;Acc:MGI:95 557]
Fat31.86E-32−0.54469370.5360.6686.01E-28FAT atypical cadherin 3 [Source:MGI Symbol;Acc:MGI:2 444 314]
Id32.99E-320.44 213 5360.3820.1389.65E-28inhibitor of DNA binding 3 [Source:MGI Symbol;Acc:MGI:96 398]
Acsbg13.38E-32−0.51663020.3750.5931.09E-27acyl-CoA synthetase bubblegum family member 1 [Source:MGI Symbol;Acc:MGI:2 385 656]
Ptprg5.17E-32−0.54858780.4790.6311.67E-27NA
Tenm46.03E-32−0.49947230.2080.4141.95E-27teneurin transmembrane protein 4 [Source:MGI Symbol;Acc:MGI:2 447 063]
Slc6a16.17E-32−0.46255770.390.5951.99E-27solute carrier family 6 (neurotransmitter transporter, GABA), member 1 [Source:MGI Symbol;Acc:MGI:95 627]
Fgfr37.78E-32−0.46368980.4160.6252.51E-27fibroblast growth factor receptor 3 [Source:MGI Symbol;Acc:MGI:95 524]
Kcnip32.19E-31−0.50406720.1320.3697.08E-27Kv channel interacting protein 3, calsenilin [Source:MGI Symbol;Acc:MGI:1 929 258]
Ntng12.53E-310.47 422 6670.2470.0618.18E-27netrin G1 [Source:MGI Symbol;Acc:MGI:1 934 028]
Tmc74.94E-31−0.49709030.0910.3361.59E-26transmembrane channel-like gene family 7 [Source:MGI Symbol;Acc:MGI:2 443 317]
Tafa15.30E-31−0.65893280.1080.3081.71E-26TAFA chemokine like family member 1 [Source:MGI Symbol;Acc:MGI:2 443 695]
Frmpd46.58E-310.36 641 1150.2860.1362.12E-26FERM and PDZ domain containing 4 [Source:MGI Symbol;Acc:MGI:3 042 378]
Cep85l2.02E-30−0.48200370.3340.5686.52E-26centrosomal protein 85-like [Source:MGI Symbol;Acc:MGI:3 642 684]
Prickle22.16E-300.63 320 0450.610.3696.96E-26prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
C33.37E-300.26 171 3210.1480.0121.09E-25complement component 3 [Source:MGI Symbol;Acc:MGI:88 227]
Pdgfd4.30E-300.64 872 8860.6070.3891.39E-25platelet-derived growth factor, D polypeptide [Source:MGI Symbol;Acc:MGI:1 919 035]
Miat4.48E-300.28 579 9650.210.0561.45E-25myocardial infarction associated transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 886]
Kalrn4.56E-30−0.55721350.2490.5561.47E-25kalirin, RhoGEF kinase [Source:MGI Symbol;Acc:MGI:2 685 385]
Klhl294.79E-300.34 632 9080.330.1281.54E-25kelch-like 29 [Source:MGI Symbol;Acc:MGI:2 683 857]
Osbpl35.99E-300.32 270 9410.2190.0571.93E-25oxysterol binding protein-like 3 [Source:MGI Symbol;Acc:MGI:1 918 970]
Atp1b22.35E-29−0.48022990.4210.5317.59E-25ATPase, Na+/K + transporting, beta 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 109]
Dgkb2.41E-29−0.54566150.7460.8967.79E-25diacylglycerol kinase, beta [Source:MGI Symbol;Acc:MGI:2 442 474]
2610307P16Rik2.50E-290.44 161 5380.2650.0658.07E-25RIKEN cDNA 2610307P16 gene [Source:MGI Symbol;Acc:MGI:1 919 768]
Dock52.53E-29−0.42793390.0980.2718.17E-25dedicator of cytokinesis 5 [Source:MGI Symbol;Acc:MGI:2 652 871]
Slco1c12.73E-29−0.58344170.150.4538.80E-25solute carrier organic anion transporter family, member 1c1 [Source:MGI Symbol;Acc:MGI:1 889 679]
Grin2c4.74E-29−0.51409050.1040.4211.53E-24glutamate receptor, ionotropic, NMDA2C (epsilon 3) [Source:MGI Symbol;Acc:MGI:95 822]
Plekha64.74E-290.32 322 5750.2620.081.53E-24pleckstrin homology domain containing, family A member 6 [Source:MGI Symbol;Acc:MGI:2 388 662]
Luzp24.80E-29−1.1363530.6490.8881.55E-24leucine zipper protein 2 [Source:MGI Symbol;Acc:MGI:1 889 615]
Apbb1ip8.64E-290.319 4610.1950.0212.79E-24amyloid beta (A4) precursor protein-binding, family B, member 1 interacting protein [Source:MGI Symbol;Acc:MGI:1 861 354]
Tnik1.81E-28−0.45286520.8480.9195.84E-24TRAF2 and NCK interacting kinase [Source:MGI Symbol;Acc:MGI:1 916 264]
Grk31.89E-28−0.48679820.2730.5626.11E-24G protein-coupled receptor kinase 3 [Source:MGI Symbol;Acc:MGI:87 941]
Nwd12.12E-28−0.49137720.4580.6956.83E-24NACHT and WD repeat domain containing 1 [Source:MGI Symbol;Acc:MGI:2 442 268]
Shroom33.36E-28−0.47205920.3120.4451.08E-23shroom family member 3 [Source:MGI Symbol;Acc:MGI:1 351 655]
Hip14.84E-28−0.48733460.2210.4791.56E-23huntingtin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 099 804]
Armc21.06E-270.35 458 0490.260.0813.43E-23armadillo repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 916 449]
Plscr41.14E-270.36 422 8220.3150.1023.67E-23phospholipid scramblase 4 [Source:MGI Symbol;Acc:MGI:2 143 267]
Cep1123.75E-270.31 022 3890.2580.081.21E-22centrosomal protein 112 [Source:MGI Symbol;Acc:MGI:1 923 673]
Ahcyl14.67E-27−0.46130040.4380.6641.51E-22S-adenosylhomocysteine hydrolase-like 1 [Source:MGI Symbol;Acc:MGI:2 385 184]
Mertk5.96E-27−0.62954020.5770.7941.92E-22MER proto-oncogene tyrosine kinase [Source:MGI Symbol;Acc:MGI:96 965]
Tulp47.54E-270.48 002 0980.590.3922.43E-22tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Tspan79.19E-27−0.60251660.5570.7832.97E-22tetraspanin 7 [Source:MGI Symbol;Acc:MGI:1 298 407]
Xylt11.90E-26−0.51734750.2230.5016.13E-22xylosyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 451 073]
St3gal62.80E-260.26 891 0790.1890.0429.05E-22ST3 beta-galactoside alpha-2,3-sialyltransferase 6 [Source:MGI Symbol;Acc:MGI:1 888 707]
Myo163.60E-260.3 868 6270.2750.0941.16E-21myosin XVI [Source:MGI Symbol;Acc:MGI:2 685 951]
Ptprj3.83E-26−0.51797520.2410.4251.24E-21protein tyrosine phosphatase, receptor type, J [Source:MGI Symbol;Acc:MGI:104 574]
Npas23.91E-26−0.47452730.3490.5611.26E-21neuronal PAS domain protein 2 [Source:MGI Symbol;Acc:MGI:109 232]
Abcc45.32E-260.25 504 1830.2280.0651.72E-21ATP-binding cassette, sub-family C (CFTR/MRP), member 4 [Source:MGI Symbol;Acc:MGI:2 443 111]
Ablim16.53E-26−0.4412370.260.5082.11E-21actin-binding LIM protein 1 [Source:MGI Symbol;Acc:MGI:1 194 500]
Pamr19.42E-260.31 300 2710.2430.083.04E-21peptidase domain containing associated with muscle regeneration 1 [Source:MGI Symbol;Acc:MGI:2 445 082]
Pde4b2.15E-25−0.61258360.3950.5646.93E-21phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Rfx23.58E-250.25 164 9040.2060.0531.16E-20regulatory factor X, 2 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:106 583]
Gjb63.65E-25−0.39927990.1060.3411.18E-20gap junction protein, beta 6 [Source:MGI Symbol;Acc:MGI:107 588]
Rapgef46.94E-250.3 878 8060.2690.1282.24E-20Rap guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:1 917 723]
Rps6ka57.23E-250.39 342 2340.4190.2182.34E-20ribosomal protein S6 kinase, polypeptide 5 [Source:MGI Symbol;Acc:MGI:1 920 336]
Slc6a98.63E-25−0.34170660.1080.2652.78E-20solute carrier family 6 (neurotransmitter transporter, glycine), member 9 [Source:MGI Symbol;Acc:MGI:95 760]
Gm351881.74E-24−0.51985970.3930.6425.61E-20predicted gene, 35 188 [Source:MGI Symbol;Acc:MGI:5 594 347]
Wdr171.84E-24−0.67369960.7160.8425.93E-20WD repeat domain 17 [Source:MGI Symbol;Acc:MGI:1 924 662]
Mgat4c1.93E-24−0.38743970.5080.5526.23E-20MGAT4 family, member C [Source:MGI Symbol;Acc:MGI:1 914 819]
Il6st1.96E-240.30 887 3980.2930.1146.31E-20interleukin 6 signal transducer [Source:MGI Symbol;Acc:MGI:96 560]
Fry2.03E-24−0.33083650.6010.6616.56E-20FRY microtubule binding protein [Source:MGI Symbol;Acc:MGI:2 443 895]
Ddr12.06E-240.34 612 2530.3190.1436.65E-20discoidin domain receptor family, member 1 [Source:MGI Symbol;Acc:MGI:99 216]
9530026P05Rik2.30E-240.6 724 1210.4510.2387.43E-20RIKEN cDNA 9530026P05 gene [Source:MGI Symbol;Acc:MGI:1 924 659]
Plcl12.96E-24−0.54617790.390.6029.55E-20phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Thbs43.13E-240.26 018 0990.1260.0181.01E-19thrombospondin 4 [Source:MGI Symbol;Acc:MGI:1 101 779]
Wasf34.11E-24−0.40801660.3230.5411.33E-19WASP family, member 3 [Source:MGI Symbol;Acc:MGI:2 658 986]
Bmpr1b4.19E-240.51 910 0950.7770.6711.35E-19bone morphogenetic protein receptor, type 1B [Source:MGI Symbol;Acc:MGI:107 191]
Abcg24.64E-240.2 696 1690.180.0391.50E-19ATP binding cassette subfamily G member 2 (Junior blood group) [Source:MGI Symbol;Acc:MGI:1 347 061]
Pacrg5.76E-240.51 573 1970.540.3051.86E-19PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Nav26.65E-240.50 495 9320.6720.5262.15E-19neuron navigator 2 [Source:MGI Symbol;Acc:MGI:2 183 691]
Adcy86.82E-240.49 769 6870.4210.2382.20E-19adenylate cyclase 8 [Source:MGI Symbol;Acc:MGI:1 341 110]
Arhgef287.54E-24−0.34171580.3360.4392.43E-19Rho guanine nucleotide exchange factor (GEF) 28 [Source:MGI Symbol;Acc:MGI:1 346 016]
Phka18.43E-24−0.49889370.4710.6452.72E-19phosphorylase kinase alpha 1 [Source:MGI Symbol;Acc:MGI:97 576]
Sorcs21.49E-23−0.40460820.1020.3424.82E-19sortilin-related VPS10 domain containing receptor 2 [Source:MGI Symbol;Acc:MGI:1 932 289]
Fgfr22.62E-23−0.49287160.6960.8268.45E-19fibroblast growth factor receptor 2 [Source:MGI Symbol;Acc:MGI:95 523]
Vegfa2.66E-23−0.44432130.3230.5338.58E-19vascular endothelial growth factor A [Source:MGI Symbol;Acc:MGI:103 178]
Phlpp12.95E-23−0.4415010.670.8059.52E-19PH domain and leucine rich repeat protein phosphatase 1 [Source:MGI Symbol;Acc:MGI:2 138 327]
Agbl43.41E-230.31 829 1360.280.1561.10E-18ATP/GTP binding protein-like 4 [Source:MGI Symbol;Acc:MGI:1 918 244]
Chd93.90E-23−0.39624570.6310.7681.26E-18chromodomain helicase DNA binding protein 9 [Source:MGI Symbol;Acc:MGI:1 924 001]
Syt75.17E-230.29 056 6340.2560.1091.67E-18synaptotagmin VII [Source:MGI Symbol;Acc:MGI:1 859 545]
Pgm55.43E-230.36 064 8080.2080.0371.75E-18phosphoglucomutase 5 [Source:MGI Symbol;Acc:MGI:1 925 668]
Nrcam7.62E-23−0.42771690.6550.8222.46E-18neuronal cell adhesion molecule [Source:MGI Symbol;Acc:MGI:104 750]
Esrrg1.51E-22−0.37881910.3580.4814.87E-18estrogen-related receptor gamma [Source:MGI Symbol;Acc:MGI:1 347 056]
Ski2.23E-220.36 561 5220.3560.1767.19E-18ski sarcoma viral oncogene homolog (avian) [Source:MGI Symbol;Acc:MGI:98 310]
Lrrc93.59E-220.25 188 7780.230.0741.16E-17leucine rich repeat containing 9 [Source:MGI Symbol;Acc:MGI:1 925 507]
Kmt2c4.36E-22−0.40842180.5030.6461.41E-17lysine (K)-specific methyltransferase 2C [Source:MGI Symbol;Acc:MGI:2 444 959]
Cdk175.13E-220.31 776 5450.3640.1951.66E-17cyclin-dependent kinase 17 [Source:MGI Symbol;Acc:MGI:97 517]
Bmp65.80E-220.30 526 8880.1890.0451.87E-17bone morphogenetic protein 6 [Source:MGI Symbol;Acc:MGI:88 182]
Mical26.40E-22−0.40585430.4530.6382.07E-17microtubule associated monooxygenase, calponin and LIM domain containing 2 [Source:MGI Symbol;Acc:MGI:2 444 947]
Shc36.90E-22−0.39790530.1320.3742.23E-17src homology 2 domain-containing transforming protein C3 [Source:MGI Symbol;Acc:MGI:106 179]
Nim1k9.23E-22−0.40655110.1890.4062.98E-17NIM1 serine/threonine protein kinase [Source:MGI Symbol;Acc:MGI:2 442 399]
Egfr1.06E-21−0.44128390.1780.4533.42E-17epidermal growth factor receptor [Source:MGI Symbol;Acc:MGI:95 294]
Ccdc1361.11E-210.34 468 6360.3450.1883.59E-17coiled-coil domain containing 136 [Source:MGI Symbol;Acc:MGI:1 918 128]
9630028H03Rik1.23E-21−0.39854630.0760.2963.96E-17RIKEN cDNA 9630028H03 gene [Source:MGI Symbol;Acc:MGI:2 444 526]
Arhgap61.37E-210.2 759 5590.1670.044.43E-17Rho GTPase activating protein 6 [Source:MGI Symbol;Acc:MGI:1 196 332]
Slc25a211.67E-210.43 983 0650.3670.1365.39E-17solute carrier family 25 (mitochondrial oxodicarboxylate carrier), member 21 [Source:MGI Symbol;Acc:MGI:2 445 059]
Pde10a1.67E-21−0.87998210.1820.3975.39E-17phosphodiesterase 10A [Source:MGI Symbol;Acc:MGI:1 345 143]
Igfbp52.16E-210.35 607 1570.2840.1096.98E-17insulin-like growth factor binding protein 5 [Source:MGI Symbol;Acc:MGI:96 440]
Dmd2.40E-21−0.49480860.6680.8187.75E-17dystrophin, muscular dystrophy [Source:MGI Symbol;Acc:MGI:94 909]
Wwox2.73E-210.661 1160.7310.5318.82E-17WW domain-containing oxidoreductase [Source:MGI Symbol;Acc:MGI:1 931 237]
Flvcr12.88E-210.28 350 7830.180.0589.29E-17feline leukemia virus subgroup C cellular receptor 1 [Source:MGI Symbol;Acc:MGI:2 444 881]
Utrn3.40E-210.56 232 0440.6960.5921.10E-16utrophin [Source:MGI Symbol;Acc:MGI:104 631]
Etv43.67E-21−0.41480610.0260.271.18E-16ets variant 4 [Source:MGI Symbol;Acc:MGI:99 423]
Gabbr24.65E-21−0.48095810.1150.321.50E-16gamma-aminobutyric acid (GABA) B receptor, 2 [Source:MGI Symbol;Acc:MGI:2 386 030]
Tsc22d17.13E-210.30 642 5310.4450.272.30E-16TSC22 domain family, member 1 [Source:MGI Symbol;Acc:MGI:109 127]
Mgat57.30E-210.37 459 7910.5140.3362.36E-16mannoside acetylglucosaminyltransferase 5 [Source:MGI Symbol;Acc:MGI:894 701]
Etnppl8.27E-21−0.4354390.1840.3982.67E-16ethanolamine phosphate phospholyase [Source:MGI Symbol;Acc:MGI:1 919 010]
Kcnj101.83E-20−0.34450520.2150.3515.91E-16potassium inwardly-rectifying channel, subfamily J, member 10 [Source:MGI Symbol;Acc:MGI:1 194 504]
Pbx12.42E-200.45 860 1090.8890.9017.82E-16pre B cell leukemia homeobox 1 [Source:MGI Symbol;Acc:MGI:97 495]
Kif21a2.63E-200.37 637 5380.5920.4158.50E-16kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
F32.75E-20−0.38615180.3950.5368.88E-16coagulation factor III [Source:MGI Symbol;Acc:MGI:88 381]
Itpr24.32E-20−0.38444840.3020.4841.40E-15inositol 1,4,5-triphosphate receptor 2 [Source:MGI Symbol;Acc:MGI:99 418]
Map2k64.93E-20−0.38073380.1610.3731.59E-15mitogen-activated protein kinase kinase 6 [Source:MGI Symbol;Acc:MGI:1 346 870]
Ghr5.27E-20−0.41385010.2930.4861.70E-15growth hormone receptor [Source:MGI Symbol;Acc:MGI:95 708]
Camk1d6.31E-20−0.46280450.4530.6712.04E-15calcium/calmodulin-dependent protein kinase ID [Source:MGI Symbol;Acc:MGI:2 442 190]
Tenm36.32E-200.45 681 2960.7090.5292.04E-15teneurin transmembrane protein 3 [Source:MGI Symbol;Acc:MGI:1 345 183]
Serpine26.56E-20−0.37787130.3120.4892.12E-15serine (or cysteine) peptidase inhibitor, clade E, member 2 [Source:MGI Symbol;Acc:MGI:101 780]
Mpdz8.64E-200.32 366 9020.3250.1642.79E-15multiple PDZ domain crumbs cell polarity complex component [Source:MGI Symbol;Acc:MGI:1 343 489]
Prr168.74E-20−0.38983670.130.3032.82E-15proline rich 16 [Source:MGI Symbol;Acc:MGI:1 918 623]
Sipa1l19.14E-200.31 642 9060.3540.1952.95E-15signal-induced proliferation-associated 1 like 1 [Source:MGI Symbol;Acc:MGI:2 443 679]
9630014M24Rik1.01E-19−0.36049980.0480.2683.25E-15RIKEN cDNA 9630014M24 gene [Source:MGI Symbol;Acc:MGI:3 588 234]
Pcdh11x1.06E-19−0.43014620.2060.4183.43E-15protocadherin 11 X-linked [Source:MGI Symbol;Acc:MGI:2 442 849]
Daam21.24E-19−0.40299570.380.5794.01E-15dishevelled associated activator of morphogenesis 2 [Source:MGI Symbol;Acc:MGI:1 923 691]
Myo5a2.01E-190.31 211 7670.3510.2186.49E-15myosin VA [Source:MGI Symbol;Acc:MGI:105 976]
Ctnnd22.21E-19−0.33544240.9590.9797.13E-15catenin (cadherin associated protein), delta 2 [Source:MGI Symbol;Acc:MGI:1 195 966]
Nkain22.91E-191.07 747 9260.6940.4659.39E-15Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Tprkb5.34E-190.41 617 8930.540.3671.72E-14Tp53rk binding protein [Source:MGI Symbol;Acc:MGI:1 917 036]
St6galnac55.81E-19−0.46329760.050.2511.87E-14ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 5 [Source:MGI Symbol;Acc:MGI:1 349 471]
Wnk26.61E-190.32 581 3630.560.452.14E-14WNK lysine deficient protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 922 857]
Hipk21.04E-18−0.36330730.330.523.34E-14homeodomain interacting protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 314 872]
Paqr81.23E-18−0.4099550.5340.683.96E-14progestin and adipoQ receptor family member VIII [Source:MGI Symbol;Acc:MGI:1 921 479]
Csmd31.59E-18−0.38243580.3170.4425.14E-14CUB and Sushi multiple domains 3 [Source:MGI Symbol;Acc:MGI:2 386 403]
Tril1.66E-18−0.29567320.1130.2585.36E-14TLR4 interactor with leucine-rich repeats [Source:MGI Symbol;Acc:MGI:1 914 123]
Ttc31.97E-180.33 617 4860.720.6146.34E-14tetratricopeptide repeat domain 3 [Source:MGI Symbol;Acc:MGI:1 276 539]
Syn22.93E-18−0.36464740.3770.5119.45E-14synapsin II [Source:MGI Symbol;Acc:MGI:103 020]
Zfp4623.48E-180.41 639 7750.5310.3211.12E-13zinc finger protein 462 [Source:MGI Symbol;Acc:MGI:107 690]
Etv54.64E-18−0.31365220.0980.2871.50E-13ets variant 5 [Source:MGI Symbol;Acc:MGI:1 096 867]
Hif1a4.84E-18−0.2855130.1240.2641.56E-13hypoxia inducible factor 1, alpha subunit [Source:MGI Symbol;Acc:MGI:106 918]
Qk5.84E-18−0.30950920.9050.9521.88E-13NA
Angpt16.03E-180.36 156 7160.3430.1531.95E-13angiopoietin 1 [Source:MGI Symbol;Acc:MGI:108 448]
Ptprz16.17E-18−0.4077510.8130.8971.99E-13protein tyrosine phosphatase, receptor type Z, polypeptide 1 [Source:MGI Symbol;Acc:MGI:97 816]
Pde8b7.34E-18−0.47950910.1930.4292.37E-13phosphodiesterase 8B [Source:MGI Symbol;Acc:MGI:2 443 999]
Paqr68.29E-18−0.25736120.0760.2062.68E-13progestin and adipoQ receptor family member VI [Source:MGI Symbol;Acc:MGI:1 916 207]
Rgs7bp9.33E-18−0.36288870.1540.3423.01E-13regulator of G-protein signalling 7 binding protein [Source:MGI Symbol;Acc:MGI:106 334]
Gm303821.03E-17−0.32001860.0370.1613.32E-13predicted gene, 30 382 [Source:MGI Symbol;Acc:MGI:5 589 541]
Nr3c21.42E-17−0.37639490.4660.6324.59E-13nuclear receptor subfamily 3, group C, member 2 [Source:MGI Symbol;Acc:MGI:99 459]
Gm295141.61E-17−0.31190710.0460.2185.19E-13predicted gene 29 514 [Source:MGI Symbol;Acc:MGI:5 580 220]
Cdh202.29E-17−0.32722130.6230.7157.38E-13cadherin 20 [Source:MGI Symbol;Acc:MGI:1 346 069]
4930545L23Rik2.29E-17−0.31231950.0390.2077.39E-13RIKEN cDNA 4930545L23 gene [Source:MGI Symbol;Acc:MGI:1 926 055]
Tsc22d32.66E-17−0.35317440.1670.3088.58E-13TSC22 domain family, member 3 [Source:MGI Symbol;Acc:MGI:1 196 284]
Mir124-2hg2.83E-17−0.30729330.1110.2879.14E-13Mir124-2 host gene (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 917 691]
Unc5c3.79E-170.51 316 4480.3450.2171.22E-12unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Ralgps23.84E-170.30 587 3090.3470.1761.24E-12Ral GEF with PH domain and SH3 binding motif 2 [Source:MGI Symbol;Acc:MGI:1 925 505]
Naaladl23.86E-170.47 242 1590.5270.3341.25E-12N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Spred13.92E-17−0.35151260.2540.4611.27E-12sprouty protein with EVH-1 domain 1, related sequence [Source:MGI Symbol;Acc:MGI:2 150 016]
Prkce4.64E-170.32 778 0490.5380.3571.50E-12protein kinase C, epsilon [Source:MGI Symbol;Acc:MGI:97 599]
Erbb45.00E-17−0.27353870.5640.561.61E-12erb-b2 receptor tyrosine kinase 4 [Source:MGI Symbol;Acc:MGI:104 771]
Arhgap265.43E-17−0.3746340.3540.5291.75E-12Rho GTPase activating protein 26 [Source:MGI Symbol;Acc:MGI:1 918 552]
Tgfb26.00E-170.27 281 3620.2520.1011.94E-12transforming growth factor, beta 2 [Source:MGI Symbol;Acc:MGI:98 726]
Rfx46.00E-170.50 589 5770.6680.5241.94E-12regulatory factor X, 4 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:1 918 387]
Actr3b6.84E-17−0.30921650.0950.2792.21E-12ARP3 actin-related protein 3B [Source:MGI Symbol;Acc:MGI:2 661 120]
Cacna1c6.97E-170.30 918 3930.2340.1132.25E-12calcium channel, voltage-dependent, L type, alpha 1C subunit [Source:MGI Symbol;Acc:MGI:103 013]
Nrg27.41E-170.40 615 1540.4250.2272.39E-12neuregulin 2 [Source:MGI Symbol;Acc:MGI:1 098 246]
Abcc128.05E-170.27 124 3680.1240.0012.60E-12ATP-binding cassette, sub-family C (CFTR/MRP), member 12 [Source:MGI Symbol;Acc:MGI:2 441 679]
Lhfp1.32E-16−0.44843810.4210.5584.25E-12lipoma HMGIC fusion partner [Source:MGI Symbol;Acc:MGI:1 920 048]
Cdh191.37E-16−0.39954830.4160.6394.42E-12cadherin 19, type 2 [Source:MGI Symbol;Acc:MGI:3 588 198]
Efr3b2.37E-16−0.35896560.2520.4367.66E-12EFR3 homolog B [Source:MGI Symbol;Acc:MGI:2 444 851]
Snrk2.59E-16−0.27634490.130.2768.35E-12SNF related kinase [Source:MGI Symbol;Acc:MGI:108 104]
Nrbp22.67E-160.31 083 0320.3640.1988.61E-12nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Znrf32.68E-16−0.36015180.3490.5418.67E-12zinc and ring finger 3 [Source:MGI Symbol;Acc:MGI:3 039 616]
Slc25a182.73E-16−0.293550.1820.3318.81E-12solute carrier family 25 (mitochondrial carrier), member 18 [Source:MGI Symbol;Acc:MGI:1 919 053]
Frem12.81E-16−0.26884840.0410.1839.07E-12Fras1 related extracellular matrix protein 1 [Source:MGI Symbol;Acc:MGI:2 670 972]
Irak23.22E-16−0.35947760.2840.4621.04E-11interleukin-1 receptor-associated kinase 2 [Source:MGI Symbol;Acc:MGI:2 429 603]
Nnat3.46E-160.49 109 3640.2490.1681.12E-11neuronatin [Source:MGI Symbol;Acc:MGI:104 716]
Robo14.72E-16−0.34446260.3040.4121.52E-11roundabout guidance receptor 1 [Source:MGI Symbol;Acc:MGI:1 274 781]
Macrod15.02E-16−0.27263890.1240.2741.62E-11mono-ADP ribosylhydrolase 1 [Source:MGI Symbol;Acc:MGI:2 147 583]
Tafa56.98E-160.30 683 6790.3950.2362.25E-11TAFA chemokine like family member 5 [Source:MGI Symbol;Acc:MGI:2 146 182]
Hif3a8.85E-16−0.30664720.2280.3992.86E-11hypoxia inducible factor 3, alpha subunit [Source:MGI Symbol;Acc:MGI:1 859 778]
Per31.19E-15−0.27632390.210.3523.83E-11period circadian clock 3 [Source:MGI Symbol;Acc:MGI:1 277 134]
Gm61451.55E-15−0.34107270.4840.6315.01E-11predicted gene 6145 [Source:MGI Symbol;Acc:MGI:3 779 559]
Cdh221.77E-15−0.25025550.0930.1935.71E-11cadherin 22 [Source:MGI Symbol;Acc:MGI:1 341 843]
Itgav2.98E-15−0.30584590.1930.3759.61E-11integrin alpha V [Source:MGI Symbol;Acc:MGI:96 608]
Ripor23.01E-15−0.26244060.0330.1779.73E-11RHO family interacting cell polarization regulator 2 [Source:MGI Symbol;Acc:MGI:2 444 879]
Map1b3.10E-150.33 093 8720.5310.4281.00E-10microtubule-associated protein 1B [Source:MGI Symbol;Acc:MGI:1 306 778]
Stk32a3.37E-150.63 100 5440.410.2261.09E-10serine/threonine kinase 32A [Source:MGI Symbol;Acc:MGI:2 442 403]
Slc7a23.54E-150.38 023 4180.4580.3091.14E-10solute carrier family 7 (cationic amino acid transporter, y + system), member 2 [Source:MGI Symbol;Acc:MGI:99 828]
Pros13.70E-150.26 161 4790.1840.0761.19E-10protein S (alpha) [Source:MGI Symbol;Acc:MGI:1 095 733]
Glul4.09E-15−0.37453610.3930.5971.32E-10glutamate-ammonia ligase (glutamine synthetase) [Source:MGI Symbol;Acc:MGI:95 739]
Washc24.58E-15−0.29666350.20.3591.48E-10WASH complex subunit 2 [Source:MGI Symbol;Acc:MGI:106 463]
Sat14.69E-15−0.32853420.260.4161.52E-10spermidine/spermine N1-acetyl transferase 1 [Source:MGI Symbol;Acc:MGI:98 233]
Man1a5.06E-150.25 671 6970.2170.091.63E-10mannosidase 1, alpha [Source:MGI Symbol;Acc:MGI:104 677]
Cap25.07E-15−0.29239790.1610.3331.64E-10CAP, adenylate cyclase-associated protein, 2 (yeast) [Source:MGI Symbol;Acc:MGI:1 914 502]
Pla2g75.26E-15−0.32651650.4160.5951.70E-10phospholipase A2, group VII (platelet-activating factor acetylhydrolase, plasma) [Source:MGI Symbol;Acc:MGI:1 351 327]
Cdh25.37E-15−0.35713410.4620.6291.73E-10cadherin 2 [Source:MGI Symbol;Acc:MGI:88 355]
Prex28.14E-15−0.42284340.7050.8262.63E-10phosphatidylinositol-3,4,5-trisphosphate-dependent Rac exchange factor 2 [Source:MGI Symbol;Acc:MGI:1 923 385]
Tmcc39.77E-15−0.30733460.4430.5673.16E-10transmembrane and coiled coil domains 3 [Source:MGI Symbol;Acc:MGI:2 442 900]
Spag91.02E-14−0.30034320.5860.6963.28E-10sperm associated antigen 9 [Source:MGI Symbol;Acc:MGI:1 918 084]
Adcy21.06E-140.29 525 0120.5770.4873.41E-10adenylate cyclase 2 [Source:MGI Symbol;Acc:MGI:99 676]
Gli31.10E-14−0.33010320.5420.6923.55E-10GLI-Kruppel family member GLI3 [Source:MGI Symbol;Acc:MGI:95 729]
Hmgn31.10E-14−0.30435120.1410.3243.57E-10high mobility group nucleosomal binding domain 3 [Source:MGI Symbol;Acc:MGI:2 138 069]
Ldlrad41.19E-14−0.31893250.2130.3563.84E-10low density lipoprotein receptor class A domain containing 4 [Source:MGI Symbol;Acc:MGI:1 277 150]
Eps151.28E-14−0.29645940.4620.6064.14E-10epidermal growth factor receptor pathway substrate 15 [Source:MGI Symbol;Acc:MGI:104 583]
Gli21.39E-14−0.32220330.2840.4594.47E-10GLI-Kruppel family member GLI2 [Source:MGI Symbol;Acc:MGI:95 728]
Dock11.56E-14−0.32618150.5230.6735.04E-10dedicator of cytokinesis 1 [Source:MGI Symbol;Acc:MGI:2 429 765]
Sox2ot1.64E-14−0.33052370.4340.5045.30E-10SOX2 overlapping transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 112]
Cnn31.70E-140.28 344 2520.3170.1945.50E-10calponin 3, acidic [Source:MGI Symbol;Acc:MGI:1 919 244]
Ttyh11.92E-14−0.29267970.6050.7186.19E-10tweety family member 1 [Source:MGI Symbol;Acc:MGI:1 889 007]
Gm442572.12E-14−0.26098730.0330.1976.85E-10predicted gene, 44 257 [Source:MGI Symbol;Acc:MGI:5 690 649]
Adamts202.16E-140.29 924 1810.2730.1486.97E-10a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 20 [Source:MGI Symbol;Acc:MGI:2 660 628]
Dclk22.20E-140.30 007 3780.4190.2677.11E-10doublecortin-like kinase 2 [Source:MGI Symbol;Acc:MGI:1 918 012]
Cacna1a2.21E-140.25 941 8020.3190.1927.14E-10calcium channel, voltage-dependent, P/Q type, alpha 1A subunit [Source:MGI Symbol;Acc:MGI:109 482]
Plekha52.37E-140.28 678 2280.3560.2177.64E-10pleckstrin homology domain containing, family A member 5 [Source:MGI Symbol;Acc:MGI:1 923 802]
Kifc32.45E-14−0.25976760.1610.3177.90E-10kinesin family member C3 [Source:MGI Symbol;Acc:MGI:109 202]
Lgr62.51E-14−0.2593910.0240.1568.11E-10leucine-rich repeat-containing G protein-coupled receptor 6 [Source:MGI Symbol;Acc:MGI:2 441 805]
Eda2.59E-140.32 338 3020.3620.2228.37E-10ectodysplasin-A [Source:MGI Symbol;Acc:MGI:1 195 272]
Ccdc1622.67E-140.31 699 3020.2690.1248.61E-10coiled-coil domain containing 162 [Source:MGI Symbol;Acc:MGI:1 923 223]
Arid5b3.24E-140.2 963 0380.2820.151.04E-09AT rich interactive domain 5B (MRF1-like) [Source:MGI Symbol;Acc:MGI:2 175 912]
Garem13.77E-14−0.36059850.2540.4491.22E-09GRB2 associated regulator of MAPK1 subtype 1 [Source:MGI Symbol;Acc:MGI:2 685 790]
Arhgap53.93E-14−0.33484380.6620.7571.27E-09Rho GTPase activating protein 5 [Source:MGI Symbol;Acc:MGI:1 332 637]
Immp2l3.95E-140.31 435 5180.330.1941.27E-09IMP2 inner mitochondrial membrane peptidase-like (S. cerevisiae) [Source:MGI Symbol;Acc:MGI:2 135 611]
Aldoc4.99E-14−0.25647490.3560.4761.61E-09aldolase C, fructose-bisphosphate [Source:MGI Symbol;Acc:MGI:101 863]
Grip15.24E-14−0.3209810.1240.2691.69E-09glutamate receptor interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 921 303]
Fgf15.34E-14−0.27476260.1970.3461.73E-09fibroblast growth factor 1 [Source:MGI Symbol;Acc:MGI:95 515]
App5.83E-140.32 161 6870.6550.531.88E-09amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Wipf16.20E-14−0.28437770.1390.2542.00E-09WAS/WASL interacting protein family, member 1 [Source:MGI Symbol;Acc:MGI:2 178 801]
Cyfip17.55E-14−0.27023090.2190.3672.44E-09cytoplasmic FMR1 interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 338 801]
Gnao18.00E-14−0.54154020.5940.6752.58E-09guanine nucleotide binding protein, alpha O [Source:MGI Symbol;Acc:MGI:95 775]
Ccdc1418.02E-14−0.29317220.3410.4542.59E-09coiled-coil domain containing 141 [Source:MGI Symbol;Acc:MGI:1 919 735]
Stard138.21E-140.4 152 6490.5550.3882.65E-09StAR-related lipid transfer (START) domain containing 13 [Source:MGI Symbol;Acc:MGI:2 385 331]
Fut98.62E-14−0.3228330.5380.662.78E-09fucosyltransferase 9 [Source:MGI Symbol;Acc:MGI:1 330 859]
Sycp29.81E-14−0.26892640.1040.2673.17E-09synaptonemal complex protein 2 [Source:MGI Symbol;Acc:MGI:1 933 281]
Tox1.04E-13−0.37116680.2990.5143.36E-09thymocyte selection-associated high mobility group box [Source:MGI Symbol;Acc:MGI:2 181 659]
Eif4g31.08E-13−0.32461490.4010.5713.48E-09eukaryotic translation initiation factor 4 gamma, 3 [Source:MGI Symbol;Acc:MGI:1 923 935]
Stat31.34E-130.27 159 3520.3060.1534.34E-09signal transducer and activator of transcription 3 [Source:MGI Symbol;Acc:MGI:103 038]
Sned11.48E-130.2 999 9790.3470.24.78E-09sushi, nidogen and EGF-like domains 1 [Source:MGI Symbol;Acc:MGI:3 045 960]
Usp541.72E-13−0.2713570.2060.3455.55E-09ubiquitin specific peptidase 54 [Source:MGI Symbol;Acc:MGI:1 926 037]
Tle42.16E-13−0.31412170.2490.4416.97E-09transducin-like enhancer of split 4 [Source:MGI Symbol;Acc:MGI:104 633]
Dbx22.45E-13−0.25818290.2210.3587.91E-09developing brain homeobox 2 [Source:MGI Symbol;Acc:MGI:107 445]
Btbd92.62E-130.31 317 4530.5080.3468.47E-09BTB (POZ) domain containing 9 [Source:MGI Symbol;Acc:MGI:1 916 625]
Fam214a2.90E-13−0.27770730.2130.3549.37E-09NA
Cachd13.12E-130.33 962 3370.4770.3271.01E-08cache domain containing 1 [Source:MGI Symbol;Acc:MGI:2 444 177]
Fnbp13.31E-13−0.29308250.6360.7341.07E-08formin binding protein 1 [Source:MGI Symbol;Acc:MGI:109 606]
Pid13.41E-13−0.31881280.3470.5121.10E-08phosphotyrosine interaction domain containing 1 [Source:MGI Symbol;Acc:MGI:2 138 391]
Id43.49E-130.36 185 5740.4620.2821.13E-08inhibitor of DNA binding 4 [Source:MGI Symbol;Acc:MGI:99 414]
Chst113.52E-130.31 210 5770.4120.2621.14E-08carbohydrate sulfotransferase 11 [Source:MGI Symbol;Acc:MGI:1 927 166]
Atl24.05E-13−0.26108010.3040.4241.31E-08atlastin GTPase 2 [Source:MGI Symbol;Acc:MGI:1 929 492]
Dpf35.01E-13−0.29100540.2650.4261.62E-08double PHD fingers 3 [Source:MGI Symbol;Acc:MGI:1 917 377]
Arrb15.31E-13−0.25373280.180.3391.71E-08arrestin, beta 1 [Source:MGI Symbol;Acc:MGI:99 473]
Fam155a5.80E-130.69 052 6150.4840.2871.87E-08NA
Zfhx47.06E-130.3 268 6590.3560.232.28E-08zinc finger homeodomain 4 [Source:MGI Symbol;Acc:MGI:2 137 668]
Fgf147.06E-130.39 407 1390.8630.7582.28E-08fibroblast growth factor 14 [Source:MGI Symbol;Acc:MGI:109 189]
Hivep37.55E-13−0.32663020.5750.7292.44E-08human immunodeficiency virus type I enhancer binding protein 3 [Source:MGI Symbol;Acc:MGI:106 589]
Fermt28.05E-13−0.29984070.3410.5012.60E-08fermitin family member 2 [Source:MGI Symbol;Acc:MGI:2 385 001]
Rnf2208.48E-13−0.29992290.1020.1932.74E-08ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Rmst1.07E-120.52 794 9370.8030.7583.47E-08rhabdomyosarcoma 2 associated transcript (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 099 806]
Dnm31.48E-120.3 694 3220.490.3064.77E-08dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Gulp11.67E-12−0.27018140.150.2955.38E-08GULP, engulfment adaptor PTB domain containing 1 [Source:MGI Symbol;Acc:MGI:1 920 407]
Prkn1.96E-120.42 415 9410.7350.66.32E-08parkin RBR E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 355 296]
Hivep22.85E-12−0.30008690.4010.5449.21E-08human immunodeficiency virus type I enhancer binding protein 2 [Source:MGI Symbol;Acc:MGI:1 338 076]
Agl2.91E-12−0.25301560.2820.419.40E-08amylo-1,6-glucosidase, 4-alpha-glucanotransferase [Source:MGI Symbol;Acc:MGI:1 924 809]
Astn23.41E-120.43 229 7550.590.5141.10E-07astrotactin 2 [Source:MGI Symbol;Acc:MGI:1 889 277]
Abi13.62E-12−0.26955890.3340.4761.17E-07abl interactor 1 [Source:MGI Symbol;Acc:MGI:104 913]
Enah4.34E-12−0.29490060.5570.6891.40E-07ENAH actin regulator [Source:MGI Symbol;Acc:MGI:108 360]
Tmem1645.37E-12−0.32205140.3560.5141.74E-07transmembrane protein 164 [Source:MGI Symbol;Acc:MGI:2 148 020]
Aco25.41E-12−0.2500020.2950.4341.75E-07aconitase 2, mitochondrial [Source:MGI Symbol;Acc:MGI:87 880]
Dlgap15.65E-12−0.32803280.7250.8471.82E-07DLG associated protein 1 [Source:MGI Symbol;Acc:MGI:1 346 065]
Cpeb35.85E-12−0.27077850.4380.5531.89E-07cytoplasmic polyadenylation element binding protein 3 [Source:MGI Symbol;Acc:MGI:2 443 075]
Nfib7.15E-12−0.27996810.740.8212.31E-07nuclear factor I/B [Source:MGI Symbol;Acc:MGI:103 188]
Iqsec28.06E-120.25 033 8210.3360.1962.60E-07IQ motif and Sec7 domain 2 [Source:MGI Symbol;Acc:MGI:3 528 396]
Shisa68.24E-12−0.25758450.10.1592.66E-07shisa family member 6 [Source:MGI Symbol;Acc:MGI:2 685 725]
Nfkb18.60E-120.31 729 2130.4510.3092.78E-07nuclear factor of kappa light polypeptide gene enhancer in B cells 1, p105 [Source:MGI Symbol;Acc:MGI:97 312]
Myo18a9.58E-12−0.26612360.2320.3853.09E-07myosin XVIIIA [Source:MGI Symbol;Acc:MGI:2 667 185]
Ugp21.08E-110.26 792 9520.5160.3723.49E-07UDP-glucose pyrophosphorylase 2 [Source:MGI Symbol;Acc:MGI:2 183 447]
Enpp21.36E-110.30 137 9840.410.2424.40E-07ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
Frmpd11.37E-11−0.27250150.2540.4044.42E-07FERM and PDZ domain containing 1 [Source:MGI Symbol;Acc:MGI:2 446 274]
Ano62.02E-110.28 037 3710.2690.1426.53E-07anoctamin 6 [Source:MGI Symbol;Acc:MGI:2 145 890]
Tcf252.14E-11−0.25243530.4950.6256.92E-07transcription factor 25 (basic helix-loop-helix) [Source:MGI Symbol;Acc:MGI:1 914 105]
Sel1l32.21E-110.25 017 1740.20.1017.13E-07sel-1 suppressor of lin-12-like 3 (C. elegans) [Source:MGI Symbol;Acc:MGI:1 916 941]
Pigk2.24E-11−0.31922570.1080.2577.24E-07phosphatidylinositol glycan anchor biosynthesis, class K [Source:MGI Symbol;Acc:MGI:1 913 863]
Meis22.39E-110.28 700 8230.7220.647.73E-07Meis homeobox 2 [Source:MGI Symbol;Acc:MGI:108 564]
Clmn2.43E-11−0.37419370.3380.5017.85E-07calmin [Source:MGI Symbol;Acc:MGI:2 136 957]
Pard3b2.59E-110.36 304 2810.6770.578.37E-07par-3 family cell polarity regulator beta [Source:MGI Symbol;Acc:MGI:1 919 301]
Zfhx32.74E-110.44 295 7930.5180.3638.84E-07zinc finger homeobox 3 [Source:MGI Symbol;Acc:MGI:99 948]
Bcan2.75E-11−0.25547580.5570.6498.87E-07brevican [Source:MGI Symbol;Acc:MGI:1 096 385]
Acss13.09E-11−0.25673650.2430.3979.98E-07acyl-CoA synthetase short-chain family member 1 [Source:MGI Symbol;Acc:MGI:1 915 988]
Adk3.22E-11−0.28200380.6570.7661.04E-06adenosine kinase [Source:MGI Symbol;Acc:MGI:87 930]
Clasp24.17E-11−0.27344010.5990.6911.35E-06CLIP associating protein 2 [Source:MGI Symbol;Acc:MGI:1 923 749]
Alcam5.04E-11−0.32091160.3640.5191.63E-06activated leukocyte cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 313 266]
Cspp15.14E-110.26 083 5650.4860.3481.66E-06centrosome and spindle pole associated protein 1 [Source:MGI Symbol;Acc:MGI:2 681 832]
Plpp35.22E-11−0.3177850.6960.7881.68E-06phospholipid phosphatase 3 [Source:MGI Symbol;Acc:MGI:1 915 166]
Megf105.80E-11−0.25197490.280.4191.87E-06multiple EGF-like-domains 10 [Source:MGI Symbol;Acc:MGI:2 685 177]
Gphn6.45E-11−0.26894960.8740.9112.08E-06gephyrin [Source:MGI Symbol;Acc:MGI:109 602]
Fus6.61E-110.25 396 1730.5160.3762.13E-06fused in sarcoma [Source:MGI Symbol;Acc:MGI:1 353 633]
Wwc18.27E-11−0.26592630.4120.5382.67E-06WW, C2 and coiled-coil domain containing 1 [Source:MGI Symbol;Acc:MGI:2 388 637]
Lrrc4c8.56E-11−0.44154730.8940.9012.76E-06leucine rich repeat containing 4C [Source:MGI Symbol;Acc:MGI:2 442 636]
Rorb1.46E-10−0.32772560.7460.8574.71E-06RAR-related orphan receptor beta [Source:MGI Symbol;Acc:MGI:1 343 464]
Sgip11.72E-10−0.28270460.6250.7265.55E-06SH3-domain GRB2-like (endophilin) interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 920 344]
Gm487421.76E-10−0.25864250.230.3675.69E-06predicted gene, 48 742 [Source:MGI Symbol;Acc:MGI:6 098 410]
Ttc282.09E-100.28 895 9350.4970.3736.76E-06tetratricopeptide repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 140 873]
Igsf112.14E-100.28 984 7290.4920.3536.90E-06immunoglobulin superfamily, member 11 [Source:MGI Symbol;Acc:MGI:2 388 477]
Fbxl72.42E-100.30 362 5530.2150.0827.83E-06F-box and leucine-rich repeat protein 7 [Source:MGI Symbol;Acc:MGI:3 052 506]
Lama22.60E-10−0.31068160.6160.7188.39E-06laminin, alpha 2 [Source:MGI Symbol;Acc:MGI:99 912]
Camk2n12.74E-10−0.27324110.2690.4598.84E-06calcium/calmodulin-dependent protein kinase II inhibitor 1 [Source:MGI Symbol;Acc:MGI:1 913 509]
Spire13.03E-10−0.26781420.5510.6729.78E-06spire type actin nucleation factor 1 [Source:MGI Symbol;Acc:MGI:1 915 416]
Thrb3.43E-10−0.26550690.6160.6761.11E-05thyroid hormone receptor beta [Source:MGI Symbol;Acc:MGI:98 743]
Grid13.76E-10−0.27218740.2750.4451.21E-05glutamate receptor, ionotropic, delta 1 [Source:MGI Symbol;Acc:MGI:95 812]
Dst3.99E-100.33 094 5720.6880.6351.29E-05dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Lhfpl35.06E-100.52 784 1760.4380.2881.63E-05lipoma HMGIC fusion partner-like 3 [Source:MGI Symbol;Acc:MGI:1 925 076]
Lrmda5.92E-10−0.33622630.2190.361.91E-05leucine rich melanocyte differentiation associated [Source:MGI Symbol;Acc:MGI:1 923 883]
Slc9a91.26E-090.27 808 9960.4880.3734.08E-05solute carrier family 9 (sodium/hydrogen exchanger), member 9 [Source:MGI Symbol;Acc:MGI:2 679 732]
Mapk101.51E-09−0.26380080.5680.6624.87E-05mitogen-activated protein kinase 10 [Source:MGI Symbol;Acc:MGI:1 346 863]
B3galt12.00E-09−0.26546690.8610.9196.45E-05UDP-Gal:betaGlcNAc beta 1,3-galactosyltransferase, polypeptide 1 [Source:MGI Symbol;Acc:MGI:1 349 403]
Ddah12.19E-09−0.25509760.2170.3817.07E-05dimethylarginine dimethylaminohydrolase 1 [Source:MGI Symbol;Acc:MGI:1 916 469]
Smyd33.06E-090.30 146 9810.5120.3619.89E-05SET and MYND domain containing 3 [Source:MGI Symbol;Acc:MGI:1 916 976]
Pde4d3.57E-090.49 104 4540.8160.7410.00 011 538phosphodiesterase 4D, cAMP specific [Source:MGI Symbol;Acc:MGI:99 555]
Prdx63.89E-090.28 389 0770.640.5270.00 012 564peroxiredoxin 6 [Source:MGI Symbol;Acc:MGI:894 320]
Ankrd283.94E-090.27 308 2010.4790.3550.0 001 273ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Map4k44.15E-090.25 600 6240.5180.4170.00 013 397mitogen-activated protein kinase kinase kinase kinase 4 [Source:MGI Symbol;Acc:MGI:1 349 394]
Acss34.20E-090.26 918 8530.3210.1890.00 013 546acyl-CoA synthetase short-chain family member 3 [Source:MGI Symbol;Acc:MGI:2 685 720]
Dock74.82E-090.27 946 9240.4080.2920.00 015 556dedicator of cytokinesis 7 [Source:MGI Symbol;Acc:MGI:1 914 549]
Bcl28.22E-090.25 489 8510.4080.3380.00 026 533B cell leukemia/lymphoma 2 [Source:MGI Symbol;Acc:MGI:88 138]
4930488L21Rik1.21E-08−0.31219660.1430.2830.00 039 211RIKEN cDNA 4930488L21 gene [Source:MGI Symbol;Acc:MGI:1 923 059]
Fhit2.18E-080.40 458 5420.5530.3880.00 070 321fragile histidine triad gene [Source:MGI Symbol;Acc:MGI:1 277 947]
Ank2.18E-080.32 658 1310.5120.4220.00 070 377progressive ankylosis [Source:MGI Symbol;Acc:MGI:3 045 421]
Fam13c3.14E-08−0.25229780.150.2780.00 101 426family with sequence similarity 13, member C [Source:MGI Symbol;Acc:MGI:1 918 971]
Thsd7a3.44E-080.31 348 4940.4510.3030.00 111 155thrombospondin, type I, domain containing 7A [Source:MGI Symbol;Acc:MGI:2 685 683]
Epha54.54E-080.30 165 5980.5420.3820.00 146 634Eph receptor A5 [Source:MGI Symbol;Acc:MGI:99 654]
Phactr15.31E-08−0.27994040.3320.4980.00 171 272phosphatase and actin regulator 1 [Source:MGI Symbol;Acc:MGI:2 659 021]
Inpp4b9.18E-080.25 348 1230.2650.1510.00 296 391inositol polyphosphate-4-phosphatase, type II [Source:MGI Symbol;Acc:MGI:2 158 925]
Genep_valavg_log2FCpct.1pct.2p_val_adjdescription
Ablim202.01 268 2050.5920.1420actin-binding LIM protein 2 [Source:MGI Symbol;Acc:MGI:2 385 758]
Gpc50−2.42154350.5230.9780glypican 5 [Source:MGI Symbol;Acc:MGI:1 194 894]
Trpm30−2.77725470.4750.9310transient receptor potential cation channel, subfamily M, member 3 [Source:MGI Symbol;Acc:MGI:2 443 101]
Lsamp5.69E-249−1.48518030.99311.84E-244limbic system-associated membrane protein [Source:MGI Symbol;Acc:MGI:1 261 760]
Plcb16.73E-181−1.7406110.670.9462.17E-176phospholipase C, beta 1 [Source:MGI Symbol;Acc:MGI:97 613]
6330411D24Rik6.01E-1802.09 342 4640.4010.0221.94E-175RIKEN cDNA 6330411D24 gene [Source:MGI Symbol;Acc:MGI:1 917 975]
Kcnd25.20E-170−1.93504750.3730.7061.68E-165potassium voltage-gated channel, Shal-related family, member 2 [Source:MGI Symbol;Acc:MGI:102 663]
Prune22.77E-1681.331 2720.6140.1358.94E-164prune homolog 2 [Source:MGI Symbol;Acc:MGI:1 925 004]
Sorbs21.02E-1671.50 461 4180.6180.1733.30E-163sorbin and SH3 domain containing 2 [Source:MGI Symbol;Acc:MGI:1 924 574]
Kirrel36.70E-158−1.79298880.4010.8792.16E-153kirre like nephrin family adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 914 953]
Gfap7.52E-1541.81 373 9420.6660.2152.43E-149glial fibrillary acidic protein [Source:MGI Symbol;Acc:MGI:95 697]
Mdga24.23E-152−1.30816060.8110.9741.36E-147MAM domain containing glycosylphosphatidylinositol anchor 2 [Source:MGI Symbol;Acc:MGI:2 444 706]
Nrxn12.30E-143−1.27407430.8630.9987.42E-139neurexin I [Source:MGI Symbol;Acc:MGI:1 096 391]
Gm37647.00E-142−1.25984060.7270.9372.26E-137predicted gene 3764 [Source:MGI Symbol;Acc:MGI:3 781 938]
Grik24.07E-1331.35 293 1470.7960.4631.31E-128glutamate receptor, ionotropic, kainate 2 (beta 2) [Source:MGI Symbol;Acc:MGI:95 815]
Cacnb25.58E-1301.4 550 6950.6440.2571.80E-125calcium channel, voltage-dependent, beta 2 subunit [Source:MGI Symbol;Acc:MGI:894 644]
Ccdc1486.30E-1221.04 581 6740.4010.0552.04E-117coiled-coil domain containing 148 [Source:MGI Symbol;Acc:MGI:3 039 583]
Pkp41.87E-1211.16 887 2370.610.2336.05E-117plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Gm122391.17E-119−1.56307290.150.5663.78E-115predicted gene 12 239 [Source:MGI Symbol;Acc:MGI:3 651 547]
Adamtsl11.78E-1181.0 194 3730.3690.0385.76E-114ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
A2m1.89E-1091.16 768 9790.4210.0656.11E-105alpha-2-macroglobulin [Source:MGI Symbol;Acc:MGI:2 449 119]
Rora3.95E-109−1.07252170.9520.9891.28E-104RAR-related orphan receptor alpha [Source:MGI Symbol;Acc:MGI:104 661]
Pcdh94.52E-109−1.08897650.9440.9921.46E-104protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Slc38a16.45E-1081.18 683 5730.6290.2362.08E-103solute carrier family 38, member 1 [Source:MGI Symbol;Acc:MGI:2 145 895]
Cadps3.49E-1011.07 111 9480.6810.3051.13E-96Ca2+-dependent secretion activator [Source:MGI Symbol;Acc:MGI:1 350 922]
Pitpnc15.38E-101−1.20861830.6940.9131.74E-96phosphatidylinositol transfer protein, cytoplasmic 1 [Source:MGI Symbol;Acc:MGI:1 919 045]
Kcnj33.06E-980.90 152 9530.5620.1669.89E-94potassium inwardly-rectifying channel, subfamily J, member 3 [Source:MGI Symbol;Acc:MGI:104 742]
Gm149641.15E-960.76 450 6180.5080.1593.70E-92predicted gene 14 964 [Source:MGI Symbol;Acc:MGI:3 641 621]
Ccdc35.80E-960.76 885 9680.3410.0241.87E-91coiled-coil domain containing 3 [Source:MGI Symbol;Acc:MGI:1 921 436]
Asap31.18E-930.63 349 4210.3430.0273.82E-89ArfGAP with SH3 domain, ankyrin repeat and PH domain 3 [Source:MGI Symbol;Acc:MGI:2 684 986]
Atp1a21.41E-92−0.95126260.7790.9324.56E-88ATPase, Na+/K + transporting, alpha 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 106]
Gm48764.73E-880.82 426 1180.4770.1311.53E-83predicted gene 4876 [Source:MGI Symbol;Acc:MGI:3 647 654]
Car109.87E-88−1.17006910.2520.4793.19E-83carbonic anhydrase 10 [Source:MGI Symbol;Acc:MGI:1 919 855]
Ldb21.61E-860.78 138 8860.4620.1195.19E-82LIM domain binding 2 [Source:MGI Symbol;Acc:MGI:894 670]
Arhgef46.30E-861.03 026 8930.7720.5642.03E-81Rho guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:2 442 507]
Prkag26.94E-850.77 822 6080.4920.1562.24E-80protein kinase, AMP-activated, gamma 2 non-catalytic subunit [Source:MGI Symbol;Acc:MGI:1 336 153]
Col23a18.05E-851.11 579 5670.4690.112.60E-80collagen, type XXIII, alpha 1 [Source:MGI Symbol;Acc:MGI:2 653 243]
Brinp34.08E-84−1.05676250.2670.6981.32E-79bone morphogenetic protein/retinoic acid inducible neural specific 3 [Source:MGI Symbol;Acc:MGI:2 443 035]
Myoc9.22E-830.80 203 1310.2730.0122.98E-78myocilin [Source:MGI Symbol;Acc:MGI:1 202 864]
Pdzrn34.51E-820.69 065 9930.4340.11.46E-77PDZ domain containing RING finger 3 [Source:MGI Symbol;Acc:MGI:1 933 157]
C4b9.92E-820.67 373 8660.4010.0733.20E-77complement component 4B (Chido blood group) [Source:MGI Symbol;Acc:MGI:88 228]
Gm207131.04E-81−1.16710950.1480.713.35E-77predicted gene 20 713 [Source:MGI Symbol;Acc:MGI:5 313 160]
Cadm29.70E-81−0.86774230.8870.9913.13E-76cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:2 442 722]
Cobll11.01E-800.69 941 5610.380.0583.26E-76Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Tmem1087.84E-790.68 764 5550.3250.0482.53E-74transmembrane protein 108 [Source:MGI Symbol;Acc:MGI:1 932 411]
Slc6a111.58E-78−0.95280880.260.5775.11E-74solute carrier family 6 (neurotransmitter transporter, GABA), member 11 [Source:MGI Symbol;Acc:MGI:95 630]
Gria28.90E-78−1.17085270.4010.7652.87E-73glutamate receptor, ionotropic, AMPA2 (alpha 2) [Source:MGI Symbol;Acc:MGI:95 809]
Ptch11.21E-77−1.03795650.1780.5723.91E-73patched 1 [Source:MGI Symbol;Acc:MGI:105 373]
Nhsl12.00E-77−1.00848890.3620.7246.47E-73NHS-like 1 [Source:MGI Symbol;Acc:MGI:106 390]
Cd443.84E-750.61 517 8670.2890.0221.24E-70CD44 antigen [Source:MGI Symbol;Acc:MGI:88 338]
Adgrb38.83E-75−0.93077680.8760.9562.85E-70adhesion G protein-coupled receptor B3 [Source:MGI Symbol;Acc:MGI:2 441 837]
Man1c12.14E-730.63 698 9220.3360.0636.91E-69mannosidase, alpha, class 1C, member 1 [Source:MGI Symbol;Acc:MGI:2 446 214]
Prkca4.62E-710.97 231 7920.80.5611.49E-66protein kinase C, alpha [Source:MGI Symbol;Acc:MGI:97 595]
Sntg21.58E-700.49 453 6240.2820.0155.10E-66syntrophin, gamma 2 [Source:MGI Symbol;Acc:MGI:1 919 541]
Sulf21.19E-690.53 943 0030.2910.0443.85E-65sulfatase 2 [Source:MGI Symbol;Acc:MGI:1 919 293]
Glis32.10E-690.81 574 3810.790.5286.77E-65GLIS family zinc finger 3 [Source:MGI Symbol;Acc:MGI:2 444 289]
Nrp28.88E-690.52 318 1580.3230.0452.87E-64neuropilin 2 [Source:MGI Symbol;Acc:MGI:1 100 492]
Reep17.50E-670.64 992 3470.3430.0692.42E-62receptor accessory protein 1 [Source:MGI Symbol;Acc:MGI:1 098 827]
Slc7a105.38E-65−1.11624910.0650.5521.74E-60solute carrier family 7 (cationic amino acid transporter, y + system), member 10 [Source:MGI Symbol;Acc:MGI:1 858 261]
Pde7b6.13E-65−0.99651790.2730.7011.98E-60phosphodiesterase 7B [Source:MGI Symbol;Acc:MGI:1 352 752]
Ctnna22.42E-631.08 054 9980.8440.6767.81E-59catenin (cadherin associated protein), alpha 2 [Source:MGI Symbol;Acc:MGI:88 275]
Csmd17.81E-630.67 950 1760.5770.3952.52E-58CUB and Sushi multiple domains 1 [Source:MGI Symbol;Acc:MGI:2 137 383]
Sorbs11.00E-620.95 190 3380.8290.6383.24E-58sorbin and SH3 domain containing 1 [Source:MGI Symbol;Acc:MGI:700 014]
Aebp11.73E-620.45 464 3510.2580.0135.59E-58AE binding protein 1 [Source:MGI Symbol;Acc:MGI:1 197 012]
Sema3a1.11E-600.54 359 6090.2520.033.59E-56sema domain, immunoglobulin domain (Ig), short basic domain, secreted, (semaphorin) 3A [Source:MGI Symbol;Acc:MGI:107 558]
Rgs72.21E-60−1.01278830.2430.6427.14E-56regulator of G protein signaling 7 [Source:MGI Symbol;Acc:MGI:1 346 089]
Slc8a15.29E-600.95 401 4560.5210.2471.71E-55solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Synpo25.36E-600.82 634 0960.4970.1651.73E-55synaptopodin 2 [Source:MGI Symbol;Acc:MGI:2 153 070]
Dock47.62E-60−0.79633060.5790.812.46E-55dedicator of cytokinesis 4 [Source:MGI Symbol;Acc:MGI:1 918 006]
C530044C16Rik1.87E-590.4 873 9990.2340.0126.04E-55RIKEN cDNA C530044C16 gene [Source:MGI Symbol;Acc:MGI:2 443 109]
Tagln34.73E-590.61 896 3830.5770.2991.53E-54transgelin 3 [Source:MGI Symbol;Acc:MGI:1 926 784]
Adgrl31.51E-57−0.71364630.7790.8994.88E-53adhesion G protein-coupled receptor L3 [Source:MGI Symbol;Acc:MGI:2 441 950]
Cpne82.52E-560.41 103 0570.2620.0378.13E-52copine VIII [Source:MGI Symbol;Acc:MGI:1 914 121]
Phyhd14.30E-560.6 780 0510.5340.2281.39E-51phytanoyl-CoA dioxygenase domain containing 1 [Source:MGI Symbol;Acc:MGI:3 612 860]
Gria44.97E-56−0.85760140.2060.421.60E-51glutamate receptor, ionotropic, AMPA4 (alpha 4) [Source:MGI Symbol;Acc:MGI:95 811]
Padi28.82E-560.61 810 8460.4230.1282.85E-51peptidyl arginine deiminase, type II [Source:MGI Symbol;Acc:MGI:1 338 892]
Robo21.23E-540.9 155 6120.7870.5693.98E-50roundabout guidance receptor 2 [Source:MGI Symbol;Acc:MGI:1 890 110]
Ccser11.27E-540.80 908 8570.4730.2874.09E-50coiled-coil serine rich 1 [Source:MGI Symbol;Acc:MGI:3 045 354]
St6galnac32.01E-541.53 920 7550.540.1396.49E-50ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Cdh108.08E-54−0.77856710.4450.7362.61E-49cadherin 10 [Source:MGI Symbol;Acc:MGI:107 436]
Dok61.84E-530.70 032 1640.4620.1635.93E-49docking protein 6 [Source:MGI Symbol;Acc:MGI:3 639 495]
Smad63.72E-530.34 957 9810.2470.0341.20E-48SMAD family member 6 [Source:MGI Symbol;Acc:MGI:1 336 883]
Aqp46.40E-530.78 867 0240.7010.4032.07E-48aquaporin 4 [Source:MGI Symbol;Acc:MGI:107 387]
Grm79.42E-510.88 253 3170.4620.2293.04E-46glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Dgki6.91E-500.76 957 4490.5730.2442.23E-45diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Tex111.04E-490.36 512 0030.2150.0123.35E-45testis expressed gene 11 [Source:MGI Symbol;Acc:MGI:1 933 237]
Ahnak1.08E-480.32 270 0590.2340.0273.48E-44AHNAK nucleoprotein (desmoyokin) [Source:MGI Symbol;Acc:MGI:1 316 648]
Trp632.37E-48−0.91803720.0350.3187.64E-44transformation related protein 63 [Source:MGI Symbol;Acc:MGI:1 330 810]
Tnc2.67E-480.37 489 8670.2340.0238.61E-44tenascin C [Source:MGI Symbol;Acc:MGI:101 922]
Reln3.62E-480.6 459 5270.3970.1091.17E-43reelin [Source:MGI Symbol;Acc:MGI:103 022]
Pxdn3.76E-480.4 112 2210.2930.0721.21E-43peroxidasin [Source:MGI Symbol;Acc:MGI:1 916 925]
Atp13a47.34E-48−0.66697550.1450.4862.37E-43ATPase type 13A4 [Source:MGI Symbol;Acc:MGI:1 924 456]
Cacnb49.29E-470.71 396 1130.4840.2383.00E-42calcium channel, voltage-dependent, beta 4 subunit [Source:MGI Symbol;Acc:MGI:103 301]
Adamts92.03E-460.68 554 0960.4990.2026.57E-42a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 9 [Source:MGI Symbol;Acc:MGI:1 916 320]
Tmtc23.43E-46−0.73294880.2430.5761.11E-41transmembrane and tetratricopeptide repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 914 057]
Limch17.50E-46−0.68115580.3950.6812.42E-41LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Grid21.96E-45−0.66948460.7090.9066.34E-41glutamate receptor, ionotropic, delta 2 [Source:MGI Symbol;Acc:MGI:95 813]
Cadm12.29E-45−0.80658970.5490.8357.40E-41cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:1 889 272]
Sema6a1.15E-440.44 205 1310.3150.0743.73E-40sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
Ggta13.51E-440.29 853 8780.1930.0181.13E-39glycoprotein galactosyltransferase alpha 1, 3 [Source:MGI Symbol;Acc:MGI:95 704]
Npas35.45E-44−0.57127180.9440.9811.76E-39neuronal PAS domain protein 3 [Source:MGI Symbol;Acc:MGI:1 351 610]
Garnl37.71E-440.42 029 5370.3060.0932.49E-39GTPase activating RANGAP domain-like 3 [Source:MGI Symbol;Acc:MGI:2 139 309]
Kcnma11.92E-43−0.78100460.310.6676.19E-39potassium large conductance calcium-activated channel, subfamily M, alpha member 1 [Source:MGI Symbol;Acc:MGI:99 923]
Auts22.67E-43−0.7000360.7350.9138.63E-39autism susceptibility candidate 2 [Source:MGI Symbol;Acc:MGI:1 919 847]
Fmn12.69E-430.79 828 6930.4270.1988.69E-39formin 1 [Source:MGI Symbol;Acc:MGI:101 815]
Disp32.97E-430.4 166 9970.2520.0799.59E-39dispatched RND transporter family member 3 [Source:MGI Symbol;Acc:MGI:2 444 403]
Grin3a4.31E-430.59 174 3050.3860.1361.39E-38glutamate receptor ionotropic, NMDA3A [Source:MGI Symbol;Acc:MGI:1 933 206]
Sema6d8.82E-430.98 719 6660.7110.5332.85E-38sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6D [Source:MGI Symbol;Acc:MGI:2 387 661]
Pcdh71.43E-42−0.62898410.7350.8744.62E-38protocadherin 7 [Source:MGI Symbol;Acc:MGI:1 860 487]
Ank21.64E-420.95 150 8240.9390.9555.30E-38ankyrin 2, brain [Source:MGI Symbol;Acc:MGI:88 025]
Mast41.87E-41−0.67183640.440.7166.04E-37microtubule associated serine/threonine kinase family member 4 [Source:MGI Symbol;Acc:MGI:1 918 885]
Slc4a42.81E-41−0.55013950.8520.9199.08E-37solute carrier family 4 (anion exchanger), member 4 [Source:MGI Symbol;Acc:MGI:1 927 555]
Ano15.02E-410.46 720 2610.2150.0031.62E-36anoctamin 1, calcium activated chloride channel [Source:MGI Symbol;Acc:MGI:2 142 149]
Cmya58.05E-410.45 054 9590.3410.0972.60E-36cardiomyopathy associated 5 [Source:MGI Symbol;Acc:MGI:1 923 719]
Dner1.62E-400.46 188 8890.3990.1765.22E-36delta/notch-like EGF repeat containing [Source:MGI Symbol;Acc:MGI:2 152 889]
Gpld12.60E-40−0.63787620.080.3858.38E-36glycosylphosphatidylinositol specific phospholipase D1 [Source:MGI Symbol;Acc:MGI:106 604]
Negr12.65E-40−0.69709820.620.8528.56E-36neuronal growth regulator 1 [Source:MGI Symbol;Acc:MGI:2 444 846]
Anxa21.10E-390.27 925 3720.1760.0123.54E-35annexin A2 [Source:MGI Symbol;Acc:MGI:88 246]
Vav32.04E-39−0.6866090.0910.4396.58E-35vav 3 oncogene [Source:MGI Symbol;Acc:MGI:1 888 518]
Airn2.14E-390.4 276 2380.2320.0576.90E-35antisense Igf2r RNA [Source:MGI Symbol;Acc:MGI:1 353 471]
Mgat4a2.28E-390.32 616 9760.2170.0397.37E-35mannoside acetylglucosaminyltransferase 4, isoenzyme A [Source:MGI Symbol;Acc:MGI:2 662 992]
Enox14.40E-390.73 574 6870.4990.2741.42E-34ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Frmd4a6.76E-39−0.75556080.7350.9292.18E-34FERM domain containing 4A [Source:MGI Symbol;Acc:MGI:1 919 850]
Eps87.63E-39−0.59955040.2190.5232.46E-34epidermal growth factor receptor pathway substrate 8 [Source:MGI Symbol;Acc:MGI:104 684]
Gm106358.27E-390.4 519 9270.2190.0222.67E-34predicted gene 10 635 [Source:MGI Symbol;Acc:MGI:3 641 740]
Atoh89.59E-390.28 185 6110.1650.0083.10E-34atonal bHLH transcription factor 8 [Source:MGI Symbol;Acc:MGI:1 918 343]
Slc16a23.09E-380.31 372 7040.2280.0519.98E-34solute carrier family 16 (monocarboxylic acid transporters), member 2 [Source:MGI Symbol;Acc:MGI:1 203 732]
Tab28.33E-380.49 912 7840.5210.2572.69E-33TGF-beta activated kinase 1/MAP3K7 binding protein 2 [Source:MGI Symbol;Acc:MGI:1 915 902]
Gm110999.08E-380.33 560 9310.1560.0072.93E-33predicted gene 11 099 [Source:MGI Symbol;Acc:MGI:3 779 335]
Itih39.39E-38−0.61596580.0740.3323.03E-33inter-alpha trypsin inhibitor, heavy chain 3 [Source:MGI Symbol;Acc:MGI:96 620]
P3h21.14E-360.29 550 0610.1780.0183.69E-32prolyl 3-hydroxylase 2 [Source:MGI Symbol;Acc:MGI:2 146 663]
Cables11.22E-36−0.5880480.1450.4593.95E-32CDK5 and Abl enzyme substrate 1 [Source:MGI Symbol;Acc:MGI:1 927 065]
4930402H24Rik1.48E-360.65 012 5090.8550.8344.78E-32NA
Syne11.85E-36−0.55320050.7480.8785.97E-32spectrin repeat containing, nuclear envelope 1 [Source:MGI Symbol;Acc:MGI:1 927 152]
Grm33.44E-36−0.89460450.3340.5831.11E-31glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Eya44.53E-360.43 761 3450.310.1021.46E-31EYA transcriptional coactivator and phosphatase 4 [Source:MGI Symbol;Acc:MGI:1 337 104]
Mamdc23.19E-350.27 013 5470.1560.0071.03E-30MAM domain containing 2 [Source:MGI Symbol;Acc:MGI:1 918 988]
Slc1a24.34E-35−0.55237630.9670.9981.40E-30solute carrier family 1 (glial high affinity glutamate transporter), member 2 [Source:MGI Symbol;Acc:MGI:101 931]
Nxn5.99E-350.62 688 2070.6510.4271.93E-30nucleoredoxin [Source:MGI Symbol;Acc:MGI:109 331]
Phactr36.21E-35−0.57997520.1760.5162.01E-30phosphatase and actin regulator 3 [Source:MGI Symbol;Acc:MGI:1 921 439]
Ccdc85a1.62E-34−0.62650680.1870.5195.22E-30coiled-coil domain containing 85A [Source:MGI Symbol;Acc:MGI:2 445 069]
Ndrg24.31E-34−0.49506960.5790.7271.39E-29N-myc downstream regulated gene 2 [Source:MGI Symbol;Acc:MGI:1 352 498]
Htra15.00E-34−0.57374980.3770.6611.61E-29HtrA serine peptidase 1 [Source:MGI Symbol;Acc:MGI:1 929 076]
St3gal48.55E-34−0.58873510.2650.5412.76E-29ST3 beta-galactoside alpha-2,3-sialyltransferase 4 [Source:MGI Symbol;Acc:MGI:1 316 743]
Tmem132b1.11E-330.31 405 0380.2650.0813.59E-29transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Nav31.86E-33−0.60843310.3170.5146.00E-29neuron navigator 3 [Source:MGI Symbol;Acc:MGI:2 183 703]
Atp2b42.16E-330.32 348 1480.2650.0816.97E-29ATPase, Ca++ transporting, plasma membrane 4 [Source:MGI Symbol;Acc:MGI:88 111]
Met2.35E-330.29 645 2570.1630.0057.60E-29met proto-oncogene [Source:MGI Symbol;Acc:MGI:96 969]
Flnc7.50E-330.27 142 0560.1410.012.42E-28filamin C, gamma [Source:MGI Symbol;Acc:MGI:95 557]
Fat31.86E-32−0.54469370.5360.6686.01E-28FAT atypical cadherin 3 [Source:MGI Symbol;Acc:MGI:2 444 314]
Id32.99E-320.44 213 5360.3820.1389.65E-28inhibitor of DNA binding 3 [Source:MGI Symbol;Acc:MGI:96 398]
Acsbg13.38E-32−0.51663020.3750.5931.09E-27acyl-CoA synthetase bubblegum family member 1 [Source:MGI Symbol;Acc:MGI:2 385 656]
Ptprg5.17E-32−0.54858780.4790.6311.67E-27NA
Tenm46.03E-32−0.49947230.2080.4141.95E-27teneurin transmembrane protein 4 [Source:MGI Symbol;Acc:MGI:2 447 063]
Slc6a16.17E-32−0.46255770.390.5951.99E-27solute carrier family 6 (neurotransmitter transporter, GABA), member 1 [Source:MGI Symbol;Acc:MGI:95 627]
Fgfr37.78E-32−0.46368980.4160.6252.51E-27fibroblast growth factor receptor 3 [Source:MGI Symbol;Acc:MGI:95 524]
Kcnip32.19E-31−0.50406720.1320.3697.08E-27Kv channel interacting protein 3, calsenilin [Source:MGI Symbol;Acc:MGI:1 929 258]
Ntng12.53E-310.47 422 6670.2470.0618.18E-27netrin G1 [Source:MGI Symbol;Acc:MGI:1 934 028]
Tmc74.94E-31−0.49709030.0910.3361.59E-26transmembrane channel-like gene family 7 [Source:MGI Symbol;Acc:MGI:2 443 317]
Tafa15.30E-31−0.65893280.1080.3081.71E-26TAFA chemokine like family member 1 [Source:MGI Symbol;Acc:MGI:2 443 695]
Frmpd46.58E-310.36 641 1150.2860.1362.12E-26FERM and PDZ domain containing 4 [Source:MGI Symbol;Acc:MGI:3 042 378]
Cep85l2.02E-30−0.48200370.3340.5686.52E-26centrosomal protein 85-like [Source:MGI Symbol;Acc:MGI:3 642 684]
Prickle22.16E-300.63 320 0450.610.3696.96E-26prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
C33.37E-300.26 171 3210.1480.0121.09E-25complement component 3 [Source:MGI Symbol;Acc:MGI:88 227]
Pdgfd4.30E-300.64 872 8860.6070.3891.39E-25platelet-derived growth factor, D polypeptide [Source:MGI Symbol;Acc:MGI:1 919 035]
Miat4.48E-300.28 579 9650.210.0561.45E-25myocardial infarction associated transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 886]
Kalrn4.56E-30−0.55721350.2490.5561.47E-25kalirin, RhoGEF kinase [Source:MGI Symbol;Acc:MGI:2 685 385]
Klhl294.79E-300.34 632 9080.330.1281.54E-25kelch-like 29 [Source:MGI Symbol;Acc:MGI:2 683 857]
Osbpl35.99E-300.32 270 9410.2190.0571.93E-25oxysterol binding protein-like 3 [Source:MGI Symbol;Acc:MGI:1 918 970]
Atp1b22.35E-29−0.48022990.4210.5317.59E-25ATPase, Na+/K + transporting, beta 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 109]
Dgkb2.41E-29−0.54566150.7460.8967.79E-25diacylglycerol kinase, beta [Source:MGI Symbol;Acc:MGI:2 442 474]
2610307P16Rik2.50E-290.44 161 5380.2650.0658.07E-25RIKEN cDNA 2610307P16 gene [Source:MGI Symbol;Acc:MGI:1 919 768]
Dock52.53E-29−0.42793390.0980.2718.17E-25dedicator of cytokinesis 5 [Source:MGI Symbol;Acc:MGI:2 652 871]
Slco1c12.73E-29−0.58344170.150.4538.80E-25solute carrier organic anion transporter family, member 1c1 [Source:MGI Symbol;Acc:MGI:1 889 679]
Grin2c4.74E-29−0.51409050.1040.4211.53E-24glutamate receptor, ionotropic, NMDA2C (epsilon 3) [Source:MGI Symbol;Acc:MGI:95 822]
Plekha64.74E-290.32 322 5750.2620.081.53E-24pleckstrin homology domain containing, family A member 6 [Source:MGI Symbol;Acc:MGI:2 388 662]
Luzp24.80E-29−1.1363530.6490.8881.55E-24leucine zipper protein 2 [Source:MGI Symbol;Acc:MGI:1 889 615]
Apbb1ip8.64E-290.319 4610.1950.0212.79E-24amyloid beta (A4) precursor protein-binding, family B, member 1 interacting protein [Source:MGI Symbol;Acc:MGI:1 861 354]
Tnik1.81E-28−0.45286520.8480.9195.84E-24TRAF2 and NCK interacting kinase [Source:MGI Symbol;Acc:MGI:1 916 264]
Grk31.89E-28−0.48679820.2730.5626.11E-24G protein-coupled receptor kinase 3 [Source:MGI Symbol;Acc:MGI:87 941]
Nwd12.12E-28−0.49137720.4580.6956.83E-24NACHT and WD repeat domain containing 1 [Source:MGI Symbol;Acc:MGI:2 442 268]
Shroom33.36E-28−0.47205920.3120.4451.08E-23shroom family member 3 [Source:MGI Symbol;Acc:MGI:1 351 655]
Hip14.84E-28−0.48733460.2210.4791.56E-23huntingtin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 099 804]
Armc21.06E-270.35 458 0490.260.0813.43E-23armadillo repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 916 449]
Plscr41.14E-270.36 422 8220.3150.1023.67E-23phospholipid scramblase 4 [Source:MGI Symbol;Acc:MGI:2 143 267]
Cep1123.75E-270.31 022 3890.2580.081.21E-22centrosomal protein 112 [Source:MGI Symbol;Acc:MGI:1 923 673]
Ahcyl14.67E-27−0.46130040.4380.6641.51E-22S-adenosylhomocysteine hydrolase-like 1 [Source:MGI Symbol;Acc:MGI:2 385 184]
Mertk5.96E-27−0.62954020.5770.7941.92E-22MER proto-oncogene tyrosine kinase [Source:MGI Symbol;Acc:MGI:96 965]
Tulp47.54E-270.48 002 0980.590.3922.43E-22tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Tspan79.19E-27−0.60251660.5570.7832.97E-22tetraspanin 7 [Source:MGI Symbol;Acc:MGI:1 298 407]
Xylt11.90E-26−0.51734750.2230.5016.13E-22xylosyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 451 073]
St3gal62.80E-260.26 891 0790.1890.0429.05E-22ST3 beta-galactoside alpha-2,3-sialyltransferase 6 [Source:MGI Symbol;Acc:MGI:1 888 707]
Myo163.60E-260.3 868 6270.2750.0941.16E-21myosin XVI [Source:MGI Symbol;Acc:MGI:2 685 951]
Ptprj3.83E-26−0.51797520.2410.4251.24E-21protein tyrosine phosphatase, receptor type, J [Source:MGI Symbol;Acc:MGI:104 574]
Npas23.91E-26−0.47452730.3490.5611.26E-21neuronal PAS domain protein 2 [Source:MGI Symbol;Acc:MGI:109 232]
Abcc45.32E-260.25 504 1830.2280.0651.72E-21ATP-binding cassette, sub-family C (CFTR/MRP), member 4 [Source:MGI Symbol;Acc:MGI:2 443 111]
Ablim16.53E-26−0.4412370.260.5082.11E-21actin-binding LIM protein 1 [Source:MGI Symbol;Acc:MGI:1 194 500]
Pamr19.42E-260.31 300 2710.2430.083.04E-21peptidase domain containing associated with muscle regeneration 1 [Source:MGI Symbol;Acc:MGI:2 445 082]
Pde4b2.15E-25−0.61258360.3950.5646.93E-21phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Rfx23.58E-250.25 164 9040.2060.0531.16E-20regulatory factor X, 2 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:106 583]
Gjb63.65E-25−0.39927990.1060.3411.18E-20gap junction protein, beta 6 [Source:MGI Symbol;Acc:MGI:107 588]
Rapgef46.94E-250.3 878 8060.2690.1282.24E-20Rap guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:1 917 723]
Rps6ka57.23E-250.39 342 2340.4190.2182.34E-20ribosomal protein S6 kinase, polypeptide 5 [Source:MGI Symbol;Acc:MGI:1 920 336]
Slc6a98.63E-25−0.34170660.1080.2652.78E-20solute carrier family 6 (neurotransmitter transporter, glycine), member 9 [Source:MGI Symbol;Acc:MGI:95 760]
Gm351881.74E-24−0.51985970.3930.6425.61E-20predicted gene, 35 188 [Source:MGI Symbol;Acc:MGI:5 594 347]
Wdr171.84E-24−0.67369960.7160.8425.93E-20WD repeat domain 17 [Source:MGI Symbol;Acc:MGI:1 924 662]
Mgat4c1.93E-24−0.38743970.5080.5526.23E-20MGAT4 family, member C [Source:MGI Symbol;Acc:MGI:1 914 819]
Il6st1.96E-240.30 887 3980.2930.1146.31E-20interleukin 6 signal transducer [Source:MGI Symbol;Acc:MGI:96 560]
Fry2.03E-24−0.33083650.6010.6616.56E-20FRY microtubule binding protein [Source:MGI Symbol;Acc:MGI:2 443 895]
Ddr12.06E-240.34 612 2530.3190.1436.65E-20discoidin domain receptor family, member 1 [Source:MGI Symbol;Acc:MGI:99 216]
9530026P05Rik2.30E-240.6 724 1210.4510.2387.43E-20RIKEN cDNA 9530026P05 gene [Source:MGI Symbol;Acc:MGI:1 924 659]
Plcl12.96E-24−0.54617790.390.6029.55E-20phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Thbs43.13E-240.26 018 0990.1260.0181.01E-19thrombospondin 4 [Source:MGI Symbol;Acc:MGI:1 101 779]
Wasf34.11E-24−0.40801660.3230.5411.33E-19WASP family, member 3 [Source:MGI Symbol;Acc:MGI:2 658 986]
Bmpr1b4.19E-240.51 910 0950.7770.6711.35E-19bone morphogenetic protein receptor, type 1B [Source:MGI Symbol;Acc:MGI:107 191]
Abcg24.64E-240.2 696 1690.180.0391.50E-19ATP binding cassette subfamily G member 2 (Junior blood group) [Source:MGI Symbol;Acc:MGI:1 347 061]
Pacrg5.76E-240.51 573 1970.540.3051.86E-19PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Nav26.65E-240.50 495 9320.6720.5262.15E-19neuron navigator 2 [Source:MGI Symbol;Acc:MGI:2 183 691]
Adcy86.82E-240.49 769 6870.4210.2382.20E-19adenylate cyclase 8 [Source:MGI Symbol;Acc:MGI:1 341 110]
Arhgef287.54E-24−0.34171580.3360.4392.43E-19Rho guanine nucleotide exchange factor (GEF) 28 [Source:MGI Symbol;Acc:MGI:1 346 016]
Phka18.43E-24−0.49889370.4710.6452.72E-19phosphorylase kinase alpha 1 [Source:MGI Symbol;Acc:MGI:97 576]
Sorcs21.49E-23−0.40460820.1020.3424.82E-19sortilin-related VPS10 domain containing receptor 2 [Source:MGI Symbol;Acc:MGI:1 932 289]
Fgfr22.62E-23−0.49287160.6960.8268.45E-19fibroblast growth factor receptor 2 [Source:MGI Symbol;Acc:MGI:95 523]
Vegfa2.66E-23−0.44432130.3230.5338.58E-19vascular endothelial growth factor A [Source:MGI Symbol;Acc:MGI:103 178]
Phlpp12.95E-23−0.4415010.670.8059.52E-19PH domain and leucine rich repeat protein phosphatase 1 [Source:MGI Symbol;Acc:MGI:2 138 327]
Agbl43.41E-230.31 829 1360.280.1561.10E-18ATP/GTP binding protein-like 4 [Source:MGI Symbol;Acc:MGI:1 918 244]
Chd93.90E-23−0.39624570.6310.7681.26E-18chromodomain helicase DNA binding protein 9 [Source:MGI Symbol;Acc:MGI:1 924 001]
Syt75.17E-230.29 056 6340.2560.1091.67E-18synaptotagmin VII [Source:MGI Symbol;Acc:MGI:1 859 545]
Pgm55.43E-230.36 064 8080.2080.0371.75E-18phosphoglucomutase 5 [Source:MGI Symbol;Acc:MGI:1 925 668]
Nrcam7.62E-23−0.42771690.6550.8222.46E-18neuronal cell adhesion molecule [Source:MGI Symbol;Acc:MGI:104 750]
Esrrg1.51E-22−0.37881910.3580.4814.87E-18estrogen-related receptor gamma [Source:MGI Symbol;Acc:MGI:1 347 056]
Ski2.23E-220.36 561 5220.3560.1767.19E-18ski sarcoma viral oncogene homolog (avian) [Source:MGI Symbol;Acc:MGI:98 310]
Lrrc93.59E-220.25 188 7780.230.0741.16E-17leucine rich repeat containing 9 [Source:MGI Symbol;Acc:MGI:1 925 507]
Kmt2c4.36E-22−0.40842180.5030.6461.41E-17lysine (K)-specific methyltransferase 2C [Source:MGI Symbol;Acc:MGI:2 444 959]
Cdk175.13E-220.31 776 5450.3640.1951.66E-17cyclin-dependent kinase 17 [Source:MGI Symbol;Acc:MGI:97 517]
Bmp65.80E-220.30 526 8880.1890.0451.87E-17bone morphogenetic protein 6 [Source:MGI Symbol;Acc:MGI:88 182]
Mical26.40E-22−0.40585430.4530.6382.07E-17microtubule associated monooxygenase, calponin and LIM domain containing 2 [Source:MGI Symbol;Acc:MGI:2 444 947]
Shc36.90E-22−0.39790530.1320.3742.23E-17src homology 2 domain-containing transforming protein C3 [Source:MGI Symbol;Acc:MGI:106 179]
Nim1k9.23E-22−0.40655110.1890.4062.98E-17NIM1 serine/threonine protein kinase [Source:MGI Symbol;Acc:MGI:2 442 399]
Egfr1.06E-21−0.44128390.1780.4533.42E-17epidermal growth factor receptor [Source:MGI Symbol;Acc:MGI:95 294]
Ccdc1361.11E-210.34 468 6360.3450.1883.59E-17coiled-coil domain containing 136 [Source:MGI Symbol;Acc:MGI:1 918 128]
9630028H03Rik1.23E-21−0.39854630.0760.2963.96E-17RIKEN cDNA 9630028H03 gene [Source:MGI Symbol;Acc:MGI:2 444 526]
Arhgap61.37E-210.2 759 5590.1670.044.43E-17Rho GTPase activating protein 6 [Source:MGI Symbol;Acc:MGI:1 196 332]
Slc25a211.67E-210.43 983 0650.3670.1365.39E-17solute carrier family 25 (mitochondrial oxodicarboxylate carrier), member 21 [Source:MGI Symbol;Acc:MGI:2 445 059]
Pde10a1.67E-21−0.87998210.1820.3975.39E-17phosphodiesterase 10A [Source:MGI Symbol;Acc:MGI:1 345 143]
Igfbp52.16E-210.35 607 1570.2840.1096.98E-17insulin-like growth factor binding protein 5 [Source:MGI Symbol;Acc:MGI:96 440]
Dmd2.40E-21−0.49480860.6680.8187.75E-17dystrophin, muscular dystrophy [Source:MGI Symbol;Acc:MGI:94 909]
Wwox2.73E-210.661 1160.7310.5318.82E-17WW domain-containing oxidoreductase [Source:MGI Symbol;Acc:MGI:1 931 237]
Flvcr12.88E-210.28 350 7830.180.0589.29E-17feline leukemia virus subgroup C cellular receptor 1 [Source:MGI Symbol;Acc:MGI:2 444 881]
Utrn3.40E-210.56 232 0440.6960.5921.10E-16utrophin [Source:MGI Symbol;Acc:MGI:104 631]
Etv43.67E-21−0.41480610.0260.271.18E-16ets variant 4 [Source:MGI Symbol;Acc:MGI:99 423]
Gabbr24.65E-21−0.48095810.1150.321.50E-16gamma-aminobutyric acid (GABA) B receptor, 2 [Source:MGI Symbol;Acc:MGI:2 386 030]
Tsc22d17.13E-210.30 642 5310.4450.272.30E-16TSC22 domain family, member 1 [Source:MGI Symbol;Acc:MGI:109 127]
Mgat57.30E-210.37 459 7910.5140.3362.36E-16mannoside acetylglucosaminyltransferase 5 [Source:MGI Symbol;Acc:MGI:894 701]
Etnppl8.27E-21−0.4354390.1840.3982.67E-16ethanolamine phosphate phospholyase [Source:MGI Symbol;Acc:MGI:1 919 010]
Kcnj101.83E-20−0.34450520.2150.3515.91E-16potassium inwardly-rectifying channel, subfamily J, member 10 [Source:MGI Symbol;Acc:MGI:1 194 504]
Pbx12.42E-200.45 860 1090.8890.9017.82E-16pre B cell leukemia homeobox 1 [Source:MGI Symbol;Acc:MGI:97 495]
Kif21a2.63E-200.37 637 5380.5920.4158.50E-16kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
F32.75E-20−0.38615180.3950.5368.88E-16coagulation factor III [Source:MGI Symbol;Acc:MGI:88 381]
Itpr24.32E-20−0.38444840.3020.4841.40E-15inositol 1,4,5-triphosphate receptor 2 [Source:MGI Symbol;Acc:MGI:99 418]
Map2k64.93E-20−0.38073380.1610.3731.59E-15mitogen-activated protein kinase kinase 6 [Source:MGI Symbol;Acc:MGI:1 346 870]
Ghr5.27E-20−0.41385010.2930.4861.70E-15growth hormone receptor [Source:MGI Symbol;Acc:MGI:95 708]
Camk1d6.31E-20−0.46280450.4530.6712.04E-15calcium/calmodulin-dependent protein kinase ID [Source:MGI Symbol;Acc:MGI:2 442 190]
Tenm36.32E-200.45 681 2960.7090.5292.04E-15teneurin transmembrane protein 3 [Source:MGI Symbol;Acc:MGI:1 345 183]
Serpine26.56E-20−0.37787130.3120.4892.12E-15serine (or cysteine) peptidase inhibitor, clade E, member 2 [Source:MGI Symbol;Acc:MGI:101 780]
Mpdz8.64E-200.32 366 9020.3250.1642.79E-15multiple PDZ domain crumbs cell polarity complex component [Source:MGI Symbol;Acc:MGI:1 343 489]
Prr168.74E-20−0.38983670.130.3032.82E-15proline rich 16 [Source:MGI Symbol;Acc:MGI:1 918 623]
Sipa1l19.14E-200.31 642 9060.3540.1952.95E-15signal-induced proliferation-associated 1 like 1 [Source:MGI Symbol;Acc:MGI:2 443 679]
9630014M24Rik1.01E-19−0.36049980.0480.2683.25E-15RIKEN cDNA 9630014M24 gene [Source:MGI Symbol;Acc:MGI:3 588 234]
Pcdh11x1.06E-19−0.43014620.2060.4183.43E-15protocadherin 11 X-linked [Source:MGI Symbol;Acc:MGI:2 442 849]
Daam21.24E-19−0.40299570.380.5794.01E-15dishevelled associated activator of morphogenesis 2 [Source:MGI Symbol;Acc:MGI:1 923 691]
Myo5a2.01E-190.31 211 7670.3510.2186.49E-15myosin VA [Source:MGI Symbol;Acc:MGI:105 976]
Ctnnd22.21E-19−0.33544240.9590.9797.13E-15catenin (cadherin associated protein), delta 2 [Source:MGI Symbol;Acc:MGI:1 195 966]
Nkain22.91E-191.07 747 9260.6940.4659.39E-15Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Tprkb5.34E-190.41 617 8930.540.3671.72E-14Tp53rk binding protein [Source:MGI Symbol;Acc:MGI:1 917 036]
St6galnac55.81E-19−0.46329760.050.2511.87E-14ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 5 [Source:MGI Symbol;Acc:MGI:1 349 471]
Wnk26.61E-190.32 581 3630.560.452.14E-14WNK lysine deficient protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 922 857]
Hipk21.04E-18−0.36330730.330.523.34E-14homeodomain interacting protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 314 872]
Paqr81.23E-18−0.4099550.5340.683.96E-14progestin and adipoQ receptor family member VIII [Source:MGI Symbol;Acc:MGI:1 921 479]
Csmd31.59E-18−0.38243580.3170.4425.14E-14CUB and Sushi multiple domains 3 [Source:MGI Symbol;Acc:MGI:2 386 403]
Tril1.66E-18−0.29567320.1130.2585.36E-14TLR4 interactor with leucine-rich repeats [Source:MGI Symbol;Acc:MGI:1 914 123]
Ttc31.97E-180.33 617 4860.720.6146.34E-14tetratricopeptide repeat domain 3 [Source:MGI Symbol;Acc:MGI:1 276 539]
Syn22.93E-18−0.36464740.3770.5119.45E-14synapsin II [Source:MGI Symbol;Acc:MGI:103 020]
Zfp4623.48E-180.41 639 7750.5310.3211.12E-13zinc finger protein 462 [Source:MGI Symbol;Acc:MGI:107 690]
Etv54.64E-18−0.31365220.0980.2871.50E-13ets variant 5 [Source:MGI Symbol;Acc:MGI:1 096 867]
Hif1a4.84E-18−0.2855130.1240.2641.56E-13hypoxia inducible factor 1, alpha subunit [Source:MGI Symbol;Acc:MGI:106 918]
Qk5.84E-18−0.30950920.9050.9521.88E-13NA
Angpt16.03E-180.36 156 7160.3430.1531.95E-13angiopoietin 1 [Source:MGI Symbol;Acc:MGI:108 448]
Ptprz16.17E-18−0.4077510.8130.8971.99E-13protein tyrosine phosphatase, receptor type Z, polypeptide 1 [Source:MGI Symbol;Acc:MGI:97 816]
Pde8b7.34E-18−0.47950910.1930.4292.37E-13phosphodiesterase 8B [Source:MGI Symbol;Acc:MGI:2 443 999]
Paqr68.29E-18−0.25736120.0760.2062.68E-13progestin and adipoQ receptor family member VI [Source:MGI Symbol;Acc:MGI:1 916 207]
Rgs7bp9.33E-18−0.36288870.1540.3423.01E-13regulator of G-protein signalling 7 binding protein [Source:MGI Symbol;Acc:MGI:106 334]
Gm303821.03E-17−0.32001860.0370.1613.32E-13predicted gene, 30 382 [Source:MGI Symbol;Acc:MGI:5 589 541]
Nr3c21.42E-17−0.37639490.4660.6324.59E-13nuclear receptor subfamily 3, group C, member 2 [Source:MGI Symbol;Acc:MGI:99 459]
Gm295141.61E-17−0.31190710.0460.2185.19E-13predicted gene 29 514 [Source:MGI Symbol;Acc:MGI:5 580 220]
Cdh202.29E-17−0.32722130.6230.7157.38E-13cadherin 20 [Source:MGI Symbol;Acc:MGI:1 346 069]
4930545L23Rik2.29E-17−0.31231950.0390.2077.39E-13RIKEN cDNA 4930545L23 gene [Source:MGI Symbol;Acc:MGI:1 926 055]
Tsc22d32.66E-17−0.35317440.1670.3088.58E-13TSC22 domain family, member 3 [Source:MGI Symbol;Acc:MGI:1 196 284]
Mir124-2hg2.83E-17−0.30729330.1110.2879.14E-13Mir124-2 host gene (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 917 691]
Unc5c3.79E-170.51 316 4480.3450.2171.22E-12unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Ralgps23.84E-170.30 587 3090.3470.1761.24E-12Ral GEF with PH domain and SH3 binding motif 2 [Source:MGI Symbol;Acc:MGI:1 925 505]
Naaladl23.86E-170.47 242 1590.5270.3341.25E-12N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Spred13.92E-17−0.35151260.2540.4611.27E-12sprouty protein with EVH-1 domain 1, related sequence [Source:MGI Symbol;Acc:MGI:2 150 016]
Prkce4.64E-170.32 778 0490.5380.3571.50E-12protein kinase C, epsilon [Source:MGI Symbol;Acc:MGI:97 599]
Erbb45.00E-17−0.27353870.5640.561.61E-12erb-b2 receptor tyrosine kinase 4 [Source:MGI Symbol;Acc:MGI:104 771]
Arhgap265.43E-17−0.3746340.3540.5291.75E-12Rho GTPase activating protein 26 [Source:MGI Symbol;Acc:MGI:1 918 552]
Tgfb26.00E-170.27 281 3620.2520.1011.94E-12transforming growth factor, beta 2 [Source:MGI Symbol;Acc:MGI:98 726]
Rfx46.00E-170.50 589 5770.6680.5241.94E-12regulatory factor X, 4 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:1 918 387]
Actr3b6.84E-17−0.30921650.0950.2792.21E-12ARP3 actin-related protein 3B [Source:MGI Symbol;Acc:MGI:2 661 120]
Cacna1c6.97E-170.30 918 3930.2340.1132.25E-12calcium channel, voltage-dependent, L type, alpha 1C subunit [Source:MGI Symbol;Acc:MGI:103 013]
Nrg27.41E-170.40 615 1540.4250.2272.39E-12neuregulin 2 [Source:MGI Symbol;Acc:MGI:1 098 246]
Abcc128.05E-170.27 124 3680.1240.0012.60E-12ATP-binding cassette, sub-family C (CFTR/MRP), member 12 [Source:MGI Symbol;Acc:MGI:2 441 679]
Lhfp1.32E-16−0.44843810.4210.5584.25E-12lipoma HMGIC fusion partner [Source:MGI Symbol;Acc:MGI:1 920 048]
Cdh191.37E-16−0.39954830.4160.6394.42E-12cadherin 19, type 2 [Source:MGI Symbol;Acc:MGI:3 588 198]
Efr3b2.37E-16−0.35896560.2520.4367.66E-12EFR3 homolog B [Source:MGI Symbol;Acc:MGI:2 444 851]
Snrk2.59E-16−0.27634490.130.2768.35E-12SNF related kinase [Source:MGI Symbol;Acc:MGI:108 104]
Nrbp22.67E-160.31 083 0320.3640.1988.61E-12nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Znrf32.68E-16−0.36015180.3490.5418.67E-12zinc and ring finger 3 [Source:MGI Symbol;Acc:MGI:3 039 616]
Slc25a182.73E-16−0.293550.1820.3318.81E-12solute carrier family 25 (mitochondrial carrier), member 18 [Source:MGI Symbol;Acc:MGI:1 919 053]
Frem12.81E-16−0.26884840.0410.1839.07E-12Fras1 related extracellular matrix protein 1 [Source:MGI Symbol;Acc:MGI:2 670 972]
Irak23.22E-16−0.35947760.2840.4621.04E-11interleukin-1 receptor-associated kinase 2 [Source:MGI Symbol;Acc:MGI:2 429 603]
Nnat3.46E-160.49 109 3640.2490.1681.12E-11neuronatin [Source:MGI Symbol;Acc:MGI:104 716]
Robo14.72E-16−0.34446260.3040.4121.52E-11roundabout guidance receptor 1 [Source:MGI Symbol;Acc:MGI:1 274 781]
Macrod15.02E-16−0.27263890.1240.2741.62E-11mono-ADP ribosylhydrolase 1 [Source:MGI Symbol;Acc:MGI:2 147 583]
Tafa56.98E-160.30 683 6790.3950.2362.25E-11TAFA chemokine like family member 5 [Source:MGI Symbol;Acc:MGI:2 146 182]
Hif3a8.85E-16−0.30664720.2280.3992.86E-11hypoxia inducible factor 3, alpha subunit [Source:MGI Symbol;Acc:MGI:1 859 778]
Per31.19E-15−0.27632390.210.3523.83E-11period circadian clock 3 [Source:MGI Symbol;Acc:MGI:1 277 134]
Gm61451.55E-15−0.34107270.4840.6315.01E-11predicted gene 6145 [Source:MGI Symbol;Acc:MGI:3 779 559]
Cdh221.77E-15−0.25025550.0930.1935.71E-11cadherin 22 [Source:MGI Symbol;Acc:MGI:1 341 843]
Itgav2.98E-15−0.30584590.1930.3759.61E-11integrin alpha V [Source:MGI Symbol;Acc:MGI:96 608]
Ripor23.01E-15−0.26244060.0330.1779.73E-11RHO family interacting cell polarization regulator 2 [Source:MGI Symbol;Acc:MGI:2 444 879]
Map1b3.10E-150.33 093 8720.5310.4281.00E-10microtubule-associated protein 1B [Source:MGI Symbol;Acc:MGI:1 306 778]
Stk32a3.37E-150.63 100 5440.410.2261.09E-10serine/threonine kinase 32A [Source:MGI Symbol;Acc:MGI:2 442 403]
Slc7a23.54E-150.38 023 4180.4580.3091.14E-10solute carrier family 7 (cationic amino acid transporter, y + system), member 2 [Source:MGI Symbol;Acc:MGI:99 828]
Pros13.70E-150.26 161 4790.1840.0761.19E-10protein S (alpha) [Source:MGI Symbol;Acc:MGI:1 095 733]
Glul4.09E-15−0.37453610.3930.5971.32E-10glutamate-ammonia ligase (glutamine synthetase) [Source:MGI Symbol;Acc:MGI:95 739]
Washc24.58E-15−0.29666350.20.3591.48E-10WASH complex subunit 2 [Source:MGI Symbol;Acc:MGI:106 463]
Sat14.69E-15−0.32853420.260.4161.52E-10spermidine/spermine N1-acetyl transferase 1 [Source:MGI Symbol;Acc:MGI:98 233]
Man1a5.06E-150.25 671 6970.2170.091.63E-10mannosidase 1, alpha [Source:MGI Symbol;Acc:MGI:104 677]
Cap25.07E-15−0.29239790.1610.3331.64E-10CAP, adenylate cyclase-associated protein, 2 (yeast) [Source:MGI Symbol;Acc:MGI:1 914 502]
Pla2g75.26E-15−0.32651650.4160.5951.70E-10phospholipase A2, group VII (platelet-activating factor acetylhydrolase, plasma) [Source:MGI Symbol;Acc:MGI:1 351 327]
Cdh25.37E-15−0.35713410.4620.6291.73E-10cadherin 2 [Source:MGI Symbol;Acc:MGI:88 355]
Prex28.14E-15−0.42284340.7050.8262.63E-10phosphatidylinositol-3,4,5-trisphosphate-dependent Rac exchange factor 2 [Source:MGI Symbol;Acc:MGI:1 923 385]
Tmcc39.77E-15−0.30733460.4430.5673.16E-10transmembrane and coiled coil domains 3 [Source:MGI Symbol;Acc:MGI:2 442 900]
Spag91.02E-14−0.30034320.5860.6963.28E-10sperm associated antigen 9 [Source:MGI Symbol;Acc:MGI:1 918 084]
Adcy21.06E-140.29 525 0120.5770.4873.41E-10adenylate cyclase 2 [Source:MGI Symbol;Acc:MGI:99 676]
Gli31.10E-14−0.33010320.5420.6923.55E-10GLI-Kruppel family member GLI3 [Source:MGI Symbol;Acc:MGI:95 729]
Hmgn31.10E-14−0.30435120.1410.3243.57E-10high mobility group nucleosomal binding domain 3 [Source:MGI Symbol;Acc:MGI:2 138 069]
Ldlrad41.19E-14−0.31893250.2130.3563.84E-10low density lipoprotein receptor class A domain containing 4 [Source:MGI Symbol;Acc:MGI:1 277 150]
Eps151.28E-14−0.29645940.4620.6064.14E-10epidermal growth factor receptor pathway substrate 15 [Source:MGI Symbol;Acc:MGI:104 583]
Gli21.39E-14−0.32220330.2840.4594.47E-10GLI-Kruppel family member GLI2 [Source:MGI Symbol;Acc:MGI:95 728]
Dock11.56E-14−0.32618150.5230.6735.04E-10dedicator of cytokinesis 1 [Source:MGI Symbol;Acc:MGI:2 429 765]
Sox2ot1.64E-14−0.33052370.4340.5045.30E-10SOX2 overlapping transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 112]
Cnn31.70E-140.28 344 2520.3170.1945.50E-10calponin 3, acidic [Source:MGI Symbol;Acc:MGI:1 919 244]
Ttyh11.92E-14−0.29267970.6050.7186.19E-10tweety family member 1 [Source:MGI Symbol;Acc:MGI:1 889 007]
Gm442572.12E-14−0.26098730.0330.1976.85E-10predicted gene, 44 257 [Source:MGI Symbol;Acc:MGI:5 690 649]
Adamts202.16E-140.29 924 1810.2730.1486.97E-10a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 20 [Source:MGI Symbol;Acc:MGI:2 660 628]
Dclk22.20E-140.30 007 3780.4190.2677.11E-10doublecortin-like kinase 2 [Source:MGI Symbol;Acc:MGI:1 918 012]
Cacna1a2.21E-140.25 941 8020.3190.1927.14E-10calcium channel, voltage-dependent, P/Q type, alpha 1A subunit [Source:MGI Symbol;Acc:MGI:109 482]
Plekha52.37E-140.28 678 2280.3560.2177.64E-10pleckstrin homology domain containing, family A member 5 [Source:MGI Symbol;Acc:MGI:1 923 802]
Kifc32.45E-14−0.25976760.1610.3177.90E-10kinesin family member C3 [Source:MGI Symbol;Acc:MGI:109 202]
Lgr62.51E-14−0.2593910.0240.1568.11E-10leucine-rich repeat-containing G protein-coupled receptor 6 [Source:MGI Symbol;Acc:MGI:2 441 805]
Eda2.59E-140.32 338 3020.3620.2228.37E-10ectodysplasin-A [Source:MGI Symbol;Acc:MGI:1 195 272]
Ccdc1622.67E-140.31 699 3020.2690.1248.61E-10coiled-coil domain containing 162 [Source:MGI Symbol;Acc:MGI:1 923 223]
Arid5b3.24E-140.2 963 0380.2820.151.04E-09AT rich interactive domain 5B (MRF1-like) [Source:MGI Symbol;Acc:MGI:2 175 912]
Garem13.77E-14−0.36059850.2540.4491.22E-09GRB2 associated regulator of MAPK1 subtype 1 [Source:MGI Symbol;Acc:MGI:2 685 790]
Arhgap53.93E-14−0.33484380.6620.7571.27E-09Rho GTPase activating protein 5 [Source:MGI Symbol;Acc:MGI:1 332 637]
Immp2l3.95E-140.31 435 5180.330.1941.27E-09IMP2 inner mitochondrial membrane peptidase-like (S. cerevisiae) [Source:MGI Symbol;Acc:MGI:2 135 611]
Aldoc4.99E-14−0.25647490.3560.4761.61E-09aldolase C, fructose-bisphosphate [Source:MGI Symbol;Acc:MGI:101 863]
Grip15.24E-14−0.3209810.1240.2691.69E-09glutamate receptor interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 921 303]
Fgf15.34E-14−0.27476260.1970.3461.73E-09fibroblast growth factor 1 [Source:MGI Symbol;Acc:MGI:95 515]
App5.83E-140.32 161 6870.6550.531.88E-09amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Wipf16.20E-14−0.28437770.1390.2542.00E-09WAS/WASL interacting protein family, member 1 [Source:MGI Symbol;Acc:MGI:2 178 801]
Cyfip17.55E-14−0.27023090.2190.3672.44E-09cytoplasmic FMR1 interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 338 801]
Gnao18.00E-14−0.54154020.5940.6752.58E-09guanine nucleotide binding protein, alpha O [Source:MGI Symbol;Acc:MGI:95 775]
Ccdc1418.02E-14−0.29317220.3410.4542.59E-09coiled-coil domain containing 141 [Source:MGI Symbol;Acc:MGI:1 919 735]
Stard138.21E-140.4 152 6490.5550.3882.65E-09StAR-related lipid transfer (START) domain containing 13 [Source:MGI Symbol;Acc:MGI:2 385 331]
Fut98.62E-14−0.3228330.5380.662.78E-09fucosyltransferase 9 [Source:MGI Symbol;Acc:MGI:1 330 859]
Sycp29.81E-14−0.26892640.1040.2673.17E-09synaptonemal complex protein 2 [Source:MGI Symbol;Acc:MGI:1 933 281]
Tox1.04E-13−0.37116680.2990.5143.36E-09thymocyte selection-associated high mobility group box [Source:MGI Symbol;Acc:MGI:2 181 659]
Eif4g31.08E-13−0.32461490.4010.5713.48E-09eukaryotic translation initiation factor 4 gamma, 3 [Source:MGI Symbol;Acc:MGI:1 923 935]
Stat31.34E-130.27 159 3520.3060.1534.34E-09signal transducer and activator of transcription 3 [Source:MGI Symbol;Acc:MGI:103 038]
Sned11.48E-130.2 999 9790.3470.24.78E-09sushi, nidogen and EGF-like domains 1 [Source:MGI Symbol;Acc:MGI:3 045 960]
Usp541.72E-13−0.2713570.2060.3455.55E-09ubiquitin specific peptidase 54 [Source:MGI Symbol;Acc:MGI:1 926 037]
Tle42.16E-13−0.31412170.2490.4416.97E-09transducin-like enhancer of split 4 [Source:MGI Symbol;Acc:MGI:104 633]
Dbx22.45E-13−0.25818290.2210.3587.91E-09developing brain homeobox 2 [Source:MGI Symbol;Acc:MGI:107 445]
Btbd92.62E-130.31 317 4530.5080.3468.47E-09BTB (POZ) domain containing 9 [Source:MGI Symbol;Acc:MGI:1 916 625]
Fam214a2.90E-13−0.27770730.2130.3549.37E-09NA
Cachd13.12E-130.33 962 3370.4770.3271.01E-08cache domain containing 1 [Source:MGI Symbol;Acc:MGI:2 444 177]
Fnbp13.31E-13−0.29308250.6360.7341.07E-08formin binding protein 1 [Source:MGI Symbol;Acc:MGI:109 606]
Pid13.41E-13−0.31881280.3470.5121.10E-08phosphotyrosine interaction domain containing 1 [Source:MGI Symbol;Acc:MGI:2 138 391]
Id43.49E-130.36 185 5740.4620.2821.13E-08inhibitor of DNA binding 4 [Source:MGI Symbol;Acc:MGI:99 414]
Chst113.52E-130.31 210 5770.4120.2621.14E-08carbohydrate sulfotransferase 11 [Source:MGI Symbol;Acc:MGI:1 927 166]
Atl24.05E-13−0.26108010.3040.4241.31E-08atlastin GTPase 2 [Source:MGI Symbol;Acc:MGI:1 929 492]
Dpf35.01E-13−0.29100540.2650.4261.62E-08double PHD fingers 3 [Source:MGI Symbol;Acc:MGI:1 917 377]
Arrb15.31E-13−0.25373280.180.3391.71E-08arrestin, beta 1 [Source:MGI Symbol;Acc:MGI:99 473]
Fam155a5.80E-130.69 052 6150.4840.2871.87E-08NA
Zfhx47.06E-130.3 268 6590.3560.232.28E-08zinc finger homeodomain 4 [Source:MGI Symbol;Acc:MGI:2 137 668]
Fgf147.06E-130.39 407 1390.8630.7582.28E-08fibroblast growth factor 14 [Source:MGI Symbol;Acc:MGI:109 189]
Hivep37.55E-13−0.32663020.5750.7292.44E-08human immunodeficiency virus type I enhancer binding protein 3 [Source:MGI Symbol;Acc:MGI:106 589]
Fermt28.05E-13−0.29984070.3410.5012.60E-08fermitin family member 2 [Source:MGI Symbol;Acc:MGI:2 385 001]
Rnf2208.48E-13−0.29992290.1020.1932.74E-08ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Rmst1.07E-120.52 794 9370.8030.7583.47E-08rhabdomyosarcoma 2 associated transcript (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 099 806]
Dnm31.48E-120.3 694 3220.490.3064.77E-08dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Gulp11.67E-12−0.27018140.150.2955.38E-08GULP, engulfment adaptor PTB domain containing 1 [Source:MGI Symbol;Acc:MGI:1 920 407]
Prkn1.96E-120.42 415 9410.7350.66.32E-08parkin RBR E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 355 296]
Hivep22.85E-12−0.30008690.4010.5449.21E-08human immunodeficiency virus type I enhancer binding protein 2 [Source:MGI Symbol;Acc:MGI:1 338 076]
Agl2.91E-12−0.25301560.2820.419.40E-08amylo-1,6-glucosidase, 4-alpha-glucanotransferase [Source:MGI Symbol;Acc:MGI:1 924 809]
Astn23.41E-120.43 229 7550.590.5141.10E-07astrotactin 2 [Source:MGI Symbol;Acc:MGI:1 889 277]
Abi13.62E-12−0.26955890.3340.4761.17E-07abl interactor 1 [Source:MGI Symbol;Acc:MGI:104 913]
Enah4.34E-12−0.29490060.5570.6891.40E-07ENAH actin regulator [Source:MGI Symbol;Acc:MGI:108 360]
Tmem1645.37E-12−0.32205140.3560.5141.74E-07transmembrane protein 164 [Source:MGI Symbol;Acc:MGI:2 148 020]
Aco25.41E-12−0.2500020.2950.4341.75E-07aconitase 2, mitochondrial [Source:MGI Symbol;Acc:MGI:87 880]
Dlgap15.65E-12−0.32803280.7250.8471.82E-07DLG associated protein 1 [Source:MGI Symbol;Acc:MGI:1 346 065]
Cpeb35.85E-12−0.27077850.4380.5531.89E-07cytoplasmic polyadenylation element binding protein 3 [Source:MGI Symbol;Acc:MGI:2 443 075]
Nfib7.15E-12−0.27996810.740.8212.31E-07nuclear factor I/B [Source:MGI Symbol;Acc:MGI:103 188]
Iqsec28.06E-120.25 033 8210.3360.1962.60E-07IQ motif and Sec7 domain 2 [Source:MGI Symbol;Acc:MGI:3 528 396]
Shisa68.24E-12−0.25758450.10.1592.66E-07shisa family member 6 [Source:MGI Symbol;Acc:MGI:2 685 725]
Nfkb18.60E-120.31 729 2130.4510.3092.78E-07nuclear factor of kappa light polypeptide gene enhancer in B cells 1, p105 [Source:MGI Symbol;Acc:MGI:97 312]
Myo18a9.58E-12−0.26612360.2320.3853.09E-07myosin XVIIIA [Source:MGI Symbol;Acc:MGI:2 667 185]
Ugp21.08E-110.26 792 9520.5160.3723.49E-07UDP-glucose pyrophosphorylase 2 [Source:MGI Symbol;Acc:MGI:2 183 447]
Enpp21.36E-110.30 137 9840.410.2424.40E-07ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
Frmpd11.37E-11−0.27250150.2540.4044.42E-07FERM and PDZ domain containing 1 [Source:MGI Symbol;Acc:MGI:2 446 274]
Ano62.02E-110.28 037 3710.2690.1426.53E-07anoctamin 6 [Source:MGI Symbol;Acc:MGI:2 145 890]
Tcf252.14E-11−0.25243530.4950.6256.92E-07transcription factor 25 (basic helix-loop-helix) [Source:MGI Symbol;Acc:MGI:1 914 105]
Sel1l32.21E-110.25 017 1740.20.1017.13E-07sel-1 suppressor of lin-12-like 3 (C. elegans) [Source:MGI Symbol;Acc:MGI:1 916 941]
Pigk2.24E-11−0.31922570.1080.2577.24E-07phosphatidylinositol glycan anchor biosynthesis, class K [Source:MGI Symbol;Acc:MGI:1 913 863]
Meis22.39E-110.28 700 8230.7220.647.73E-07Meis homeobox 2 [Source:MGI Symbol;Acc:MGI:108 564]
Clmn2.43E-11−0.37419370.3380.5017.85E-07calmin [Source:MGI Symbol;Acc:MGI:2 136 957]
Pard3b2.59E-110.36 304 2810.6770.578.37E-07par-3 family cell polarity regulator beta [Source:MGI Symbol;Acc:MGI:1 919 301]
Zfhx32.74E-110.44 295 7930.5180.3638.84E-07zinc finger homeobox 3 [Source:MGI Symbol;Acc:MGI:99 948]
Bcan2.75E-11−0.25547580.5570.6498.87E-07brevican [Source:MGI Symbol;Acc:MGI:1 096 385]
Acss13.09E-11−0.25673650.2430.3979.98E-07acyl-CoA synthetase short-chain family member 1 [Source:MGI Symbol;Acc:MGI:1 915 988]
Adk3.22E-11−0.28200380.6570.7661.04E-06adenosine kinase [Source:MGI Symbol;Acc:MGI:87 930]
Clasp24.17E-11−0.27344010.5990.6911.35E-06CLIP associating protein 2 [Source:MGI Symbol;Acc:MGI:1 923 749]
Alcam5.04E-11−0.32091160.3640.5191.63E-06activated leukocyte cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 313 266]
Cspp15.14E-110.26 083 5650.4860.3481.66E-06centrosome and spindle pole associated protein 1 [Source:MGI Symbol;Acc:MGI:2 681 832]
Plpp35.22E-11−0.3177850.6960.7881.68E-06phospholipid phosphatase 3 [Source:MGI Symbol;Acc:MGI:1 915 166]
Megf105.80E-11−0.25197490.280.4191.87E-06multiple EGF-like-domains 10 [Source:MGI Symbol;Acc:MGI:2 685 177]
Gphn6.45E-11−0.26894960.8740.9112.08E-06gephyrin [Source:MGI Symbol;Acc:MGI:109 602]
Fus6.61E-110.25 396 1730.5160.3762.13E-06fused in sarcoma [Source:MGI Symbol;Acc:MGI:1 353 633]
Wwc18.27E-11−0.26592630.4120.5382.67E-06WW, C2 and coiled-coil domain containing 1 [Source:MGI Symbol;Acc:MGI:2 388 637]
Lrrc4c8.56E-11−0.44154730.8940.9012.76E-06leucine rich repeat containing 4C [Source:MGI Symbol;Acc:MGI:2 442 636]
Rorb1.46E-10−0.32772560.7460.8574.71E-06RAR-related orphan receptor beta [Source:MGI Symbol;Acc:MGI:1 343 464]
Sgip11.72E-10−0.28270460.6250.7265.55E-06SH3-domain GRB2-like (endophilin) interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 920 344]
Gm487421.76E-10−0.25864250.230.3675.69E-06predicted gene, 48 742 [Source:MGI Symbol;Acc:MGI:6 098 410]
Ttc282.09E-100.28 895 9350.4970.3736.76E-06tetratricopeptide repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 140 873]
Igsf112.14E-100.28 984 7290.4920.3536.90E-06immunoglobulin superfamily, member 11 [Source:MGI Symbol;Acc:MGI:2 388 477]
Fbxl72.42E-100.30 362 5530.2150.0827.83E-06F-box and leucine-rich repeat protein 7 [Source:MGI Symbol;Acc:MGI:3 052 506]
Lama22.60E-10−0.31068160.6160.7188.39E-06laminin, alpha 2 [Source:MGI Symbol;Acc:MGI:99 912]
Camk2n12.74E-10−0.27324110.2690.4598.84E-06calcium/calmodulin-dependent protein kinase II inhibitor 1 [Source:MGI Symbol;Acc:MGI:1 913 509]
Spire13.03E-10−0.26781420.5510.6729.78E-06spire type actin nucleation factor 1 [Source:MGI Symbol;Acc:MGI:1 915 416]
Thrb3.43E-10−0.26550690.6160.6761.11E-05thyroid hormone receptor beta [Source:MGI Symbol;Acc:MGI:98 743]
Grid13.76E-10−0.27218740.2750.4451.21E-05glutamate receptor, ionotropic, delta 1 [Source:MGI Symbol;Acc:MGI:95 812]
Dst3.99E-100.33 094 5720.6880.6351.29E-05dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Lhfpl35.06E-100.52 784 1760.4380.2881.63E-05lipoma HMGIC fusion partner-like 3 [Source:MGI Symbol;Acc:MGI:1 925 076]
Lrmda5.92E-10−0.33622630.2190.361.91E-05leucine rich melanocyte differentiation associated [Source:MGI Symbol;Acc:MGI:1 923 883]
Slc9a91.26E-090.27 808 9960.4880.3734.08E-05solute carrier family 9 (sodium/hydrogen exchanger), member 9 [Source:MGI Symbol;Acc:MGI:2 679 732]
Mapk101.51E-09−0.26380080.5680.6624.87E-05mitogen-activated protein kinase 10 [Source:MGI Symbol;Acc:MGI:1 346 863]
B3galt12.00E-09−0.26546690.8610.9196.45E-05UDP-Gal:betaGlcNAc beta 1,3-galactosyltransferase, polypeptide 1 [Source:MGI Symbol;Acc:MGI:1 349 403]
Ddah12.19E-09−0.25509760.2170.3817.07E-05dimethylarginine dimethylaminohydrolase 1 [Source:MGI Symbol;Acc:MGI:1 916 469]
Smyd33.06E-090.30 146 9810.5120.3619.89E-05SET and MYND domain containing 3 [Source:MGI Symbol;Acc:MGI:1 916 976]
Pde4d3.57E-090.49 104 4540.8160.7410.00 011 538phosphodiesterase 4D, cAMP specific [Source:MGI Symbol;Acc:MGI:99 555]
Prdx63.89E-090.28 389 0770.640.5270.00 012 564peroxiredoxin 6 [Source:MGI Symbol;Acc:MGI:894 320]
Ankrd283.94E-090.27 308 2010.4790.3550.0 001 273ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Map4k44.15E-090.25 600 6240.5180.4170.00 013 397mitogen-activated protein kinase kinase kinase kinase 4 [Source:MGI Symbol;Acc:MGI:1 349 394]
Acss34.20E-090.26 918 8530.3210.1890.00 013 546acyl-CoA synthetase short-chain family member 3 [Source:MGI Symbol;Acc:MGI:2 685 720]
Dock74.82E-090.27 946 9240.4080.2920.00 015 556dedicator of cytokinesis 7 [Source:MGI Symbol;Acc:MGI:1 914 549]
Bcl28.22E-090.25 489 8510.4080.3380.00 026 533B cell leukemia/lymphoma 2 [Source:MGI Symbol;Acc:MGI:88 138]
4930488L21Rik1.21E-08−0.31219660.1430.2830.00 039 211RIKEN cDNA 4930488L21 gene [Source:MGI Symbol;Acc:MGI:1 923 059]
Fhit2.18E-080.40 458 5420.5530.3880.00 070 321fragile histidine triad gene [Source:MGI Symbol;Acc:MGI:1 277 947]
Ank2.18E-080.32 658 1310.5120.4220.00 070 377progressive ankylosis [Source:MGI Symbol;Acc:MGI:3 045 421]
Fam13c3.14E-08−0.25229780.150.2780.00 101 426family with sequence similarity 13, member C [Source:MGI Symbol;Acc:MGI:1 918 971]
Thsd7a3.44E-080.31 348 4940.4510.3030.00 111 155thrombospondin, type I, domain containing 7A [Source:MGI Symbol;Acc:MGI:2 685 683]
Epha54.54E-080.30 165 5980.5420.3820.00 146 634Eph receptor A5 [Source:MGI Symbol;Acc:MGI:99 654]
Phactr15.31E-08−0.27994040.3320.4980.00 171 272phosphatase and actin regulator 1 [Source:MGI Symbol;Acc:MGI:2 659 021]
Inpp4b9.18E-080.25 348 1230.2650.1510.00 296 391inositol polyphosphate-4-phosphatase, type II [Source:MGI Symbol;Acc:MGI:2 158 925]
Table 2.

Differentially upregulated genes (P value < 0.005) in AG2 in comparison with AG1 and AG3

Genep_valavg_log2FCpct.1pct.2p_val_adjdescription
Ablim202.01 268 2050.5920.1420actin-binding LIM protein 2 [Source:MGI Symbol;Acc:MGI:2 385 758]
Gpc50−2.42154350.5230.9780glypican 5 [Source:MGI Symbol;Acc:MGI:1 194 894]
Trpm30−2.77725470.4750.9310transient receptor potential cation channel, subfamily M, member 3 [Source:MGI Symbol;Acc:MGI:2 443 101]
Lsamp5.69E-249−1.48518030.99311.84E-244limbic system-associated membrane protein [Source:MGI Symbol;Acc:MGI:1 261 760]
Plcb16.73E-181−1.7406110.670.9462.17E-176phospholipase C, beta 1 [Source:MGI Symbol;Acc:MGI:97 613]
6330411D24Rik6.01E-1802.09 342 4640.4010.0221.94E-175RIKEN cDNA 6330411D24 gene [Source:MGI Symbol;Acc:MGI:1 917 975]
Kcnd25.20E-170−1.93504750.3730.7061.68E-165potassium voltage-gated channel, Shal-related family, member 2 [Source:MGI Symbol;Acc:MGI:102 663]
Prune22.77E-1681.331 2720.6140.1358.94E-164prune homolog 2 [Source:MGI Symbol;Acc:MGI:1 925 004]
Sorbs21.02E-1671.50 461 4180.6180.1733.30E-163sorbin and SH3 domain containing 2 [Source:MGI Symbol;Acc:MGI:1 924 574]
Kirrel36.70E-158−1.79298880.4010.8792.16E-153kirre like nephrin family adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 914 953]
Gfap7.52E-1541.81 373 9420.6660.2152.43E-149glial fibrillary acidic protein [Source:MGI Symbol;Acc:MGI:95 697]
Mdga24.23E-152−1.30816060.8110.9741.36E-147MAM domain containing glycosylphosphatidylinositol anchor 2 [Source:MGI Symbol;Acc:MGI:2 444 706]
Nrxn12.30E-143−1.27407430.8630.9987.42E-139neurexin I [Source:MGI Symbol;Acc:MGI:1 096 391]
Gm37647.00E-142−1.25984060.7270.9372.26E-137predicted gene 3764 [Source:MGI Symbol;Acc:MGI:3 781 938]
Grik24.07E-1331.35 293 1470.7960.4631.31E-128glutamate receptor, ionotropic, kainate 2 (beta 2) [Source:MGI Symbol;Acc:MGI:95 815]
Cacnb25.58E-1301.4 550 6950.6440.2571.80E-125calcium channel, voltage-dependent, beta 2 subunit [Source:MGI Symbol;Acc:MGI:894 644]
Ccdc1486.30E-1221.04 581 6740.4010.0552.04E-117coiled-coil domain containing 148 [Source:MGI Symbol;Acc:MGI:3 039 583]
Pkp41.87E-1211.16 887 2370.610.2336.05E-117plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Gm122391.17E-119−1.56307290.150.5663.78E-115predicted gene 12 239 [Source:MGI Symbol;Acc:MGI:3 651 547]
Adamtsl11.78E-1181.0 194 3730.3690.0385.76E-114ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
A2m1.89E-1091.16 768 9790.4210.0656.11E-105alpha-2-macroglobulin [Source:MGI Symbol;Acc:MGI:2 449 119]
Rora3.95E-109−1.07252170.9520.9891.28E-104RAR-related orphan receptor alpha [Source:MGI Symbol;Acc:MGI:104 661]
Pcdh94.52E-109−1.08897650.9440.9921.46E-104protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Slc38a16.45E-1081.18 683 5730.6290.2362.08E-103solute carrier family 38, member 1 [Source:MGI Symbol;Acc:MGI:2 145 895]
Cadps3.49E-1011.07 111 9480.6810.3051.13E-96Ca2+-dependent secretion activator [Source:MGI Symbol;Acc:MGI:1 350 922]
Pitpnc15.38E-101−1.20861830.6940.9131.74E-96phosphatidylinositol transfer protein, cytoplasmic 1 [Source:MGI Symbol;Acc:MGI:1 919 045]
Kcnj33.06E-980.90 152 9530.5620.1669.89E-94potassium inwardly-rectifying channel, subfamily J, member 3 [Source:MGI Symbol;Acc:MGI:104 742]
Gm149641.15E-960.76 450 6180.5080.1593.70E-92predicted gene 14 964 [Source:MGI Symbol;Acc:MGI:3 641 621]
Ccdc35.80E-960.76 885 9680.3410.0241.87E-91coiled-coil domain containing 3 [Source:MGI Symbol;Acc:MGI:1 921 436]
Asap31.18E-930.63 349 4210.3430.0273.82E-89ArfGAP with SH3 domain, ankyrin repeat and PH domain 3 [Source:MGI Symbol;Acc:MGI:2 684 986]
Atp1a21.41E-92−0.95126260.7790.9324.56E-88ATPase, Na+/K + transporting, alpha 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 106]
Gm48764.73E-880.82 426 1180.4770.1311.53E-83predicted gene 4876 [Source:MGI Symbol;Acc:MGI:3 647 654]
Car109.87E-88−1.17006910.2520.4793.19E-83carbonic anhydrase 10 [Source:MGI Symbol;Acc:MGI:1 919 855]
Ldb21.61E-860.78 138 8860.4620.1195.19E-82LIM domain binding 2 [Source:MGI Symbol;Acc:MGI:894 670]
Arhgef46.30E-861.03 026 8930.7720.5642.03E-81Rho guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:2 442 507]
Prkag26.94E-850.77 822 6080.4920.1562.24E-80protein kinase, AMP-activated, gamma 2 non-catalytic subunit [Source:MGI Symbol;Acc:MGI:1 336 153]
Col23a18.05E-851.11 579 5670.4690.112.60E-80collagen, type XXIII, alpha 1 [Source:MGI Symbol;Acc:MGI:2 653 243]
Brinp34.08E-84−1.05676250.2670.6981.32E-79bone morphogenetic protein/retinoic acid inducible neural specific 3 [Source:MGI Symbol;Acc:MGI:2 443 035]
Myoc9.22E-830.80 203 1310.2730.0122.98E-78myocilin [Source:MGI Symbol;Acc:MGI:1 202 864]
Pdzrn34.51E-820.69 065 9930.4340.11.46E-77PDZ domain containing RING finger 3 [Source:MGI Symbol;Acc:MGI:1 933 157]
C4b9.92E-820.67 373 8660.4010.0733.20E-77complement component 4B (Chido blood group) [Source:MGI Symbol;Acc:MGI:88 228]
Gm207131.04E-81−1.16710950.1480.713.35E-77predicted gene 20 713 [Source:MGI Symbol;Acc:MGI:5 313 160]
Cadm29.70E-81−0.86774230.8870.9913.13E-76cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:2 442 722]
Cobll11.01E-800.69 941 5610.380.0583.26E-76Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Tmem1087.84E-790.68 764 5550.3250.0482.53E-74transmembrane protein 108 [Source:MGI Symbol;Acc:MGI:1 932 411]
Slc6a111.58E-78−0.95280880.260.5775.11E-74solute carrier family 6 (neurotransmitter transporter, GABA), member 11 [Source:MGI Symbol;Acc:MGI:95 630]
Gria28.90E-78−1.17085270.4010.7652.87E-73glutamate receptor, ionotropic, AMPA2 (alpha 2) [Source:MGI Symbol;Acc:MGI:95 809]
Ptch11.21E-77−1.03795650.1780.5723.91E-73patched 1 [Source:MGI Symbol;Acc:MGI:105 373]
Nhsl12.00E-77−1.00848890.3620.7246.47E-73NHS-like 1 [Source:MGI Symbol;Acc:MGI:106 390]
Cd443.84E-750.61 517 8670.2890.0221.24E-70CD44 antigen [Source:MGI Symbol;Acc:MGI:88 338]
Adgrb38.83E-75−0.93077680.8760.9562.85E-70adhesion G protein-coupled receptor B3 [Source:MGI Symbol;Acc:MGI:2 441 837]
Man1c12.14E-730.63 698 9220.3360.0636.91E-69mannosidase, alpha, class 1C, member 1 [Source:MGI Symbol;Acc:MGI:2 446 214]
Prkca4.62E-710.97 231 7920.80.5611.49E-66protein kinase C, alpha [Source:MGI Symbol;Acc:MGI:97 595]
Sntg21.58E-700.49 453 6240.2820.0155.10E-66syntrophin, gamma 2 [Source:MGI Symbol;Acc:MGI:1 919 541]
Sulf21.19E-690.53 943 0030.2910.0443.85E-65sulfatase 2 [Source:MGI Symbol;Acc:MGI:1 919 293]
Glis32.10E-690.81 574 3810.790.5286.77E-65GLIS family zinc finger 3 [Source:MGI Symbol;Acc:MGI:2 444 289]
Nrp28.88E-690.52 318 1580.3230.0452.87E-64neuropilin 2 [Source:MGI Symbol;Acc:MGI:1 100 492]
Reep17.50E-670.64 992 3470.3430.0692.42E-62receptor accessory protein 1 [Source:MGI Symbol;Acc:MGI:1 098 827]
Slc7a105.38E-65−1.11624910.0650.5521.74E-60solute carrier family 7 (cationic amino acid transporter, y + system), member 10 [Source:MGI Symbol;Acc:MGI:1 858 261]
Pde7b6.13E-65−0.99651790.2730.7011.98E-60phosphodiesterase 7B [Source:MGI Symbol;Acc:MGI:1 352 752]
Ctnna22.42E-631.08 054 9980.8440.6767.81E-59catenin (cadherin associated protein), alpha 2 [Source:MGI Symbol;Acc:MGI:88 275]
Csmd17.81E-630.67 950 1760.5770.3952.52E-58CUB and Sushi multiple domains 1 [Source:MGI Symbol;Acc:MGI:2 137 383]
Sorbs11.00E-620.95 190 3380.8290.6383.24E-58sorbin and SH3 domain containing 1 [Source:MGI Symbol;Acc:MGI:700 014]
Aebp11.73E-620.45 464 3510.2580.0135.59E-58AE binding protein 1 [Source:MGI Symbol;Acc:MGI:1 197 012]
Sema3a1.11E-600.54 359 6090.2520.033.59E-56sema domain, immunoglobulin domain (Ig), short basic domain, secreted, (semaphorin) 3A [Source:MGI Symbol;Acc:MGI:107 558]
Rgs72.21E-60−1.01278830.2430.6427.14E-56regulator of G protein signaling 7 [Source:MGI Symbol;Acc:MGI:1 346 089]
Slc8a15.29E-600.95 401 4560.5210.2471.71E-55solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Synpo25.36E-600.82 634 0960.4970.1651.73E-55synaptopodin 2 [Source:MGI Symbol;Acc:MGI:2 153 070]
Dock47.62E-60−0.79633060.5790.812.46E-55dedicator of cytokinesis 4 [Source:MGI Symbol;Acc:MGI:1 918 006]
C530044C16Rik1.87E-590.4 873 9990.2340.0126.04E-55RIKEN cDNA C530044C16 gene [Source:MGI Symbol;Acc:MGI:2 443 109]
Tagln34.73E-590.61 896 3830.5770.2991.53E-54transgelin 3 [Source:MGI Symbol;Acc:MGI:1 926 784]
Adgrl31.51E-57−0.71364630.7790.8994.88E-53adhesion G protein-coupled receptor L3 [Source:MGI Symbol;Acc:MGI:2 441 950]
Cpne82.52E-560.41 103 0570.2620.0378.13E-52copine VIII [Source:MGI Symbol;Acc:MGI:1 914 121]
Phyhd14.30E-560.6 780 0510.5340.2281.39E-51phytanoyl-CoA dioxygenase domain containing 1 [Source:MGI Symbol;Acc:MGI:3 612 860]
Gria44.97E-56−0.85760140.2060.421.60E-51glutamate receptor, ionotropic, AMPA4 (alpha 4) [Source:MGI Symbol;Acc:MGI:95 811]
Padi28.82E-560.61 810 8460.4230.1282.85E-51peptidyl arginine deiminase, type II [Source:MGI Symbol;Acc:MGI:1 338 892]
Robo21.23E-540.9 155 6120.7870.5693.98E-50roundabout guidance receptor 2 [Source:MGI Symbol;Acc:MGI:1 890 110]
Ccser11.27E-540.80 908 8570.4730.2874.09E-50coiled-coil serine rich 1 [Source:MGI Symbol;Acc:MGI:3 045 354]
St6galnac32.01E-541.53 920 7550.540.1396.49E-50ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Cdh108.08E-54−0.77856710.4450.7362.61E-49cadherin 10 [Source:MGI Symbol;Acc:MGI:107 436]
Dok61.84E-530.70 032 1640.4620.1635.93E-49docking protein 6 [Source:MGI Symbol;Acc:MGI:3 639 495]
Smad63.72E-530.34 957 9810.2470.0341.20E-48SMAD family member 6 [Source:MGI Symbol;Acc:MGI:1 336 883]
Aqp46.40E-530.78 867 0240.7010.4032.07E-48aquaporin 4 [Source:MGI Symbol;Acc:MGI:107 387]
Grm79.42E-510.88 253 3170.4620.2293.04E-46glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Dgki6.91E-500.76 957 4490.5730.2442.23E-45diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Tex111.04E-490.36 512 0030.2150.0123.35E-45testis expressed gene 11 [Source:MGI Symbol;Acc:MGI:1 933 237]
Ahnak1.08E-480.32 270 0590.2340.0273.48E-44AHNAK nucleoprotein (desmoyokin) [Source:MGI Symbol;Acc:MGI:1 316 648]
Trp632.37E-48−0.91803720.0350.3187.64E-44transformation related protein 63 [Source:MGI Symbol;Acc:MGI:1 330 810]
Tnc2.67E-480.37 489 8670.2340.0238.61E-44tenascin C [Source:MGI Symbol;Acc:MGI:101 922]
Reln3.62E-480.6 459 5270.3970.1091.17E-43reelin [Source:MGI Symbol;Acc:MGI:103 022]
Pxdn3.76E-480.4 112 2210.2930.0721.21E-43peroxidasin [Source:MGI Symbol;Acc:MGI:1 916 925]
Atp13a47.34E-48−0.66697550.1450.4862.37E-43ATPase type 13A4 [Source:MGI Symbol;Acc:MGI:1 924 456]
Cacnb49.29E-470.71 396 1130.4840.2383.00E-42calcium channel, voltage-dependent, beta 4 subunit [Source:MGI Symbol;Acc:MGI:103 301]
Adamts92.03E-460.68 554 0960.4990.2026.57E-42a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 9 [Source:MGI Symbol;Acc:MGI:1 916 320]
Tmtc23.43E-46−0.73294880.2430.5761.11E-41transmembrane and tetratricopeptide repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 914 057]
Limch17.50E-46−0.68115580.3950.6812.42E-41LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Grid21.96E-45−0.66948460.7090.9066.34E-41glutamate receptor, ionotropic, delta 2 [Source:MGI Symbol;Acc:MGI:95 813]
Cadm12.29E-45−0.80658970.5490.8357.40E-41cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:1 889 272]
Sema6a1.15E-440.44 205 1310.3150.0743.73E-40sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
Ggta13.51E-440.29 853 8780.1930.0181.13E-39glycoprotein galactosyltransferase alpha 1, 3 [Source:MGI Symbol;Acc:MGI:95 704]
Npas35.45E-44−0.57127180.9440.9811.76E-39neuronal PAS domain protein 3 [Source:MGI Symbol;Acc:MGI:1 351 610]
Garnl37.71E-440.42 029 5370.3060.0932.49E-39GTPase activating RANGAP domain-like 3 [Source:MGI Symbol;Acc:MGI:2 139 309]
Kcnma11.92E-43−0.78100460.310.6676.19E-39potassium large conductance calcium-activated channel, subfamily M, alpha member 1 [Source:MGI Symbol;Acc:MGI:99 923]
Auts22.67E-43−0.7000360.7350.9138.63E-39autism susceptibility candidate 2 [Source:MGI Symbol;Acc:MGI:1 919 847]
Fmn12.69E-430.79 828 6930.4270.1988.69E-39formin 1 [Source:MGI Symbol;Acc:MGI:101 815]
Disp32.97E-430.4 166 9970.2520.0799.59E-39dispatched RND transporter family member 3 [Source:MGI Symbol;Acc:MGI:2 444 403]
Grin3a4.31E-430.59 174 3050.3860.1361.39E-38glutamate receptor ionotropic, NMDA3A [Source:MGI Symbol;Acc:MGI:1 933 206]
Sema6d8.82E-430.98 719 6660.7110.5332.85E-38sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6D [Source:MGI Symbol;Acc:MGI:2 387 661]
Pcdh71.43E-42−0.62898410.7350.8744.62E-38protocadherin 7 [Source:MGI Symbol;Acc:MGI:1 860 487]
Ank21.64E-420.95 150 8240.9390.9555.30E-38ankyrin 2, brain [Source:MGI Symbol;Acc:MGI:88 025]
Mast41.87E-41−0.67183640.440.7166.04E-37microtubule associated serine/threonine kinase family member 4 [Source:MGI Symbol;Acc:MGI:1 918 885]
Slc4a42.81E-41−0.55013950.8520.9199.08E-37solute carrier family 4 (anion exchanger), member 4 [Source:MGI Symbol;Acc:MGI:1 927 555]
Ano15.02E-410.46 720 2610.2150.0031.62E-36anoctamin 1, calcium activated chloride channel [Source:MGI Symbol;Acc:MGI:2 142 149]
Cmya58.05E-410.45 054 9590.3410.0972.60E-36cardiomyopathy associated 5 [Source:MGI Symbol;Acc:MGI:1 923 719]
Dner1.62E-400.46 188 8890.3990.1765.22E-36delta/notch-like EGF repeat containing [Source:MGI Symbol;Acc:MGI:2 152 889]
Gpld12.60E-40−0.63787620.080.3858.38E-36glycosylphosphatidylinositol specific phospholipase D1 [Source:MGI Symbol;Acc:MGI:106 604]
Negr12.65E-40−0.69709820.620.8528.56E-36neuronal growth regulator 1 [Source:MGI Symbol;Acc:MGI:2 444 846]
Anxa21.10E-390.27 925 3720.1760.0123.54E-35annexin A2 [Source:MGI Symbol;Acc:MGI:88 246]
Vav32.04E-39−0.6866090.0910.4396.58E-35vav 3 oncogene [Source:MGI Symbol;Acc:MGI:1 888 518]
Airn2.14E-390.4 276 2380.2320.0576.90E-35antisense Igf2r RNA [Source:MGI Symbol;Acc:MGI:1 353 471]
Mgat4a2.28E-390.32 616 9760.2170.0397.37E-35mannoside acetylglucosaminyltransferase 4, isoenzyme A [Source:MGI Symbol;Acc:MGI:2 662 992]
Enox14.40E-390.73 574 6870.4990.2741.42E-34ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Frmd4a6.76E-39−0.75556080.7350.9292.18E-34FERM domain containing 4A [Source:MGI Symbol;Acc:MGI:1 919 850]
Eps87.63E-39−0.59955040.2190.5232.46E-34epidermal growth factor receptor pathway substrate 8 [Source:MGI Symbol;Acc:MGI:104 684]
Gm106358.27E-390.4 519 9270.2190.0222.67E-34predicted gene 10 635 [Source:MGI Symbol;Acc:MGI:3 641 740]
Atoh89.59E-390.28 185 6110.1650.0083.10E-34atonal bHLH transcription factor 8 [Source:MGI Symbol;Acc:MGI:1 918 343]
Slc16a23.09E-380.31 372 7040.2280.0519.98E-34solute carrier family 16 (monocarboxylic acid transporters), member 2 [Source:MGI Symbol;Acc:MGI:1 203 732]
Tab28.33E-380.49 912 7840.5210.2572.69E-33TGF-beta activated kinase 1/MAP3K7 binding protein 2 [Source:MGI Symbol;Acc:MGI:1 915 902]
Gm110999.08E-380.33 560 9310.1560.0072.93E-33predicted gene 11 099 [Source:MGI Symbol;Acc:MGI:3 779 335]
Itih39.39E-38−0.61596580.0740.3323.03E-33inter-alpha trypsin inhibitor, heavy chain 3 [Source:MGI Symbol;Acc:MGI:96 620]
P3h21.14E-360.29 550 0610.1780.0183.69E-32prolyl 3-hydroxylase 2 [Source:MGI Symbol;Acc:MGI:2 146 663]
Cables11.22E-36−0.5880480.1450.4593.95E-32CDK5 and Abl enzyme substrate 1 [Source:MGI Symbol;Acc:MGI:1 927 065]
4930402H24Rik1.48E-360.65 012 5090.8550.8344.78E-32NA
Syne11.85E-36−0.55320050.7480.8785.97E-32spectrin repeat containing, nuclear envelope 1 [Source:MGI Symbol;Acc:MGI:1 927 152]
Grm33.44E-36−0.89460450.3340.5831.11E-31glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Eya44.53E-360.43 761 3450.310.1021.46E-31EYA transcriptional coactivator and phosphatase 4 [Source:MGI Symbol;Acc:MGI:1 337 104]
Mamdc23.19E-350.27 013 5470.1560.0071.03E-30MAM domain containing 2 [Source:MGI Symbol;Acc:MGI:1 918 988]
Slc1a24.34E-35−0.55237630.9670.9981.40E-30solute carrier family 1 (glial high affinity glutamate transporter), member 2 [Source:MGI Symbol;Acc:MGI:101 931]
Nxn5.99E-350.62 688 2070.6510.4271.93E-30nucleoredoxin [Source:MGI Symbol;Acc:MGI:109 331]
Phactr36.21E-35−0.57997520.1760.5162.01E-30phosphatase and actin regulator 3 [Source:MGI Symbol;Acc:MGI:1 921 439]
Ccdc85a1.62E-34−0.62650680.1870.5195.22E-30coiled-coil domain containing 85A [Source:MGI Symbol;Acc:MGI:2 445 069]
Ndrg24.31E-34−0.49506960.5790.7271.39E-29N-myc downstream regulated gene 2 [Source:MGI Symbol;Acc:MGI:1 352 498]
Htra15.00E-34−0.57374980.3770.6611.61E-29HtrA serine peptidase 1 [Source:MGI Symbol;Acc:MGI:1 929 076]
St3gal48.55E-34−0.58873510.2650.5412.76E-29ST3 beta-galactoside alpha-2,3-sialyltransferase 4 [Source:MGI Symbol;Acc:MGI:1 316 743]
Tmem132b1.11E-330.31 405 0380.2650.0813.59E-29transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Nav31.86E-33−0.60843310.3170.5146.00E-29neuron navigator 3 [Source:MGI Symbol;Acc:MGI:2 183 703]
Atp2b42.16E-330.32 348 1480.2650.0816.97E-29ATPase, Ca++ transporting, plasma membrane 4 [Source:MGI Symbol;Acc:MGI:88 111]
Met2.35E-330.29 645 2570.1630.0057.60E-29met proto-oncogene [Source:MGI Symbol;Acc:MGI:96 969]
Flnc7.50E-330.27 142 0560.1410.012.42E-28filamin C, gamma [Source:MGI Symbol;Acc:MGI:95 557]
Fat31.86E-32−0.54469370.5360.6686.01E-28FAT atypical cadherin 3 [Source:MGI Symbol;Acc:MGI:2 444 314]
Id32.99E-320.44 213 5360.3820.1389.65E-28inhibitor of DNA binding 3 [Source:MGI Symbol;Acc:MGI:96 398]
Acsbg13.38E-32−0.51663020.3750.5931.09E-27acyl-CoA synthetase bubblegum family member 1 [Source:MGI Symbol;Acc:MGI:2 385 656]
Ptprg5.17E-32−0.54858780.4790.6311.67E-27NA
Tenm46.03E-32−0.49947230.2080.4141.95E-27teneurin transmembrane protein 4 [Source:MGI Symbol;Acc:MGI:2 447 063]
Slc6a16.17E-32−0.46255770.390.5951.99E-27solute carrier family 6 (neurotransmitter transporter, GABA), member 1 [Source:MGI Symbol;Acc:MGI:95 627]
Fgfr37.78E-32−0.46368980.4160.6252.51E-27fibroblast growth factor receptor 3 [Source:MGI Symbol;Acc:MGI:95 524]
Kcnip32.19E-31−0.50406720.1320.3697.08E-27Kv channel interacting protein 3, calsenilin [Source:MGI Symbol;Acc:MGI:1 929 258]
Ntng12.53E-310.47 422 6670.2470.0618.18E-27netrin G1 [Source:MGI Symbol;Acc:MGI:1 934 028]
Tmc74.94E-31−0.49709030.0910.3361.59E-26transmembrane channel-like gene family 7 [Source:MGI Symbol;Acc:MGI:2 443 317]
Tafa15.30E-31−0.65893280.1080.3081.71E-26TAFA chemokine like family member 1 [Source:MGI Symbol;Acc:MGI:2 443 695]
Frmpd46.58E-310.36 641 1150.2860.1362.12E-26FERM and PDZ domain containing 4 [Source:MGI Symbol;Acc:MGI:3 042 378]
Cep85l2.02E-30−0.48200370.3340.5686.52E-26centrosomal protein 85-like [Source:MGI Symbol;Acc:MGI:3 642 684]
Prickle22.16E-300.63 320 0450.610.3696.96E-26prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
C33.37E-300.26 171 3210.1480.0121.09E-25complement component 3 [Source:MGI Symbol;Acc:MGI:88 227]
Pdgfd4.30E-300.64 872 8860.6070.3891.39E-25platelet-derived growth factor, D polypeptide [Source:MGI Symbol;Acc:MGI:1 919 035]
Miat4.48E-300.28 579 9650.210.0561.45E-25myocardial infarction associated transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 886]
Kalrn4.56E-30−0.55721350.2490.5561.47E-25kalirin, RhoGEF kinase [Source:MGI Symbol;Acc:MGI:2 685 385]
Klhl294.79E-300.34 632 9080.330.1281.54E-25kelch-like 29 [Source:MGI Symbol;Acc:MGI:2 683 857]
Osbpl35.99E-300.32 270 9410.2190.0571.93E-25oxysterol binding protein-like 3 [Source:MGI Symbol;Acc:MGI:1 918 970]
Atp1b22.35E-29−0.48022990.4210.5317.59E-25ATPase, Na+/K + transporting, beta 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 109]
Dgkb2.41E-29−0.54566150.7460.8967.79E-25diacylglycerol kinase, beta [Source:MGI Symbol;Acc:MGI:2 442 474]
2610307P16Rik2.50E-290.44 161 5380.2650.0658.07E-25RIKEN cDNA 2610307P16 gene [Source:MGI Symbol;Acc:MGI:1 919 768]
Dock52.53E-29−0.42793390.0980.2718.17E-25dedicator of cytokinesis 5 [Source:MGI Symbol;Acc:MGI:2 652 871]
Slco1c12.73E-29−0.58344170.150.4538.80E-25solute carrier organic anion transporter family, member 1c1 [Source:MGI Symbol;Acc:MGI:1 889 679]
Grin2c4.74E-29−0.51409050.1040.4211.53E-24glutamate receptor, ionotropic, NMDA2C (epsilon 3) [Source:MGI Symbol;Acc:MGI:95 822]
Plekha64.74E-290.32 322 5750.2620.081.53E-24pleckstrin homology domain containing, family A member 6 [Source:MGI Symbol;Acc:MGI:2 388 662]
Luzp24.80E-29−1.1363530.6490.8881.55E-24leucine zipper protein 2 [Source:MGI Symbol;Acc:MGI:1 889 615]
Apbb1ip8.64E-290.319 4610.1950.0212.79E-24amyloid beta (A4) precursor protein-binding, family B, member 1 interacting protein [Source:MGI Symbol;Acc:MGI:1 861 354]
Tnik1.81E-28−0.45286520.8480.9195.84E-24TRAF2 and NCK interacting kinase [Source:MGI Symbol;Acc:MGI:1 916 264]
Grk31.89E-28−0.48679820.2730.5626.11E-24G protein-coupled receptor kinase 3 [Source:MGI Symbol;Acc:MGI:87 941]
Nwd12.12E-28−0.49137720.4580.6956.83E-24NACHT and WD repeat domain containing 1 [Source:MGI Symbol;Acc:MGI:2 442 268]
Shroom33.36E-28−0.47205920.3120.4451.08E-23shroom family member 3 [Source:MGI Symbol;Acc:MGI:1 351 655]
Hip14.84E-28−0.48733460.2210.4791.56E-23huntingtin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 099 804]
Armc21.06E-270.35 458 0490.260.0813.43E-23armadillo repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 916 449]
Plscr41.14E-270.36 422 8220.3150.1023.67E-23phospholipid scramblase 4 [Source:MGI Symbol;Acc:MGI:2 143 267]
Cep1123.75E-270.31 022 3890.2580.081.21E-22centrosomal protein 112 [Source:MGI Symbol;Acc:MGI:1 923 673]
Ahcyl14.67E-27−0.46130040.4380.6641.51E-22S-adenosylhomocysteine hydrolase-like 1 [Source:MGI Symbol;Acc:MGI:2 385 184]
Mertk5.96E-27−0.62954020.5770.7941.92E-22MER proto-oncogene tyrosine kinase [Source:MGI Symbol;Acc:MGI:96 965]
Tulp47.54E-270.48 002 0980.590.3922.43E-22tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Tspan79.19E-27−0.60251660.5570.7832.97E-22tetraspanin 7 [Source:MGI Symbol;Acc:MGI:1 298 407]
Xylt11.90E-26−0.51734750.2230.5016.13E-22xylosyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 451 073]
St3gal62.80E-260.26 891 0790.1890.0429.05E-22ST3 beta-galactoside alpha-2,3-sialyltransferase 6 [Source:MGI Symbol;Acc:MGI:1 888 707]
Myo163.60E-260.3 868 6270.2750.0941.16E-21myosin XVI [Source:MGI Symbol;Acc:MGI:2 685 951]
Ptprj3.83E-26−0.51797520.2410.4251.24E-21protein tyrosine phosphatase, receptor type, J [Source:MGI Symbol;Acc:MGI:104 574]
Npas23.91E-26−0.47452730.3490.5611.26E-21neuronal PAS domain protein 2 [Source:MGI Symbol;Acc:MGI:109 232]
Abcc45.32E-260.25 504 1830.2280.0651.72E-21ATP-binding cassette, sub-family C (CFTR/MRP), member 4 [Source:MGI Symbol;Acc:MGI:2 443 111]
Ablim16.53E-26−0.4412370.260.5082.11E-21actin-binding LIM protein 1 [Source:MGI Symbol;Acc:MGI:1 194 500]
Pamr19.42E-260.31 300 2710.2430.083.04E-21peptidase domain containing associated with muscle regeneration 1 [Source:MGI Symbol;Acc:MGI:2 445 082]
Pde4b2.15E-25−0.61258360.3950.5646.93E-21phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Rfx23.58E-250.25 164 9040.2060.0531.16E-20regulatory factor X, 2 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:106 583]
Gjb63.65E-25−0.39927990.1060.3411.18E-20gap junction protein, beta 6 [Source:MGI Symbol;Acc:MGI:107 588]
Rapgef46.94E-250.3 878 8060.2690.1282.24E-20Rap guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:1 917 723]
Rps6ka57.23E-250.39 342 2340.4190.2182.34E-20ribosomal protein S6 kinase, polypeptide 5 [Source:MGI Symbol;Acc:MGI:1 920 336]
Slc6a98.63E-25−0.34170660.1080.2652.78E-20solute carrier family 6 (neurotransmitter transporter, glycine), member 9 [Source:MGI Symbol;Acc:MGI:95 760]
Gm351881.74E-24−0.51985970.3930.6425.61E-20predicted gene, 35 188 [Source:MGI Symbol;Acc:MGI:5 594 347]
Wdr171.84E-24−0.67369960.7160.8425.93E-20WD repeat domain 17 [Source:MGI Symbol;Acc:MGI:1 924 662]
Mgat4c1.93E-24−0.38743970.5080.5526.23E-20MGAT4 family, member C [Source:MGI Symbol;Acc:MGI:1 914 819]
Il6st1.96E-240.30 887 3980.2930.1146.31E-20interleukin 6 signal transducer [Source:MGI Symbol;Acc:MGI:96 560]
Fry2.03E-24−0.33083650.6010.6616.56E-20FRY microtubule binding protein [Source:MGI Symbol;Acc:MGI:2 443 895]
Ddr12.06E-240.34 612 2530.3190.1436.65E-20discoidin domain receptor family, member 1 [Source:MGI Symbol;Acc:MGI:99 216]
9530026P05Rik2.30E-240.6 724 1210.4510.2387.43E-20RIKEN cDNA 9530026P05 gene [Source:MGI Symbol;Acc:MGI:1 924 659]
Plcl12.96E-24−0.54617790.390.6029.55E-20phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Thbs43.13E-240.26 018 0990.1260.0181.01E-19thrombospondin 4 [Source:MGI Symbol;Acc:MGI:1 101 779]
Wasf34.11E-24−0.40801660.3230.5411.33E-19WASP family, member 3 [Source:MGI Symbol;Acc:MGI:2 658 986]
Bmpr1b4.19E-240.51 910 0950.7770.6711.35E-19bone morphogenetic protein receptor, type 1B [Source:MGI Symbol;Acc:MGI:107 191]
Abcg24.64E-240.2 696 1690.180.0391.50E-19ATP binding cassette subfamily G member 2 (Junior blood group) [Source:MGI Symbol;Acc:MGI:1 347 061]
Pacrg5.76E-240.51 573 1970.540.3051.86E-19PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Nav26.65E-240.50 495 9320.6720.5262.15E-19neuron navigator 2 [Source:MGI Symbol;Acc:MGI:2 183 691]
Adcy86.82E-240.49 769 6870.4210.2382.20E-19adenylate cyclase 8 [Source:MGI Symbol;Acc:MGI:1 341 110]
Arhgef287.54E-24−0.34171580.3360.4392.43E-19Rho guanine nucleotide exchange factor (GEF) 28 [Source:MGI Symbol;Acc:MGI:1 346 016]
Phka18.43E-24−0.49889370.4710.6452.72E-19phosphorylase kinase alpha 1 [Source:MGI Symbol;Acc:MGI:97 576]
Sorcs21.49E-23−0.40460820.1020.3424.82E-19sortilin-related VPS10 domain containing receptor 2 [Source:MGI Symbol;Acc:MGI:1 932 289]
Fgfr22.62E-23−0.49287160.6960.8268.45E-19fibroblast growth factor receptor 2 [Source:MGI Symbol;Acc:MGI:95 523]
Vegfa2.66E-23−0.44432130.3230.5338.58E-19vascular endothelial growth factor A [Source:MGI Symbol;Acc:MGI:103 178]
Phlpp12.95E-23−0.4415010.670.8059.52E-19PH domain and leucine rich repeat protein phosphatase 1 [Source:MGI Symbol;Acc:MGI:2 138 327]
Agbl43.41E-230.31 829 1360.280.1561.10E-18ATP/GTP binding protein-like 4 [Source:MGI Symbol;Acc:MGI:1 918 244]
Chd93.90E-23−0.39624570.6310.7681.26E-18chromodomain helicase DNA binding protein 9 [Source:MGI Symbol;Acc:MGI:1 924 001]
Syt75.17E-230.29 056 6340.2560.1091.67E-18synaptotagmin VII [Source:MGI Symbol;Acc:MGI:1 859 545]
Pgm55.43E-230.36 064 8080.2080.0371.75E-18phosphoglucomutase 5 [Source:MGI Symbol;Acc:MGI:1 925 668]
Nrcam7.62E-23−0.42771690.6550.8222.46E-18neuronal cell adhesion molecule [Source:MGI Symbol;Acc:MGI:104 750]
Esrrg1.51E-22−0.37881910.3580.4814.87E-18estrogen-related receptor gamma [Source:MGI Symbol;Acc:MGI:1 347 056]
Ski2.23E-220.36 561 5220.3560.1767.19E-18ski sarcoma viral oncogene homolog (avian) [Source:MGI Symbol;Acc:MGI:98 310]
Lrrc93.59E-220.25 188 7780.230.0741.16E-17leucine rich repeat containing 9 [Source:MGI Symbol;Acc:MGI:1 925 507]
Kmt2c4.36E-22−0.40842180.5030.6461.41E-17lysine (K)-specific methyltransferase 2C [Source:MGI Symbol;Acc:MGI:2 444 959]
Cdk175.13E-220.31 776 5450.3640.1951.66E-17cyclin-dependent kinase 17 [Source:MGI Symbol;Acc:MGI:97 517]
Bmp65.80E-220.30 526 8880.1890.0451.87E-17bone morphogenetic protein 6 [Source:MGI Symbol;Acc:MGI:88 182]
Mical26.40E-22−0.40585430.4530.6382.07E-17microtubule associated monooxygenase, calponin and LIM domain containing 2 [Source:MGI Symbol;Acc:MGI:2 444 947]
Shc36.90E-22−0.39790530.1320.3742.23E-17src homology 2 domain-containing transforming protein C3 [Source:MGI Symbol;Acc:MGI:106 179]
Nim1k9.23E-22−0.40655110.1890.4062.98E-17NIM1 serine/threonine protein kinase [Source:MGI Symbol;Acc:MGI:2 442 399]
Egfr1.06E-21−0.44128390.1780.4533.42E-17epidermal growth factor receptor [Source:MGI Symbol;Acc:MGI:95 294]
Ccdc1361.11E-210.34 468 6360.3450.1883.59E-17coiled-coil domain containing 136 [Source:MGI Symbol;Acc:MGI:1 918 128]
9630028H03Rik1.23E-21−0.39854630.0760.2963.96E-17RIKEN cDNA 9630028H03 gene [Source:MGI Symbol;Acc:MGI:2 444 526]
Arhgap61.37E-210.2 759 5590.1670.044.43E-17Rho GTPase activating protein 6 [Source:MGI Symbol;Acc:MGI:1 196 332]
Slc25a211.67E-210.43 983 0650.3670.1365.39E-17solute carrier family 25 (mitochondrial oxodicarboxylate carrier), member 21 [Source:MGI Symbol;Acc:MGI:2 445 059]
Pde10a1.67E-21−0.87998210.1820.3975.39E-17phosphodiesterase 10A [Source:MGI Symbol;Acc:MGI:1 345 143]
Igfbp52.16E-210.35 607 1570.2840.1096.98E-17insulin-like growth factor binding protein 5 [Source:MGI Symbol;Acc:MGI:96 440]
Dmd2.40E-21−0.49480860.6680.8187.75E-17dystrophin, muscular dystrophy [Source:MGI Symbol;Acc:MGI:94 909]
Wwox2.73E-210.661 1160.7310.5318.82E-17WW domain-containing oxidoreductase [Source:MGI Symbol;Acc:MGI:1 931 237]
Flvcr12.88E-210.28 350 7830.180.0589.29E-17feline leukemia virus subgroup C cellular receptor 1 [Source:MGI Symbol;Acc:MGI:2 444 881]
Utrn3.40E-210.56 232 0440.6960.5921.10E-16utrophin [Source:MGI Symbol;Acc:MGI:104 631]
Etv43.67E-21−0.41480610.0260.271.18E-16ets variant 4 [Source:MGI Symbol;Acc:MGI:99 423]
Gabbr24.65E-21−0.48095810.1150.321.50E-16gamma-aminobutyric acid (GABA) B receptor, 2 [Source:MGI Symbol;Acc:MGI:2 386 030]
Tsc22d17.13E-210.30 642 5310.4450.272.30E-16TSC22 domain family, member 1 [Source:MGI Symbol;Acc:MGI:109 127]
Mgat57.30E-210.37 459 7910.5140.3362.36E-16mannoside acetylglucosaminyltransferase 5 [Source:MGI Symbol;Acc:MGI:894 701]
Etnppl8.27E-21−0.4354390.1840.3982.67E-16ethanolamine phosphate phospholyase [Source:MGI Symbol;Acc:MGI:1 919 010]
Kcnj101.83E-20−0.34450520.2150.3515.91E-16potassium inwardly-rectifying channel, subfamily J, member 10 [Source:MGI Symbol;Acc:MGI:1 194 504]
Pbx12.42E-200.45 860 1090.8890.9017.82E-16pre B cell leukemia homeobox 1 [Source:MGI Symbol;Acc:MGI:97 495]
Kif21a2.63E-200.37 637 5380.5920.4158.50E-16kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
F32.75E-20−0.38615180.3950.5368.88E-16coagulation factor III [Source:MGI Symbol;Acc:MGI:88 381]
Itpr24.32E-20−0.38444840.3020.4841.40E-15inositol 1,4,5-triphosphate receptor 2 [Source:MGI Symbol;Acc:MGI:99 418]
Map2k64.93E-20−0.38073380.1610.3731.59E-15mitogen-activated protein kinase kinase 6 [Source:MGI Symbol;Acc:MGI:1 346 870]
Ghr5.27E-20−0.41385010.2930.4861.70E-15growth hormone receptor [Source:MGI Symbol;Acc:MGI:95 708]
Camk1d6.31E-20−0.46280450.4530.6712.04E-15calcium/calmodulin-dependent protein kinase ID [Source:MGI Symbol;Acc:MGI:2 442 190]
Tenm36.32E-200.45 681 2960.7090.5292.04E-15teneurin transmembrane protein 3 [Source:MGI Symbol;Acc:MGI:1 345 183]
Serpine26.56E-20−0.37787130.3120.4892.12E-15serine (or cysteine) peptidase inhibitor, clade E, member 2 [Source:MGI Symbol;Acc:MGI:101 780]
Mpdz8.64E-200.32 366 9020.3250.1642.79E-15multiple PDZ domain crumbs cell polarity complex component [Source:MGI Symbol;Acc:MGI:1 343 489]
Prr168.74E-20−0.38983670.130.3032.82E-15proline rich 16 [Source:MGI Symbol;Acc:MGI:1 918 623]
Sipa1l19.14E-200.31 642 9060.3540.1952.95E-15signal-induced proliferation-associated 1 like 1 [Source:MGI Symbol;Acc:MGI:2 443 679]
9630014M24Rik1.01E-19−0.36049980.0480.2683.25E-15RIKEN cDNA 9630014M24 gene [Source:MGI Symbol;Acc:MGI:3 588 234]
Pcdh11x1.06E-19−0.43014620.2060.4183.43E-15protocadherin 11 X-linked [Source:MGI Symbol;Acc:MGI:2 442 849]
Daam21.24E-19−0.40299570.380.5794.01E-15dishevelled associated activator of morphogenesis 2 [Source:MGI Symbol;Acc:MGI:1 923 691]
Myo5a2.01E-190.31 211 7670.3510.2186.49E-15myosin VA [Source:MGI Symbol;Acc:MGI:105 976]
Ctnnd22.21E-19−0.33544240.9590.9797.13E-15catenin (cadherin associated protein), delta 2 [Source:MGI Symbol;Acc:MGI:1 195 966]
Nkain22.91E-191.07 747 9260.6940.4659.39E-15Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Tprkb5.34E-190.41 617 8930.540.3671.72E-14Tp53rk binding protein [Source:MGI Symbol;Acc:MGI:1 917 036]
St6galnac55.81E-19−0.46329760.050.2511.87E-14ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 5 [Source:MGI Symbol;Acc:MGI:1 349 471]
Wnk26.61E-190.32 581 3630.560.452.14E-14WNK lysine deficient protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 922 857]
Hipk21.04E-18−0.36330730.330.523.34E-14homeodomain interacting protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 314 872]
Paqr81.23E-18−0.4099550.5340.683.96E-14progestin and adipoQ receptor family member VIII [Source:MGI Symbol;Acc:MGI:1 921 479]
Csmd31.59E-18−0.38243580.3170.4425.14E-14CUB and Sushi multiple domains 3 [Source:MGI Symbol;Acc:MGI:2 386 403]
Tril1.66E-18−0.29567320.1130.2585.36E-14TLR4 interactor with leucine-rich repeats [Source:MGI Symbol;Acc:MGI:1 914 123]
Ttc31.97E-180.33 617 4860.720.6146.34E-14tetratricopeptide repeat domain 3 [Source:MGI Symbol;Acc:MGI:1 276 539]
Syn22.93E-18−0.36464740.3770.5119.45E-14synapsin II [Source:MGI Symbol;Acc:MGI:103 020]
Zfp4623.48E-180.41 639 7750.5310.3211.12E-13zinc finger protein 462 [Source:MGI Symbol;Acc:MGI:107 690]
Etv54.64E-18−0.31365220.0980.2871.50E-13ets variant 5 [Source:MGI Symbol;Acc:MGI:1 096 867]
Hif1a4.84E-18−0.2855130.1240.2641.56E-13hypoxia inducible factor 1, alpha subunit [Source:MGI Symbol;Acc:MGI:106 918]
Qk5.84E-18−0.30950920.9050.9521.88E-13NA
Angpt16.03E-180.36 156 7160.3430.1531.95E-13angiopoietin 1 [Source:MGI Symbol;Acc:MGI:108 448]
Ptprz16.17E-18−0.4077510.8130.8971.99E-13protein tyrosine phosphatase, receptor type Z, polypeptide 1 [Source:MGI Symbol;Acc:MGI:97 816]
Pde8b7.34E-18−0.47950910.1930.4292.37E-13phosphodiesterase 8B [Source:MGI Symbol;Acc:MGI:2 443 999]
Paqr68.29E-18−0.25736120.0760.2062.68E-13progestin and adipoQ receptor family member VI [Source:MGI Symbol;Acc:MGI:1 916 207]
Rgs7bp9.33E-18−0.36288870.1540.3423.01E-13regulator of G-protein signalling 7 binding protein [Source:MGI Symbol;Acc:MGI:106 334]
Gm303821.03E-17−0.32001860.0370.1613.32E-13predicted gene, 30 382 [Source:MGI Symbol;Acc:MGI:5 589 541]
Nr3c21.42E-17−0.37639490.4660.6324.59E-13nuclear receptor subfamily 3, group C, member 2 [Source:MGI Symbol;Acc:MGI:99 459]
Gm295141.61E-17−0.31190710.0460.2185.19E-13predicted gene 29 514 [Source:MGI Symbol;Acc:MGI:5 580 220]
Cdh202.29E-17−0.32722130.6230.7157.38E-13cadherin 20 [Source:MGI Symbol;Acc:MGI:1 346 069]
4930545L23Rik2.29E-17−0.31231950.0390.2077.39E-13RIKEN cDNA 4930545L23 gene [Source:MGI Symbol;Acc:MGI:1 926 055]
Tsc22d32.66E-17−0.35317440.1670.3088.58E-13TSC22 domain family, member 3 [Source:MGI Symbol;Acc:MGI:1 196 284]
Mir124-2hg2.83E-17−0.30729330.1110.2879.14E-13Mir124-2 host gene (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 917 691]
Unc5c3.79E-170.51 316 4480.3450.2171.22E-12unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Ralgps23.84E-170.30 587 3090.3470.1761.24E-12Ral GEF with PH domain and SH3 binding motif 2 [Source:MGI Symbol;Acc:MGI:1 925 505]
Naaladl23.86E-170.47 242 1590.5270.3341.25E-12N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Spred13.92E-17−0.35151260.2540.4611.27E-12sprouty protein with EVH-1 domain 1, related sequence [Source:MGI Symbol;Acc:MGI:2 150 016]
Prkce4.64E-170.32 778 0490.5380.3571.50E-12protein kinase C, epsilon [Source:MGI Symbol;Acc:MGI:97 599]
Erbb45.00E-17−0.27353870.5640.561.61E-12erb-b2 receptor tyrosine kinase 4 [Source:MGI Symbol;Acc:MGI:104 771]
Arhgap265.43E-17−0.3746340.3540.5291.75E-12Rho GTPase activating protein 26 [Source:MGI Symbol;Acc:MGI:1 918 552]
Tgfb26.00E-170.27 281 3620.2520.1011.94E-12transforming growth factor, beta 2 [Source:MGI Symbol;Acc:MGI:98 726]
Rfx46.00E-170.50 589 5770.6680.5241.94E-12regulatory factor X, 4 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:1 918 387]
Actr3b6.84E-17−0.30921650.0950.2792.21E-12ARP3 actin-related protein 3B [Source:MGI Symbol;Acc:MGI:2 661 120]
Cacna1c6.97E-170.30 918 3930.2340.1132.25E-12calcium channel, voltage-dependent, L type, alpha 1C subunit [Source:MGI Symbol;Acc:MGI:103 013]
Nrg27.41E-170.40 615 1540.4250.2272.39E-12neuregulin 2 [Source:MGI Symbol;Acc:MGI:1 098 246]
Abcc128.05E-170.27 124 3680.1240.0012.60E-12ATP-binding cassette, sub-family C (CFTR/MRP), member 12 [Source:MGI Symbol;Acc:MGI:2 441 679]
Lhfp1.32E-16−0.44843810.4210.5584.25E-12lipoma HMGIC fusion partner [Source:MGI Symbol;Acc:MGI:1 920 048]
Cdh191.37E-16−0.39954830.4160.6394.42E-12cadherin 19, type 2 [Source:MGI Symbol;Acc:MGI:3 588 198]
Efr3b2.37E-16−0.35896560.2520.4367.66E-12EFR3 homolog B [Source:MGI Symbol;Acc:MGI:2 444 851]
Snrk2.59E-16−0.27634490.130.2768.35E-12SNF related kinase [Source:MGI Symbol;Acc:MGI:108 104]
Nrbp22.67E-160.31 083 0320.3640.1988.61E-12nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Znrf32.68E-16−0.36015180.3490.5418.67E-12zinc and ring finger 3 [Source:MGI Symbol;Acc:MGI:3 039 616]
Slc25a182.73E-16−0.293550.1820.3318.81E-12solute carrier family 25 (mitochondrial carrier), member 18 [Source:MGI Symbol;Acc:MGI:1 919 053]
Frem12.81E-16−0.26884840.0410.1839.07E-12Fras1 related extracellular matrix protein 1 [Source:MGI Symbol;Acc:MGI:2 670 972]
Irak23.22E-16−0.35947760.2840.4621.04E-11interleukin-1 receptor-associated kinase 2 [Source:MGI Symbol;Acc:MGI:2 429 603]
Nnat3.46E-160.49 109 3640.2490.1681.12E-11neuronatin [Source:MGI Symbol;Acc:MGI:104 716]
Robo14.72E-16−0.34446260.3040.4121.52E-11roundabout guidance receptor 1 [Source:MGI Symbol;Acc:MGI:1 274 781]
Macrod15.02E-16−0.27263890.1240.2741.62E-11mono-ADP ribosylhydrolase 1 [Source:MGI Symbol;Acc:MGI:2 147 583]
Tafa56.98E-160.30 683 6790.3950.2362.25E-11TAFA chemokine like family member 5 [Source:MGI Symbol;Acc:MGI:2 146 182]
Hif3a8.85E-16−0.30664720.2280.3992.86E-11hypoxia inducible factor 3, alpha subunit [Source:MGI Symbol;Acc:MGI:1 859 778]
Per31.19E-15−0.27632390.210.3523.83E-11period circadian clock 3 [Source:MGI Symbol;Acc:MGI:1 277 134]
Gm61451.55E-15−0.34107270.4840.6315.01E-11predicted gene 6145 [Source:MGI Symbol;Acc:MGI:3 779 559]
Cdh221.77E-15−0.25025550.0930.1935.71E-11cadherin 22 [Source:MGI Symbol;Acc:MGI:1 341 843]
Itgav2.98E-15−0.30584590.1930.3759.61E-11integrin alpha V [Source:MGI Symbol;Acc:MGI:96 608]
Ripor23.01E-15−0.26244060.0330.1779.73E-11RHO family interacting cell polarization regulator 2 [Source:MGI Symbol;Acc:MGI:2 444 879]
Map1b3.10E-150.33 093 8720.5310.4281.00E-10microtubule-associated protein 1B [Source:MGI Symbol;Acc:MGI:1 306 778]
Stk32a3.37E-150.63 100 5440.410.2261.09E-10serine/threonine kinase 32A [Source:MGI Symbol;Acc:MGI:2 442 403]
Slc7a23.54E-150.38 023 4180.4580.3091.14E-10solute carrier family 7 (cationic amino acid transporter, y + system), member 2 [Source:MGI Symbol;Acc:MGI:99 828]
Pros13.70E-150.26 161 4790.1840.0761.19E-10protein S (alpha) [Source:MGI Symbol;Acc:MGI:1 095 733]
Glul4.09E-15−0.37453610.3930.5971.32E-10glutamate-ammonia ligase (glutamine synthetase) [Source:MGI Symbol;Acc:MGI:95 739]
Washc24.58E-15−0.29666350.20.3591.48E-10WASH complex subunit 2 [Source:MGI Symbol;Acc:MGI:106 463]
Sat14.69E-15−0.32853420.260.4161.52E-10spermidine/spermine N1-acetyl transferase 1 [Source:MGI Symbol;Acc:MGI:98 233]
Man1a5.06E-150.25 671 6970.2170.091.63E-10mannosidase 1, alpha [Source:MGI Symbol;Acc:MGI:104 677]
Cap25.07E-15−0.29239790.1610.3331.64E-10CAP, adenylate cyclase-associated protein, 2 (yeast) [Source:MGI Symbol;Acc:MGI:1 914 502]
Pla2g75.26E-15−0.32651650.4160.5951.70E-10phospholipase A2, group VII (platelet-activating factor acetylhydrolase, plasma) [Source:MGI Symbol;Acc:MGI:1 351 327]
Cdh25.37E-15−0.35713410.4620.6291.73E-10cadherin 2 [Source:MGI Symbol;Acc:MGI:88 355]
Prex28.14E-15−0.42284340.7050.8262.63E-10phosphatidylinositol-3,4,5-trisphosphate-dependent Rac exchange factor 2 [Source:MGI Symbol;Acc:MGI:1 923 385]
Tmcc39.77E-15−0.30733460.4430.5673.16E-10transmembrane and coiled coil domains 3 [Source:MGI Symbol;Acc:MGI:2 442 900]
Spag91.02E-14−0.30034320.5860.6963.28E-10sperm associated antigen 9 [Source:MGI Symbol;Acc:MGI:1 918 084]
Adcy21.06E-140.29 525 0120.5770.4873.41E-10adenylate cyclase 2 [Source:MGI Symbol;Acc:MGI:99 676]
Gli31.10E-14−0.33010320.5420.6923.55E-10GLI-Kruppel family member GLI3 [Source:MGI Symbol;Acc:MGI:95 729]
Hmgn31.10E-14−0.30435120.1410.3243.57E-10high mobility group nucleosomal binding domain 3 [Source:MGI Symbol;Acc:MGI:2 138 069]
Ldlrad41.19E-14−0.31893250.2130.3563.84E-10low density lipoprotein receptor class A domain containing 4 [Source:MGI Symbol;Acc:MGI:1 277 150]
Eps151.28E-14−0.29645940.4620.6064.14E-10epidermal growth factor receptor pathway substrate 15 [Source:MGI Symbol;Acc:MGI:104 583]
Gli21.39E-14−0.32220330.2840.4594.47E-10GLI-Kruppel family member GLI2 [Source:MGI Symbol;Acc:MGI:95 728]
Dock11.56E-14−0.32618150.5230.6735.04E-10dedicator of cytokinesis 1 [Source:MGI Symbol;Acc:MGI:2 429 765]
Sox2ot1.64E-14−0.33052370.4340.5045.30E-10SOX2 overlapping transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 112]
Cnn31.70E-140.28 344 2520.3170.1945.50E-10calponin 3, acidic [Source:MGI Symbol;Acc:MGI:1 919 244]
Ttyh11.92E-14−0.29267970.6050.7186.19E-10tweety family member 1 [Source:MGI Symbol;Acc:MGI:1 889 007]
Gm442572.12E-14−0.26098730.0330.1976.85E-10predicted gene, 44 257 [Source:MGI Symbol;Acc:MGI:5 690 649]
Adamts202.16E-140.29 924 1810.2730.1486.97E-10a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 20 [Source:MGI Symbol;Acc:MGI:2 660 628]
Dclk22.20E-140.30 007 3780.4190.2677.11E-10doublecortin-like kinase 2 [Source:MGI Symbol;Acc:MGI:1 918 012]
Cacna1a2.21E-140.25 941 8020.3190.1927.14E-10calcium channel, voltage-dependent, P/Q type, alpha 1A subunit [Source:MGI Symbol;Acc:MGI:109 482]
Plekha52.37E-140.28 678 2280.3560.2177.64E-10pleckstrin homology domain containing, family A member 5 [Source:MGI Symbol;Acc:MGI:1 923 802]
Kifc32.45E-14−0.25976760.1610.3177.90E-10kinesin family member C3 [Source:MGI Symbol;Acc:MGI:109 202]
Lgr62.51E-14−0.2593910.0240.1568.11E-10leucine-rich repeat-containing G protein-coupled receptor 6 [Source:MGI Symbol;Acc:MGI:2 441 805]
Eda2.59E-140.32 338 3020.3620.2228.37E-10ectodysplasin-A [Source:MGI Symbol;Acc:MGI:1 195 272]
Ccdc1622.67E-140.31 699 3020.2690.1248.61E-10coiled-coil domain containing 162 [Source:MGI Symbol;Acc:MGI:1 923 223]
Arid5b3.24E-140.2 963 0380.2820.151.04E-09AT rich interactive domain 5B (MRF1-like) [Source:MGI Symbol;Acc:MGI:2 175 912]
Garem13.77E-14−0.36059850.2540.4491.22E-09GRB2 associated regulator of MAPK1 subtype 1 [Source:MGI Symbol;Acc:MGI:2 685 790]
Arhgap53.93E-14−0.33484380.6620.7571.27E-09Rho GTPase activating protein 5 [Source:MGI Symbol;Acc:MGI:1 332 637]
Immp2l3.95E-140.31 435 5180.330.1941.27E-09IMP2 inner mitochondrial membrane peptidase-like (S. cerevisiae) [Source:MGI Symbol;Acc:MGI:2 135 611]
Aldoc4.99E-14−0.25647490.3560.4761.61E-09aldolase C, fructose-bisphosphate [Source:MGI Symbol;Acc:MGI:101 863]
Grip15.24E-14−0.3209810.1240.2691.69E-09glutamate receptor interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 921 303]
Fgf15.34E-14−0.27476260.1970.3461.73E-09fibroblast growth factor 1 [Source:MGI Symbol;Acc:MGI:95 515]
App5.83E-140.32 161 6870.6550.531.88E-09amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Wipf16.20E-14−0.28437770.1390.2542.00E-09WAS/WASL interacting protein family, member 1 [Source:MGI Symbol;Acc:MGI:2 178 801]
Cyfip17.55E-14−0.27023090.2190.3672.44E-09cytoplasmic FMR1 interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 338 801]
Gnao18.00E-14−0.54154020.5940.6752.58E-09guanine nucleotide binding protein, alpha O [Source:MGI Symbol;Acc:MGI:95 775]
Ccdc1418.02E-14−0.29317220.3410.4542.59E-09coiled-coil domain containing 141 [Source:MGI Symbol;Acc:MGI:1 919 735]
Stard138.21E-140.4 152 6490.5550.3882.65E-09StAR-related lipid transfer (START) domain containing 13 [Source:MGI Symbol;Acc:MGI:2 385 331]
Fut98.62E-14−0.3228330.5380.662.78E-09fucosyltransferase 9 [Source:MGI Symbol;Acc:MGI:1 330 859]
Sycp29.81E-14−0.26892640.1040.2673.17E-09synaptonemal complex protein 2 [Source:MGI Symbol;Acc:MGI:1 933 281]
Tox1.04E-13−0.37116680.2990.5143.36E-09thymocyte selection-associated high mobility group box [Source:MGI Symbol;Acc:MGI:2 181 659]
Eif4g31.08E-13−0.32461490.4010.5713.48E-09eukaryotic translation initiation factor 4 gamma, 3 [Source:MGI Symbol;Acc:MGI:1 923 935]
Stat31.34E-130.27 159 3520.3060.1534.34E-09signal transducer and activator of transcription 3 [Source:MGI Symbol;Acc:MGI:103 038]
Sned11.48E-130.2 999 9790.3470.24.78E-09sushi, nidogen and EGF-like domains 1 [Source:MGI Symbol;Acc:MGI:3 045 960]
Usp541.72E-13−0.2713570.2060.3455.55E-09ubiquitin specific peptidase 54 [Source:MGI Symbol;Acc:MGI:1 926 037]
Tle42.16E-13−0.31412170.2490.4416.97E-09transducin-like enhancer of split 4 [Source:MGI Symbol;Acc:MGI:104 633]
Dbx22.45E-13−0.25818290.2210.3587.91E-09developing brain homeobox 2 [Source:MGI Symbol;Acc:MGI:107 445]
Btbd92.62E-130.31 317 4530.5080.3468.47E-09BTB (POZ) domain containing 9 [Source:MGI Symbol;Acc:MGI:1 916 625]
Fam214a2.90E-13−0.27770730.2130.3549.37E-09NA
Cachd13.12E-130.33 962 3370.4770.3271.01E-08cache domain containing 1 [Source:MGI Symbol;Acc:MGI:2 444 177]
Fnbp13.31E-13−0.29308250.6360.7341.07E-08formin binding protein 1 [Source:MGI Symbol;Acc:MGI:109 606]
Pid13.41E-13−0.31881280.3470.5121.10E-08phosphotyrosine interaction domain containing 1 [Source:MGI Symbol;Acc:MGI:2 138 391]
Id43.49E-130.36 185 5740.4620.2821.13E-08inhibitor of DNA binding 4 [Source:MGI Symbol;Acc:MGI:99 414]
Chst113.52E-130.31 210 5770.4120.2621.14E-08carbohydrate sulfotransferase 11 [Source:MGI Symbol;Acc:MGI:1 927 166]
Atl24.05E-13−0.26108010.3040.4241.31E-08atlastin GTPase 2 [Source:MGI Symbol;Acc:MGI:1 929 492]
Dpf35.01E-13−0.29100540.2650.4261.62E-08double PHD fingers 3 [Source:MGI Symbol;Acc:MGI:1 917 377]
Arrb15.31E-13−0.25373280.180.3391.71E-08arrestin, beta 1 [Source:MGI Symbol;Acc:MGI:99 473]
Fam155a5.80E-130.69 052 6150.4840.2871.87E-08NA
Zfhx47.06E-130.3 268 6590.3560.232.28E-08zinc finger homeodomain 4 [Source:MGI Symbol;Acc:MGI:2 137 668]
Fgf147.06E-130.39 407 1390.8630.7582.28E-08fibroblast growth factor 14 [Source:MGI Symbol;Acc:MGI:109 189]
Hivep37.55E-13−0.32663020.5750.7292.44E-08human immunodeficiency virus type I enhancer binding protein 3 [Source:MGI Symbol;Acc:MGI:106 589]
Fermt28.05E-13−0.29984070.3410.5012.60E-08fermitin family member 2 [Source:MGI Symbol;Acc:MGI:2 385 001]
Rnf2208.48E-13−0.29992290.1020.1932.74E-08ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Rmst1.07E-120.52 794 9370.8030.7583.47E-08rhabdomyosarcoma 2 associated transcript (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 099 806]
Dnm31.48E-120.3 694 3220.490.3064.77E-08dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Gulp11.67E-12−0.27018140.150.2955.38E-08GULP, engulfment adaptor PTB domain containing 1 [Source:MGI Symbol;Acc:MGI:1 920 407]
Prkn1.96E-120.42 415 9410.7350.66.32E-08parkin RBR E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 355 296]
Hivep22.85E-12−0.30008690.4010.5449.21E-08human immunodeficiency virus type I enhancer binding protein 2 [Source:MGI Symbol;Acc:MGI:1 338 076]
Agl2.91E-12−0.25301560.2820.419.40E-08amylo-1,6-glucosidase, 4-alpha-glucanotransferase [Source:MGI Symbol;Acc:MGI:1 924 809]
Astn23.41E-120.43 229 7550.590.5141.10E-07astrotactin 2 [Source:MGI Symbol;Acc:MGI:1 889 277]
Abi13.62E-12−0.26955890.3340.4761.17E-07abl interactor 1 [Source:MGI Symbol;Acc:MGI:104 913]
Enah4.34E-12−0.29490060.5570.6891.40E-07ENAH actin regulator [Source:MGI Symbol;Acc:MGI:108 360]
Tmem1645.37E-12−0.32205140.3560.5141.74E-07transmembrane protein 164 [Source:MGI Symbol;Acc:MGI:2 148 020]
Aco25.41E-12−0.2500020.2950.4341.75E-07aconitase 2, mitochondrial [Source:MGI Symbol;Acc:MGI:87 880]
Dlgap15.65E-12−0.32803280.7250.8471.82E-07DLG associated protein 1 [Source:MGI Symbol;Acc:MGI:1 346 065]
Cpeb35.85E-12−0.27077850.4380.5531.89E-07cytoplasmic polyadenylation element binding protein 3 [Source:MGI Symbol;Acc:MGI:2 443 075]
Nfib7.15E-12−0.27996810.740.8212.31E-07nuclear factor I/B [Source:MGI Symbol;Acc:MGI:103 188]
Iqsec28.06E-120.25 033 8210.3360.1962.60E-07IQ motif and Sec7 domain 2 [Source:MGI Symbol;Acc:MGI:3 528 396]
Shisa68.24E-12−0.25758450.10.1592.66E-07shisa family member 6 [Source:MGI Symbol;Acc:MGI:2 685 725]
Nfkb18.60E-120.31 729 2130.4510.3092.78E-07nuclear factor of kappa light polypeptide gene enhancer in B cells 1, p105 [Source:MGI Symbol;Acc:MGI:97 312]
Myo18a9.58E-12−0.26612360.2320.3853.09E-07myosin XVIIIA [Source:MGI Symbol;Acc:MGI:2 667 185]
Ugp21.08E-110.26 792 9520.5160.3723.49E-07UDP-glucose pyrophosphorylase 2 [Source:MGI Symbol;Acc:MGI:2 183 447]
Enpp21.36E-110.30 137 9840.410.2424.40E-07ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
Frmpd11.37E-11−0.27250150.2540.4044.42E-07FERM and PDZ domain containing 1 [Source:MGI Symbol;Acc:MGI:2 446 274]
Ano62.02E-110.28 037 3710.2690.1426.53E-07anoctamin 6 [Source:MGI Symbol;Acc:MGI:2 145 890]
Tcf252.14E-11−0.25243530.4950.6256.92E-07transcription factor 25 (basic helix-loop-helix) [Source:MGI Symbol;Acc:MGI:1 914 105]
Sel1l32.21E-110.25 017 1740.20.1017.13E-07sel-1 suppressor of lin-12-like 3 (C. elegans) [Source:MGI Symbol;Acc:MGI:1 916 941]
Pigk2.24E-11−0.31922570.1080.2577.24E-07phosphatidylinositol glycan anchor biosynthesis, class K [Source:MGI Symbol;Acc:MGI:1 913 863]
Meis22.39E-110.28 700 8230.7220.647.73E-07Meis homeobox 2 [Source:MGI Symbol;Acc:MGI:108 564]
Clmn2.43E-11−0.37419370.3380.5017.85E-07calmin [Source:MGI Symbol;Acc:MGI:2 136 957]
Pard3b2.59E-110.36 304 2810.6770.578.37E-07par-3 family cell polarity regulator beta [Source:MGI Symbol;Acc:MGI:1 919 301]
Zfhx32.74E-110.44 295 7930.5180.3638.84E-07zinc finger homeobox 3 [Source:MGI Symbol;Acc:MGI:99 948]
Bcan2.75E-11−0.25547580.5570.6498.87E-07brevican [Source:MGI Symbol;Acc:MGI:1 096 385]
Acss13.09E-11−0.25673650.2430.3979.98E-07acyl-CoA synthetase short-chain family member 1 [Source:MGI Symbol;Acc:MGI:1 915 988]
Adk3.22E-11−0.28200380.6570.7661.04E-06adenosine kinase [Source:MGI Symbol;Acc:MGI:87 930]
Clasp24.17E-11−0.27344010.5990.6911.35E-06CLIP associating protein 2 [Source:MGI Symbol;Acc:MGI:1 923 749]
Alcam5.04E-11−0.32091160.3640.5191.63E-06activated leukocyte cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 313 266]
Cspp15.14E-110.26 083 5650.4860.3481.66E-06centrosome and spindle pole associated protein 1 [Source:MGI Symbol;Acc:MGI:2 681 832]
Plpp35.22E-11−0.3177850.6960.7881.68E-06phospholipid phosphatase 3 [Source:MGI Symbol;Acc:MGI:1 915 166]
Megf105.80E-11−0.25197490.280.4191.87E-06multiple EGF-like-domains 10 [Source:MGI Symbol;Acc:MGI:2 685 177]
Gphn6.45E-11−0.26894960.8740.9112.08E-06gephyrin [Source:MGI Symbol;Acc:MGI:109 602]
Fus6.61E-110.25 396 1730.5160.3762.13E-06fused in sarcoma [Source:MGI Symbol;Acc:MGI:1 353 633]
Wwc18.27E-11−0.26592630.4120.5382.67E-06WW, C2 and coiled-coil domain containing 1 [Source:MGI Symbol;Acc:MGI:2 388 637]
Lrrc4c8.56E-11−0.44154730.8940.9012.76E-06leucine rich repeat containing 4C [Source:MGI Symbol;Acc:MGI:2 442 636]
Rorb1.46E-10−0.32772560.7460.8574.71E-06RAR-related orphan receptor beta [Source:MGI Symbol;Acc:MGI:1 343 464]
Sgip11.72E-10−0.28270460.6250.7265.55E-06SH3-domain GRB2-like (endophilin) interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 920 344]
Gm487421.76E-10−0.25864250.230.3675.69E-06predicted gene, 48 742 [Source:MGI Symbol;Acc:MGI:6 098 410]
Ttc282.09E-100.28 895 9350.4970.3736.76E-06tetratricopeptide repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 140 873]
Igsf112.14E-100.28 984 7290.4920.3536.90E-06immunoglobulin superfamily, member 11 [Source:MGI Symbol;Acc:MGI:2 388 477]
Fbxl72.42E-100.30 362 5530.2150.0827.83E-06F-box and leucine-rich repeat protein 7 [Source:MGI Symbol;Acc:MGI:3 052 506]
Lama22.60E-10−0.31068160.6160.7188.39E-06laminin, alpha 2 [Source:MGI Symbol;Acc:MGI:99 912]
Camk2n12.74E-10−0.27324110.2690.4598.84E-06calcium/calmodulin-dependent protein kinase II inhibitor 1 [Source:MGI Symbol;Acc:MGI:1 913 509]
Spire13.03E-10−0.26781420.5510.6729.78E-06spire type actin nucleation factor 1 [Source:MGI Symbol;Acc:MGI:1 915 416]
Thrb3.43E-10−0.26550690.6160.6761.11E-05thyroid hormone receptor beta [Source:MGI Symbol;Acc:MGI:98 743]
Grid13.76E-10−0.27218740.2750.4451.21E-05glutamate receptor, ionotropic, delta 1 [Source:MGI Symbol;Acc:MGI:95 812]
Dst3.99E-100.33 094 5720.6880.6351.29E-05dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Lhfpl35.06E-100.52 784 1760.4380.2881.63E-05lipoma HMGIC fusion partner-like 3 [Source:MGI Symbol;Acc:MGI:1 925 076]
Lrmda5.92E-10−0.33622630.2190.361.91E-05leucine rich melanocyte differentiation associated [Source:MGI Symbol;Acc:MGI:1 923 883]
Slc9a91.26E-090.27 808 9960.4880.3734.08E-05solute carrier family 9 (sodium/hydrogen exchanger), member 9 [Source:MGI Symbol;Acc:MGI:2 679 732]
Mapk101.51E-09−0.26380080.5680.6624.87E-05mitogen-activated protein kinase 10 [Source:MGI Symbol;Acc:MGI:1 346 863]
B3galt12.00E-09−0.26546690.8610.9196.45E-05UDP-Gal:betaGlcNAc beta 1,3-galactosyltransferase, polypeptide 1 [Source:MGI Symbol;Acc:MGI:1 349 403]
Ddah12.19E-09−0.25509760.2170.3817.07E-05dimethylarginine dimethylaminohydrolase 1 [Source:MGI Symbol;Acc:MGI:1 916 469]
Smyd33.06E-090.30 146 9810.5120.3619.89E-05SET and MYND domain containing 3 [Source:MGI Symbol;Acc:MGI:1 916 976]
Pde4d3.57E-090.49 104 4540.8160.7410.00 011 538phosphodiesterase 4D, cAMP specific [Source:MGI Symbol;Acc:MGI:99 555]
Prdx63.89E-090.28 389 0770.640.5270.00 012 564peroxiredoxin 6 [Source:MGI Symbol;Acc:MGI:894 320]
Ankrd283.94E-090.27 308 2010.4790.3550.0 001 273ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Map4k44.15E-090.25 600 6240.5180.4170.00 013 397mitogen-activated protein kinase kinase kinase kinase 4 [Source:MGI Symbol;Acc:MGI:1 349 394]
Acss34.20E-090.26 918 8530.3210.1890.00 013 546acyl-CoA synthetase short-chain family member 3 [Source:MGI Symbol;Acc:MGI:2 685 720]
Dock74.82E-090.27 946 9240.4080.2920.00 015 556dedicator of cytokinesis 7 [Source:MGI Symbol;Acc:MGI:1 914 549]
Bcl28.22E-090.25 489 8510.4080.3380.00 026 533B cell leukemia/lymphoma 2 [Source:MGI Symbol;Acc:MGI:88 138]
4930488L21Rik1.21E-08−0.31219660.1430.2830.00 039 211RIKEN cDNA 4930488L21 gene [Source:MGI Symbol;Acc:MGI:1 923 059]
Fhit2.18E-080.40 458 5420.5530.3880.00 070 321fragile histidine triad gene [Source:MGI Symbol;Acc:MGI:1 277 947]
Ank2.18E-080.32 658 1310.5120.4220.00 070 377progressive ankylosis [Source:MGI Symbol;Acc:MGI:3 045 421]
Fam13c3.14E-08−0.25229780.150.2780.00 101 426family with sequence similarity 13, member C [Source:MGI Symbol;Acc:MGI:1 918 971]
Thsd7a3.44E-080.31 348 4940.4510.3030.00 111 155thrombospondin, type I, domain containing 7A [Source:MGI Symbol;Acc:MGI:2 685 683]
Epha54.54E-080.30 165 5980.5420.3820.00 146 634Eph receptor A5 [Source:MGI Symbol;Acc:MGI:99 654]
Phactr15.31E-08−0.27994040.3320.4980.00 171 272phosphatase and actin regulator 1 [Source:MGI Symbol;Acc:MGI:2 659 021]
Inpp4b9.18E-080.25 348 1230.2650.1510.00 296 391inositol polyphosphate-4-phosphatase, type II [Source:MGI Symbol;Acc:MGI:2 158 925]
Genep_valavg_log2FCpct.1pct.2p_val_adjdescription
Ablim202.01 268 2050.5920.1420actin-binding LIM protein 2 [Source:MGI Symbol;Acc:MGI:2 385 758]
Gpc50−2.42154350.5230.9780glypican 5 [Source:MGI Symbol;Acc:MGI:1 194 894]
Trpm30−2.77725470.4750.9310transient receptor potential cation channel, subfamily M, member 3 [Source:MGI Symbol;Acc:MGI:2 443 101]
Lsamp5.69E-249−1.48518030.99311.84E-244limbic system-associated membrane protein [Source:MGI Symbol;Acc:MGI:1 261 760]
Plcb16.73E-181−1.7406110.670.9462.17E-176phospholipase C, beta 1 [Source:MGI Symbol;Acc:MGI:97 613]
6330411D24Rik6.01E-1802.09 342 4640.4010.0221.94E-175RIKEN cDNA 6330411D24 gene [Source:MGI Symbol;Acc:MGI:1 917 975]
Kcnd25.20E-170−1.93504750.3730.7061.68E-165potassium voltage-gated channel, Shal-related family, member 2 [Source:MGI Symbol;Acc:MGI:102 663]
Prune22.77E-1681.331 2720.6140.1358.94E-164prune homolog 2 [Source:MGI Symbol;Acc:MGI:1 925 004]
Sorbs21.02E-1671.50 461 4180.6180.1733.30E-163sorbin and SH3 domain containing 2 [Source:MGI Symbol;Acc:MGI:1 924 574]
Kirrel36.70E-158−1.79298880.4010.8792.16E-153kirre like nephrin family adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 914 953]
Gfap7.52E-1541.81 373 9420.6660.2152.43E-149glial fibrillary acidic protein [Source:MGI Symbol;Acc:MGI:95 697]
Mdga24.23E-152−1.30816060.8110.9741.36E-147MAM domain containing glycosylphosphatidylinositol anchor 2 [Source:MGI Symbol;Acc:MGI:2 444 706]
Nrxn12.30E-143−1.27407430.8630.9987.42E-139neurexin I [Source:MGI Symbol;Acc:MGI:1 096 391]
Gm37647.00E-142−1.25984060.7270.9372.26E-137predicted gene 3764 [Source:MGI Symbol;Acc:MGI:3 781 938]
Grik24.07E-1331.35 293 1470.7960.4631.31E-128glutamate receptor, ionotropic, kainate 2 (beta 2) [Source:MGI Symbol;Acc:MGI:95 815]
Cacnb25.58E-1301.4 550 6950.6440.2571.80E-125calcium channel, voltage-dependent, beta 2 subunit [Source:MGI Symbol;Acc:MGI:894 644]
Ccdc1486.30E-1221.04 581 6740.4010.0552.04E-117coiled-coil domain containing 148 [Source:MGI Symbol;Acc:MGI:3 039 583]
Pkp41.87E-1211.16 887 2370.610.2336.05E-117plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Gm122391.17E-119−1.56307290.150.5663.78E-115predicted gene 12 239 [Source:MGI Symbol;Acc:MGI:3 651 547]
Adamtsl11.78E-1181.0 194 3730.3690.0385.76E-114ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
A2m1.89E-1091.16 768 9790.4210.0656.11E-105alpha-2-macroglobulin [Source:MGI Symbol;Acc:MGI:2 449 119]
Rora3.95E-109−1.07252170.9520.9891.28E-104RAR-related orphan receptor alpha [Source:MGI Symbol;Acc:MGI:104 661]
Pcdh94.52E-109−1.08897650.9440.9921.46E-104protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Slc38a16.45E-1081.18 683 5730.6290.2362.08E-103solute carrier family 38, member 1 [Source:MGI Symbol;Acc:MGI:2 145 895]
Cadps3.49E-1011.07 111 9480.6810.3051.13E-96Ca2+-dependent secretion activator [Source:MGI Symbol;Acc:MGI:1 350 922]
Pitpnc15.38E-101−1.20861830.6940.9131.74E-96phosphatidylinositol transfer protein, cytoplasmic 1 [Source:MGI Symbol;Acc:MGI:1 919 045]
Kcnj33.06E-980.90 152 9530.5620.1669.89E-94potassium inwardly-rectifying channel, subfamily J, member 3 [Source:MGI Symbol;Acc:MGI:104 742]
Gm149641.15E-960.76 450 6180.5080.1593.70E-92predicted gene 14 964 [Source:MGI Symbol;Acc:MGI:3 641 621]
Ccdc35.80E-960.76 885 9680.3410.0241.87E-91coiled-coil domain containing 3 [Source:MGI Symbol;Acc:MGI:1 921 436]
Asap31.18E-930.63 349 4210.3430.0273.82E-89ArfGAP with SH3 domain, ankyrin repeat and PH domain 3 [Source:MGI Symbol;Acc:MGI:2 684 986]
Atp1a21.41E-92−0.95126260.7790.9324.56E-88ATPase, Na+/K + transporting, alpha 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 106]
Gm48764.73E-880.82 426 1180.4770.1311.53E-83predicted gene 4876 [Source:MGI Symbol;Acc:MGI:3 647 654]
Car109.87E-88−1.17006910.2520.4793.19E-83carbonic anhydrase 10 [Source:MGI Symbol;Acc:MGI:1 919 855]
Ldb21.61E-860.78 138 8860.4620.1195.19E-82LIM domain binding 2 [Source:MGI Symbol;Acc:MGI:894 670]
Arhgef46.30E-861.03 026 8930.7720.5642.03E-81Rho guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:2 442 507]
Prkag26.94E-850.77 822 6080.4920.1562.24E-80protein kinase, AMP-activated, gamma 2 non-catalytic subunit [Source:MGI Symbol;Acc:MGI:1 336 153]
Col23a18.05E-851.11 579 5670.4690.112.60E-80collagen, type XXIII, alpha 1 [Source:MGI Symbol;Acc:MGI:2 653 243]
Brinp34.08E-84−1.05676250.2670.6981.32E-79bone morphogenetic protein/retinoic acid inducible neural specific 3 [Source:MGI Symbol;Acc:MGI:2 443 035]
Myoc9.22E-830.80 203 1310.2730.0122.98E-78myocilin [Source:MGI Symbol;Acc:MGI:1 202 864]
Pdzrn34.51E-820.69 065 9930.4340.11.46E-77PDZ domain containing RING finger 3 [Source:MGI Symbol;Acc:MGI:1 933 157]
C4b9.92E-820.67 373 8660.4010.0733.20E-77complement component 4B (Chido blood group) [Source:MGI Symbol;Acc:MGI:88 228]
Gm207131.04E-81−1.16710950.1480.713.35E-77predicted gene 20 713 [Source:MGI Symbol;Acc:MGI:5 313 160]
Cadm29.70E-81−0.86774230.8870.9913.13E-76cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:2 442 722]
Cobll11.01E-800.69 941 5610.380.0583.26E-76Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Tmem1087.84E-790.68 764 5550.3250.0482.53E-74transmembrane protein 108 [Source:MGI Symbol;Acc:MGI:1 932 411]
Slc6a111.58E-78−0.95280880.260.5775.11E-74solute carrier family 6 (neurotransmitter transporter, GABA), member 11 [Source:MGI Symbol;Acc:MGI:95 630]
Gria28.90E-78−1.17085270.4010.7652.87E-73glutamate receptor, ionotropic, AMPA2 (alpha 2) [Source:MGI Symbol;Acc:MGI:95 809]
Ptch11.21E-77−1.03795650.1780.5723.91E-73patched 1 [Source:MGI Symbol;Acc:MGI:105 373]
Nhsl12.00E-77−1.00848890.3620.7246.47E-73NHS-like 1 [Source:MGI Symbol;Acc:MGI:106 390]
Cd443.84E-750.61 517 8670.2890.0221.24E-70CD44 antigen [Source:MGI Symbol;Acc:MGI:88 338]
Adgrb38.83E-75−0.93077680.8760.9562.85E-70adhesion G protein-coupled receptor B3 [Source:MGI Symbol;Acc:MGI:2 441 837]
Man1c12.14E-730.63 698 9220.3360.0636.91E-69mannosidase, alpha, class 1C, member 1 [Source:MGI Symbol;Acc:MGI:2 446 214]
Prkca4.62E-710.97 231 7920.80.5611.49E-66protein kinase C, alpha [Source:MGI Symbol;Acc:MGI:97 595]
Sntg21.58E-700.49 453 6240.2820.0155.10E-66syntrophin, gamma 2 [Source:MGI Symbol;Acc:MGI:1 919 541]
Sulf21.19E-690.53 943 0030.2910.0443.85E-65sulfatase 2 [Source:MGI Symbol;Acc:MGI:1 919 293]
Glis32.10E-690.81 574 3810.790.5286.77E-65GLIS family zinc finger 3 [Source:MGI Symbol;Acc:MGI:2 444 289]
Nrp28.88E-690.52 318 1580.3230.0452.87E-64neuropilin 2 [Source:MGI Symbol;Acc:MGI:1 100 492]
Reep17.50E-670.64 992 3470.3430.0692.42E-62receptor accessory protein 1 [Source:MGI Symbol;Acc:MGI:1 098 827]
Slc7a105.38E-65−1.11624910.0650.5521.74E-60solute carrier family 7 (cationic amino acid transporter, y + system), member 10 [Source:MGI Symbol;Acc:MGI:1 858 261]
Pde7b6.13E-65−0.99651790.2730.7011.98E-60phosphodiesterase 7B [Source:MGI Symbol;Acc:MGI:1 352 752]
Ctnna22.42E-631.08 054 9980.8440.6767.81E-59catenin (cadherin associated protein), alpha 2 [Source:MGI Symbol;Acc:MGI:88 275]
Csmd17.81E-630.67 950 1760.5770.3952.52E-58CUB and Sushi multiple domains 1 [Source:MGI Symbol;Acc:MGI:2 137 383]
Sorbs11.00E-620.95 190 3380.8290.6383.24E-58sorbin and SH3 domain containing 1 [Source:MGI Symbol;Acc:MGI:700 014]
Aebp11.73E-620.45 464 3510.2580.0135.59E-58AE binding protein 1 [Source:MGI Symbol;Acc:MGI:1 197 012]
Sema3a1.11E-600.54 359 6090.2520.033.59E-56sema domain, immunoglobulin domain (Ig), short basic domain, secreted, (semaphorin) 3A [Source:MGI Symbol;Acc:MGI:107 558]
Rgs72.21E-60−1.01278830.2430.6427.14E-56regulator of G protein signaling 7 [Source:MGI Symbol;Acc:MGI:1 346 089]
Slc8a15.29E-600.95 401 4560.5210.2471.71E-55solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Synpo25.36E-600.82 634 0960.4970.1651.73E-55synaptopodin 2 [Source:MGI Symbol;Acc:MGI:2 153 070]
Dock47.62E-60−0.79633060.5790.812.46E-55dedicator of cytokinesis 4 [Source:MGI Symbol;Acc:MGI:1 918 006]
C530044C16Rik1.87E-590.4 873 9990.2340.0126.04E-55RIKEN cDNA C530044C16 gene [Source:MGI Symbol;Acc:MGI:2 443 109]
Tagln34.73E-590.61 896 3830.5770.2991.53E-54transgelin 3 [Source:MGI Symbol;Acc:MGI:1 926 784]
Adgrl31.51E-57−0.71364630.7790.8994.88E-53adhesion G protein-coupled receptor L3 [Source:MGI Symbol;Acc:MGI:2 441 950]
Cpne82.52E-560.41 103 0570.2620.0378.13E-52copine VIII [Source:MGI Symbol;Acc:MGI:1 914 121]
Phyhd14.30E-560.6 780 0510.5340.2281.39E-51phytanoyl-CoA dioxygenase domain containing 1 [Source:MGI Symbol;Acc:MGI:3 612 860]
Gria44.97E-56−0.85760140.2060.421.60E-51glutamate receptor, ionotropic, AMPA4 (alpha 4) [Source:MGI Symbol;Acc:MGI:95 811]
Padi28.82E-560.61 810 8460.4230.1282.85E-51peptidyl arginine deiminase, type II [Source:MGI Symbol;Acc:MGI:1 338 892]
Robo21.23E-540.9 155 6120.7870.5693.98E-50roundabout guidance receptor 2 [Source:MGI Symbol;Acc:MGI:1 890 110]
Ccser11.27E-540.80 908 8570.4730.2874.09E-50coiled-coil serine rich 1 [Source:MGI Symbol;Acc:MGI:3 045 354]
St6galnac32.01E-541.53 920 7550.540.1396.49E-50ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Cdh108.08E-54−0.77856710.4450.7362.61E-49cadherin 10 [Source:MGI Symbol;Acc:MGI:107 436]
Dok61.84E-530.70 032 1640.4620.1635.93E-49docking protein 6 [Source:MGI Symbol;Acc:MGI:3 639 495]
Smad63.72E-530.34 957 9810.2470.0341.20E-48SMAD family member 6 [Source:MGI Symbol;Acc:MGI:1 336 883]
Aqp46.40E-530.78 867 0240.7010.4032.07E-48aquaporin 4 [Source:MGI Symbol;Acc:MGI:107 387]
Grm79.42E-510.88 253 3170.4620.2293.04E-46glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Dgki6.91E-500.76 957 4490.5730.2442.23E-45diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Tex111.04E-490.36 512 0030.2150.0123.35E-45testis expressed gene 11 [Source:MGI Symbol;Acc:MGI:1 933 237]
Ahnak1.08E-480.32 270 0590.2340.0273.48E-44AHNAK nucleoprotein (desmoyokin) [Source:MGI Symbol;Acc:MGI:1 316 648]
Trp632.37E-48−0.91803720.0350.3187.64E-44transformation related protein 63 [Source:MGI Symbol;Acc:MGI:1 330 810]
Tnc2.67E-480.37 489 8670.2340.0238.61E-44tenascin C [Source:MGI Symbol;Acc:MGI:101 922]
Reln3.62E-480.6 459 5270.3970.1091.17E-43reelin [Source:MGI Symbol;Acc:MGI:103 022]
Pxdn3.76E-480.4 112 2210.2930.0721.21E-43peroxidasin [Source:MGI Symbol;Acc:MGI:1 916 925]
Atp13a47.34E-48−0.66697550.1450.4862.37E-43ATPase type 13A4 [Source:MGI Symbol;Acc:MGI:1 924 456]
Cacnb49.29E-470.71 396 1130.4840.2383.00E-42calcium channel, voltage-dependent, beta 4 subunit [Source:MGI Symbol;Acc:MGI:103 301]
Adamts92.03E-460.68 554 0960.4990.2026.57E-42a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 9 [Source:MGI Symbol;Acc:MGI:1 916 320]
Tmtc23.43E-46−0.73294880.2430.5761.11E-41transmembrane and tetratricopeptide repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 914 057]
Limch17.50E-46−0.68115580.3950.6812.42E-41LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Grid21.96E-45−0.66948460.7090.9066.34E-41glutamate receptor, ionotropic, delta 2 [Source:MGI Symbol;Acc:MGI:95 813]
Cadm12.29E-45−0.80658970.5490.8357.40E-41cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:1 889 272]
Sema6a1.15E-440.44 205 1310.3150.0743.73E-40sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
Ggta13.51E-440.29 853 8780.1930.0181.13E-39glycoprotein galactosyltransferase alpha 1, 3 [Source:MGI Symbol;Acc:MGI:95 704]
Npas35.45E-44−0.57127180.9440.9811.76E-39neuronal PAS domain protein 3 [Source:MGI Symbol;Acc:MGI:1 351 610]
Garnl37.71E-440.42 029 5370.3060.0932.49E-39GTPase activating RANGAP domain-like 3 [Source:MGI Symbol;Acc:MGI:2 139 309]
Kcnma11.92E-43−0.78100460.310.6676.19E-39potassium large conductance calcium-activated channel, subfamily M, alpha member 1 [Source:MGI Symbol;Acc:MGI:99 923]
Auts22.67E-43−0.7000360.7350.9138.63E-39autism susceptibility candidate 2 [Source:MGI Symbol;Acc:MGI:1 919 847]
Fmn12.69E-430.79 828 6930.4270.1988.69E-39formin 1 [Source:MGI Symbol;Acc:MGI:101 815]
Disp32.97E-430.4 166 9970.2520.0799.59E-39dispatched RND transporter family member 3 [Source:MGI Symbol;Acc:MGI:2 444 403]
Grin3a4.31E-430.59 174 3050.3860.1361.39E-38glutamate receptor ionotropic, NMDA3A [Source:MGI Symbol;Acc:MGI:1 933 206]
Sema6d8.82E-430.98 719 6660.7110.5332.85E-38sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6D [Source:MGI Symbol;Acc:MGI:2 387 661]
Pcdh71.43E-42−0.62898410.7350.8744.62E-38protocadherin 7 [Source:MGI Symbol;Acc:MGI:1 860 487]
Ank21.64E-420.95 150 8240.9390.9555.30E-38ankyrin 2, brain [Source:MGI Symbol;Acc:MGI:88 025]
Mast41.87E-41−0.67183640.440.7166.04E-37microtubule associated serine/threonine kinase family member 4 [Source:MGI Symbol;Acc:MGI:1 918 885]
Slc4a42.81E-41−0.55013950.8520.9199.08E-37solute carrier family 4 (anion exchanger), member 4 [Source:MGI Symbol;Acc:MGI:1 927 555]
Ano15.02E-410.46 720 2610.2150.0031.62E-36anoctamin 1, calcium activated chloride channel [Source:MGI Symbol;Acc:MGI:2 142 149]
Cmya58.05E-410.45 054 9590.3410.0972.60E-36cardiomyopathy associated 5 [Source:MGI Symbol;Acc:MGI:1 923 719]
Dner1.62E-400.46 188 8890.3990.1765.22E-36delta/notch-like EGF repeat containing [Source:MGI Symbol;Acc:MGI:2 152 889]
Gpld12.60E-40−0.63787620.080.3858.38E-36glycosylphosphatidylinositol specific phospholipase D1 [Source:MGI Symbol;Acc:MGI:106 604]
Negr12.65E-40−0.69709820.620.8528.56E-36neuronal growth regulator 1 [Source:MGI Symbol;Acc:MGI:2 444 846]
Anxa21.10E-390.27 925 3720.1760.0123.54E-35annexin A2 [Source:MGI Symbol;Acc:MGI:88 246]
Vav32.04E-39−0.6866090.0910.4396.58E-35vav 3 oncogene [Source:MGI Symbol;Acc:MGI:1 888 518]
Airn2.14E-390.4 276 2380.2320.0576.90E-35antisense Igf2r RNA [Source:MGI Symbol;Acc:MGI:1 353 471]
Mgat4a2.28E-390.32 616 9760.2170.0397.37E-35mannoside acetylglucosaminyltransferase 4, isoenzyme A [Source:MGI Symbol;Acc:MGI:2 662 992]
Enox14.40E-390.73 574 6870.4990.2741.42E-34ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Frmd4a6.76E-39−0.75556080.7350.9292.18E-34FERM domain containing 4A [Source:MGI Symbol;Acc:MGI:1 919 850]
Eps87.63E-39−0.59955040.2190.5232.46E-34epidermal growth factor receptor pathway substrate 8 [Source:MGI Symbol;Acc:MGI:104 684]
Gm106358.27E-390.4 519 9270.2190.0222.67E-34predicted gene 10 635 [Source:MGI Symbol;Acc:MGI:3 641 740]
Atoh89.59E-390.28 185 6110.1650.0083.10E-34atonal bHLH transcription factor 8 [Source:MGI Symbol;Acc:MGI:1 918 343]
Slc16a23.09E-380.31 372 7040.2280.0519.98E-34solute carrier family 16 (monocarboxylic acid transporters), member 2 [Source:MGI Symbol;Acc:MGI:1 203 732]
Tab28.33E-380.49 912 7840.5210.2572.69E-33TGF-beta activated kinase 1/MAP3K7 binding protein 2 [Source:MGI Symbol;Acc:MGI:1 915 902]
Gm110999.08E-380.33 560 9310.1560.0072.93E-33predicted gene 11 099 [Source:MGI Symbol;Acc:MGI:3 779 335]
Itih39.39E-38−0.61596580.0740.3323.03E-33inter-alpha trypsin inhibitor, heavy chain 3 [Source:MGI Symbol;Acc:MGI:96 620]
P3h21.14E-360.29 550 0610.1780.0183.69E-32prolyl 3-hydroxylase 2 [Source:MGI Symbol;Acc:MGI:2 146 663]
Cables11.22E-36−0.5880480.1450.4593.95E-32CDK5 and Abl enzyme substrate 1 [Source:MGI Symbol;Acc:MGI:1 927 065]
4930402H24Rik1.48E-360.65 012 5090.8550.8344.78E-32NA
Syne11.85E-36−0.55320050.7480.8785.97E-32spectrin repeat containing, nuclear envelope 1 [Source:MGI Symbol;Acc:MGI:1 927 152]
Grm33.44E-36−0.89460450.3340.5831.11E-31glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Eya44.53E-360.43 761 3450.310.1021.46E-31EYA transcriptional coactivator and phosphatase 4 [Source:MGI Symbol;Acc:MGI:1 337 104]
Mamdc23.19E-350.27 013 5470.1560.0071.03E-30MAM domain containing 2 [Source:MGI Symbol;Acc:MGI:1 918 988]
Slc1a24.34E-35−0.55237630.9670.9981.40E-30solute carrier family 1 (glial high affinity glutamate transporter), member 2 [Source:MGI Symbol;Acc:MGI:101 931]
Nxn5.99E-350.62 688 2070.6510.4271.93E-30nucleoredoxin [Source:MGI Symbol;Acc:MGI:109 331]
Phactr36.21E-35−0.57997520.1760.5162.01E-30phosphatase and actin regulator 3 [Source:MGI Symbol;Acc:MGI:1 921 439]
Ccdc85a1.62E-34−0.62650680.1870.5195.22E-30coiled-coil domain containing 85A [Source:MGI Symbol;Acc:MGI:2 445 069]
Ndrg24.31E-34−0.49506960.5790.7271.39E-29N-myc downstream regulated gene 2 [Source:MGI Symbol;Acc:MGI:1 352 498]
Htra15.00E-34−0.57374980.3770.6611.61E-29HtrA serine peptidase 1 [Source:MGI Symbol;Acc:MGI:1 929 076]
St3gal48.55E-34−0.58873510.2650.5412.76E-29ST3 beta-galactoside alpha-2,3-sialyltransferase 4 [Source:MGI Symbol;Acc:MGI:1 316 743]
Tmem132b1.11E-330.31 405 0380.2650.0813.59E-29transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Nav31.86E-33−0.60843310.3170.5146.00E-29neuron navigator 3 [Source:MGI Symbol;Acc:MGI:2 183 703]
Atp2b42.16E-330.32 348 1480.2650.0816.97E-29ATPase, Ca++ transporting, plasma membrane 4 [Source:MGI Symbol;Acc:MGI:88 111]
Met2.35E-330.29 645 2570.1630.0057.60E-29met proto-oncogene [Source:MGI Symbol;Acc:MGI:96 969]
Flnc7.50E-330.27 142 0560.1410.012.42E-28filamin C, gamma [Source:MGI Symbol;Acc:MGI:95 557]
Fat31.86E-32−0.54469370.5360.6686.01E-28FAT atypical cadherin 3 [Source:MGI Symbol;Acc:MGI:2 444 314]
Id32.99E-320.44 213 5360.3820.1389.65E-28inhibitor of DNA binding 3 [Source:MGI Symbol;Acc:MGI:96 398]
Acsbg13.38E-32−0.51663020.3750.5931.09E-27acyl-CoA synthetase bubblegum family member 1 [Source:MGI Symbol;Acc:MGI:2 385 656]
Ptprg5.17E-32−0.54858780.4790.6311.67E-27NA
Tenm46.03E-32−0.49947230.2080.4141.95E-27teneurin transmembrane protein 4 [Source:MGI Symbol;Acc:MGI:2 447 063]
Slc6a16.17E-32−0.46255770.390.5951.99E-27solute carrier family 6 (neurotransmitter transporter, GABA), member 1 [Source:MGI Symbol;Acc:MGI:95 627]
Fgfr37.78E-32−0.46368980.4160.6252.51E-27fibroblast growth factor receptor 3 [Source:MGI Symbol;Acc:MGI:95 524]
Kcnip32.19E-31−0.50406720.1320.3697.08E-27Kv channel interacting protein 3, calsenilin [Source:MGI Symbol;Acc:MGI:1 929 258]
Ntng12.53E-310.47 422 6670.2470.0618.18E-27netrin G1 [Source:MGI Symbol;Acc:MGI:1 934 028]
Tmc74.94E-31−0.49709030.0910.3361.59E-26transmembrane channel-like gene family 7 [Source:MGI Symbol;Acc:MGI:2 443 317]
Tafa15.30E-31−0.65893280.1080.3081.71E-26TAFA chemokine like family member 1 [Source:MGI Symbol;Acc:MGI:2 443 695]
Frmpd46.58E-310.36 641 1150.2860.1362.12E-26FERM and PDZ domain containing 4 [Source:MGI Symbol;Acc:MGI:3 042 378]
Cep85l2.02E-30−0.48200370.3340.5686.52E-26centrosomal protein 85-like [Source:MGI Symbol;Acc:MGI:3 642 684]
Prickle22.16E-300.63 320 0450.610.3696.96E-26prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
C33.37E-300.26 171 3210.1480.0121.09E-25complement component 3 [Source:MGI Symbol;Acc:MGI:88 227]
Pdgfd4.30E-300.64 872 8860.6070.3891.39E-25platelet-derived growth factor, D polypeptide [Source:MGI Symbol;Acc:MGI:1 919 035]
Miat4.48E-300.28 579 9650.210.0561.45E-25myocardial infarction associated transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 886]
Kalrn4.56E-30−0.55721350.2490.5561.47E-25kalirin, RhoGEF kinase [Source:MGI Symbol;Acc:MGI:2 685 385]
Klhl294.79E-300.34 632 9080.330.1281.54E-25kelch-like 29 [Source:MGI Symbol;Acc:MGI:2 683 857]
Osbpl35.99E-300.32 270 9410.2190.0571.93E-25oxysterol binding protein-like 3 [Source:MGI Symbol;Acc:MGI:1 918 970]
Atp1b22.35E-29−0.48022990.4210.5317.59E-25ATPase, Na+/K + transporting, beta 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 109]
Dgkb2.41E-29−0.54566150.7460.8967.79E-25diacylglycerol kinase, beta [Source:MGI Symbol;Acc:MGI:2 442 474]
2610307P16Rik2.50E-290.44 161 5380.2650.0658.07E-25RIKEN cDNA 2610307P16 gene [Source:MGI Symbol;Acc:MGI:1 919 768]
Dock52.53E-29−0.42793390.0980.2718.17E-25dedicator of cytokinesis 5 [Source:MGI Symbol;Acc:MGI:2 652 871]
Slco1c12.73E-29−0.58344170.150.4538.80E-25solute carrier organic anion transporter family, member 1c1 [Source:MGI Symbol;Acc:MGI:1 889 679]
Grin2c4.74E-29−0.51409050.1040.4211.53E-24glutamate receptor, ionotropic, NMDA2C (epsilon 3) [Source:MGI Symbol;Acc:MGI:95 822]
Plekha64.74E-290.32 322 5750.2620.081.53E-24pleckstrin homology domain containing, family A member 6 [Source:MGI Symbol;Acc:MGI:2 388 662]
Luzp24.80E-29−1.1363530.6490.8881.55E-24leucine zipper protein 2 [Source:MGI Symbol;Acc:MGI:1 889 615]
Apbb1ip8.64E-290.319 4610.1950.0212.79E-24amyloid beta (A4) precursor protein-binding, family B, member 1 interacting protein [Source:MGI Symbol;Acc:MGI:1 861 354]
Tnik1.81E-28−0.45286520.8480.9195.84E-24TRAF2 and NCK interacting kinase [Source:MGI Symbol;Acc:MGI:1 916 264]
Grk31.89E-28−0.48679820.2730.5626.11E-24G protein-coupled receptor kinase 3 [Source:MGI Symbol;Acc:MGI:87 941]
Nwd12.12E-28−0.49137720.4580.6956.83E-24NACHT and WD repeat domain containing 1 [Source:MGI Symbol;Acc:MGI:2 442 268]
Shroom33.36E-28−0.47205920.3120.4451.08E-23shroom family member 3 [Source:MGI Symbol;Acc:MGI:1 351 655]
Hip14.84E-28−0.48733460.2210.4791.56E-23huntingtin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 099 804]
Armc21.06E-270.35 458 0490.260.0813.43E-23armadillo repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 916 449]
Plscr41.14E-270.36 422 8220.3150.1023.67E-23phospholipid scramblase 4 [Source:MGI Symbol;Acc:MGI:2 143 267]
Cep1123.75E-270.31 022 3890.2580.081.21E-22centrosomal protein 112 [Source:MGI Symbol;Acc:MGI:1 923 673]
Ahcyl14.67E-27−0.46130040.4380.6641.51E-22S-adenosylhomocysteine hydrolase-like 1 [Source:MGI Symbol;Acc:MGI:2 385 184]
Mertk5.96E-27−0.62954020.5770.7941.92E-22MER proto-oncogene tyrosine kinase [Source:MGI Symbol;Acc:MGI:96 965]
Tulp47.54E-270.48 002 0980.590.3922.43E-22tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Tspan79.19E-27−0.60251660.5570.7832.97E-22tetraspanin 7 [Source:MGI Symbol;Acc:MGI:1 298 407]
Xylt11.90E-26−0.51734750.2230.5016.13E-22xylosyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 451 073]
St3gal62.80E-260.26 891 0790.1890.0429.05E-22ST3 beta-galactoside alpha-2,3-sialyltransferase 6 [Source:MGI Symbol;Acc:MGI:1 888 707]
Myo163.60E-260.3 868 6270.2750.0941.16E-21myosin XVI [Source:MGI Symbol;Acc:MGI:2 685 951]
Ptprj3.83E-26−0.51797520.2410.4251.24E-21protein tyrosine phosphatase, receptor type, J [Source:MGI Symbol;Acc:MGI:104 574]
Npas23.91E-26−0.47452730.3490.5611.26E-21neuronal PAS domain protein 2 [Source:MGI Symbol;Acc:MGI:109 232]
Abcc45.32E-260.25 504 1830.2280.0651.72E-21ATP-binding cassette, sub-family C (CFTR/MRP), member 4 [Source:MGI Symbol;Acc:MGI:2 443 111]
Ablim16.53E-26−0.4412370.260.5082.11E-21actin-binding LIM protein 1 [Source:MGI Symbol;Acc:MGI:1 194 500]
Pamr19.42E-260.31 300 2710.2430.083.04E-21peptidase domain containing associated with muscle regeneration 1 [Source:MGI Symbol;Acc:MGI:2 445 082]
Pde4b2.15E-25−0.61258360.3950.5646.93E-21phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Rfx23.58E-250.25 164 9040.2060.0531.16E-20regulatory factor X, 2 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:106 583]
Gjb63.65E-25−0.39927990.1060.3411.18E-20gap junction protein, beta 6 [Source:MGI Symbol;Acc:MGI:107 588]
Rapgef46.94E-250.3 878 8060.2690.1282.24E-20Rap guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:1 917 723]
Rps6ka57.23E-250.39 342 2340.4190.2182.34E-20ribosomal protein S6 kinase, polypeptide 5 [Source:MGI Symbol;Acc:MGI:1 920 336]
Slc6a98.63E-25−0.34170660.1080.2652.78E-20solute carrier family 6 (neurotransmitter transporter, glycine), member 9 [Source:MGI Symbol;Acc:MGI:95 760]
Gm351881.74E-24−0.51985970.3930.6425.61E-20predicted gene, 35 188 [Source:MGI Symbol;Acc:MGI:5 594 347]
Wdr171.84E-24−0.67369960.7160.8425.93E-20WD repeat domain 17 [Source:MGI Symbol;Acc:MGI:1 924 662]
Mgat4c1.93E-24−0.38743970.5080.5526.23E-20MGAT4 family, member C [Source:MGI Symbol;Acc:MGI:1 914 819]
Il6st1.96E-240.30 887 3980.2930.1146.31E-20interleukin 6 signal transducer [Source:MGI Symbol;Acc:MGI:96 560]
Fry2.03E-24−0.33083650.6010.6616.56E-20FRY microtubule binding protein [Source:MGI Symbol;Acc:MGI:2 443 895]
Ddr12.06E-240.34 612 2530.3190.1436.65E-20discoidin domain receptor family, member 1 [Source:MGI Symbol;Acc:MGI:99 216]
9530026P05Rik2.30E-240.6 724 1210.4510.2387.43E-20RIKEN cDNA 9530026P05 gene [Source:MGI Symbol;Acc:MGI:1 924 659]
Plcl12.96E-24−0.54617790.390.6029.55E-20phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Thbs43.13E-240.26 018 0990.1260.0181.01E-19thrombospondin 4 [Source:MGI Symbol;Acc:MGI:1 101 779]
Wasf34.11E-24−0.40801660.3230.5411.33E-19WASP family, member 3 [Source:MGI Symbol;Acc:MGI:2 658 986]
Bmpr1b4.19E-240.51 910 0950.7770.6711.35E-19bone morphogenetic protein receptor, type 1B [Source:MGI Symbol;Acc:MGI:107 191]
Abcg24.64E-240.2 696 1690.180.0391.50E-19ATP binding cassette subfamily G member 2 (Junior blood group) [Source:MGI Symbol;Acc:MGI:1 347 061]
Pacrg5.76E-240.51 573 1970.540.3051.86E-19PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Nav26.65E-240.50 495 9320.6720.5262.15E-19neuron navigator 2 [Source:MGI Symbol;Acc:MGI:2 183 691]
Adcy86.82E-240.49 769 6870.4210.2382.20E-19adenylate cyclase 8 [Source:MGI Symbol;Acc:MGI:1 341 110]
Arhgef287.54E-24−0.34171580.3360.4392.43E-19Rho guanine nucleotide exchange factor (GEF) 28 [Source:MGI Symbol;Acc:MGI:1 346 016]
Phka18.43E-24−0.49889370.4710.6452.72E-19phosphorylase kinase alpha 1 [Source:MGI Symbol;Acc:MGI:97 576]
Sorcs21.49E-23−0.40460820.1020.3424.82E-19sortilin-related VPS10 domain containing receptor 2 [Source:MGI Symbol;Acc:MGI:1 932 289]
Fgfr22.62E-23−0.49287160.6960.8268.45E-19fibroblast growth factor receptor 2 [Source:MGI Symbol;Acc:MGI:95 523]
Vegfa2.66E-23−0.44432130.3230.5338.58E-19vascular endothelial growth factor A [Source:MGI Symbol;Acc:MGI:103 178]
Phlpp12.95E-23−0.4415010.670.8059.52E-19PH domain and leucine rich repeat protein phosphatase 1 [Source:MGI Symbol;Acc:MGI:2 138 327]
Agbl43.41E-230.31 829 1360.280.1561.10E-18ATP/GTP binding protein-like 4 [Source:MGI Symbol;Acc:MGI:1 918 244]
Chd93.90E-23−0.39624570.6310.7681.26E-18chromodomain helicase DNA binding protein 9 [Source:MGI Symbol;Acc:MGI:1 924 001]
Syt75.17E-230.29 056 6340.2560.1091.67E-18synaptotagmin VII [Source:MGI Symbol;Acc:MGI:1 859 545]
Pgm55.43E-230.36 064 8080.2080.0371.75E-18phosphoglucomutase 5 [Source:MGI Symbol;Acc:MGI:1 925 668]
Nrcam7.62E-23−0.42771690.6550.8222.46E-18neuronal cell adhesion molecule [Source:MGI Symbol;Acc:MGI:104 750]
Esrrg1.51E-22−0.37881910.3580.4814.87E-18estrogen-related receptor gamma [Source:MGI Symbol;Acc:MGI:1 347 056]
Ski2.23E-220.36 561 5220.3560.1767.19E-18ski sarcoma viral oncogene homolog (avian) [Source:MGI Symbol;Acc:MGI:98 310]
Lrrc93.59E-220.25 188 7780.230.0741.16E-17leucine rich repeat containing 9 [Source:MGI Symbol;Acc:MGI:1 925 507]
Kmt2c4.36E-22−0.40842180.5030.6461.41E-17lysine (K)-specific methyltransferase 2C [Source:MGI Symbol;Acc:MGI:2 444 959]
Cdk175.13E-220.31 776 5450.3640.1951.66E-17cyclin-dependent kinase 17 [Source:MGI Symbol;Acc:MGI:97 517]
Bmp65.80E-220.30 526 8880.1890.0451.87E-17bone morphogenetic protein 6 [Source:MGI Symbol;Acc:MGI:88 182]
Mical26.40E-22−0.40585430.4530.6382.07E-17microtubule associated monooxygenase, calponin and LIM domain containing 2 [Source:MGI Symbol;Acc:MGI:2 444 947]
Shc36.90E-22−0.39790530.1320.3742.23E-17src homology 2 domain-containing transforming protein C3 [Source:MGI Symbol;Acc:MGI:106 179]
Nim1k9.23E-22−0.40655110.1890.4062.98E-17NIM1 serine/threonine protein kinase [Source:MGI Symbol;Acc:MGI:2 442 399]
Egfr1.06E-21−0.44128390.1780.4533.42E-17epidermal growth factor receptor [Source:MGI Symbol;Acc:MGI:95 294]
Ccdc1361.11E-210.34 468 6360.3450.1883.59E-17coiled-coil domain containing 136 [Source:MGI Symbol;Acc:MGI:1 918 128]
9630028H03Rik1.23E-21−0.39854630.0760.2963.96E-17RIKEN cDNA 9630028H03 gene [Source:MGI Symbol;Acc:MGI:2 444 526]
Arhgap61.37E-210.2 759 5590.1670.044.43E-17Rho GTPase activating protein 6 [Source:MGI Symbol;Acc:MGI:1 196 332]
Slc25a211.67E-210.43 983 0650.3670.1365.39E-17solute carrier family 25 (mitochondrial oxodicarboxylate carrier), member 21 [Source:MGI Symbol;Acc:MGI:2 445 059]
Pde10a1.67E-21−0.87998210.1820.3975.39E-17phosphodiesterase 10A [Source:MGI Symbol;Acc:MGI:1 345 143]
Igfbp52.16E-210.35 607 1570.2840.1096.98E-17insulin-like growth factor binding protein 5 [Source:MGI Symbol;Acc:MGI:96 440]
Dmd2.40E-21−0.49480860.6680.8187.75E-17dystrophin, muscular dystrophy [Source:MGI Symbol;Acc:MGI:94 909]
Wwox2.73E-210.661 1160.7310.5318.82E-17WW domain-containing oxidoreductase [Source:MGI Symbol;Acc:MGI:1 931 237]
Flvcr12.88E-210.28 350 7830.180.0589.29E-17feline leukemia virus subgroup C cellular receptor 1 [Source:MGI Symbol;Acc:MGI:2 444 881]
Utrn3.40E-210.56 232 0440.6960.5921.10E-16utrophin [Source:MGI Symbol;Acc:MGI:104 631]
Etv43.67E-21−0.41480610.0260.271.18E-16ets variant 4 [Source:MGI Symbol;Acc:MGI:99 423]
Gabbr24.65E-21−0.48095810.1150.321.50E-16gamma-aminobutyric acid (GABA) B receptor, 2 [Source:MGI Symbol;Acc:MGI:2 386 030]
Tsc22d17.13E-210.30 642 5310.4450.272.30E-16TSC22 domain family, member 1 [Source:MGI Symbol;Acc:MGI:109 127]
Mgat57.30E-210.37 459 7910.5140.3362.36E-16mannoside acetylglucosaminyltransferase 5 [Source:MGI Symbol;Acc:MGI:894 701]
Etnppl8.27E-21−0.4354390.1840.3982.67E-16ethanolamine phosphate phospholyase [Source:MGI Symbol;Acc:MGI:1 919 010]
Kcnj101.83E-20−0.34450520.2150.3515.91E-16potassium inwardly-rectifying channel, subfamily J, member 10 [Source:MGI Symbol;Acc:MGI:1 194 504]
Pbx12.42E-200.45 860 1090.8890.9017.82E-16pre B cell leukemia homeobox 1 [Source:MGI Symbol;Acc:MGI:97 495]
Kif21a2.63E-200.37 637 5380.5920.4158.50E-16kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
F32.75E-20−0.38615180.3950.5368.88E-16coagulation factor III [Source:MGI Symbol;Acc:MGI:88 381]
Itpr24.32E-20−0.38444840.3020.4841.40E-15inositol 1,4,5-triphosphate receptor 2 [Source:MGI Symbol;Acc:MGI:99 418]
Map2k64.93E-20−0.38073380.1610.3731.59E-15mitogen-activated protein kinase kinase 6 [Source:MGI Symbol;Acc:MGI:1 346 870]
Ghr5.27E-20−0.41385010.2930.4861.70E-15growth hormone receptor [Source:MGI Symbol;Acc:MGI:95 708]
Camk1d6.31E-20−0.46280450.4530.6712.04E-15calcium/calmodulin-dependent protein kinase ID [Source:MGI Symbol;Acc:MGI:2 442 190]
Tenm36.32E-200.45 681 2960.7090.5292.04E-15teneurin transmembrane protein 3 [Source:MGI Symbol;Acc:MGI:1 345 183]
Serpine26.56E-20−0.37787130.3120.4892.12E-15serine (or cysteine) peptidase inhibitor, clade E, member 2 [Source:MGI Symbol;Acc:MGI:101 780]
Mpdz8.64E-200.32 366 9020.3250.1642.79E-15multiple PDZ domain crumbs cell polarity complex component [Source:MGI Symbol;Acc:MGI:1 343 489]
Prr168.74E-20−0.38983670.130.3032.82E-15proline rich 16 [Source:MGI Symbol;Acc:MGI:1 918 623]
Sipa1l19.14E-200.31 642 9060.3540.1952.95E-15signal-induced proliferation-associated 1 like 1 [Source:MGI Symbol;Acc:MGI:2 443 679]
9630014M24Rik1.01E-19−0.36049980.0480.2683.25E-15RIKEN cDNA 9630014M24 gene [Source:MGI Symbol;Acc:MGI:3 588 234]
Pcdh11x1.06E-19−0.43014620.2060.4183.43E-15protocadherin 11 X-linked [Source:MGI Symbol;Acc:MGI:2 442 849]
Daam21.24E-19−0.40299570.380.5794.01E-15dishevelled associated activator of morphogenesis 2 [Source:MGI Symbol;Acc:MGI:1 923 691]
Myo5a2.01E-190.31 211 7670.3510.2186.49E-15myosin VA [Source:MGI Symbol;Acc:MGI:105 976]
Ctnnd22.21E-19−0.33544240.9590.9797.13E-15catenin (cadherin associated protein), delta 2 [Source:MGI Symbol;Acc:MGI:1 195 966]
Nkain22.91E-191.07 747 9260.6940.4659.39E-15Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Tprkb5.34E-190.41 617 8930.540.3671.72E-14Tp53rk binding protein [Source:MGI Symbol;Acc:MGI:1 917 036]
St6galnac55.81E-19−0.46329760.050.2511.87E-14ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 5 [Source:MGI Symbol;Acc:MGI:1 349 471]
Wnk26.61E-190.32 581 3630.560.452.14E-14WNK lysine deficient protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 922 857]
Hipk21.04E-18−0.36330730.330.523.34E-14homeodomain interacting protein kinase 2 [Source:MGI Symbol;Acc:MGI:1 314 872]
Paqr81.23E-18−0.4099550.5340.683.96E-14progestin and adipoQ receptor family member VIII [Source:MGI Symbol;Acc:MGI:1 921 479]
Csmd31.59E-18−0.38243580.3170.4425.14E-14CUB and Sushi multiple domains 3 [Source:MGI Symbol;Acc:MGI:2 386 403]
Tril1.66E-18−0.29567320.1130.2585.36E-14TLR4 interactor with leucine-rich repeats [Source:MGI Symbol;Acc:MGI:1 914 123]
Ttc31.97E-180.33 617 4860.720.6146.34E-14tetratricopeptide repeat domain 3 [Source:MGI Symbol;Acc:MGI:1 276 539]
Syn22.93E-18−0.36464740.3770.5119.45E-14synapsin II [Source:MGI Symbol;Acc:MGI:103 020]
Zfp4623.48E-180.41 639 7750.5310.3211.12E-13zinc finger protein 462 [Source:MGI Symbol;Acc:MGI:107 690]
Etv54.64E-18−0.31365220.0980.2871.50E-13ets variant 5 [Source:MGI Symbol;Acc:MGI:1 096 867]
Hif1a4.84E-18−0.2855130.1240.2641.56E-13hypoxia inducible factor 1, alpha subunit [Source:MGI Symbol;Acc:MGI:106 918]
Qk5.84E-18−0.30950920.9050.9521.88E-13NA
Angpt16.03E-180.36 156 7160.3430.1531.95E-13angiopoietin 1 [Source:MGI Symbol;Acc:MGI:108 448]
Ptprz16.17E-18−0.4077510.8130.8971.99E-13protein tyrosine phosphatase, receptor type Z, polypeptide 1 [Source:MGI Symbol;Acc:MGI:97 816]
Pde8b7.34E-18−0.47950910.1930.4292.37E-13phosphodiesterase 8B [Source:MGI Symbol;Acc:MGI:2 443 999]
Paqr68.29E-18−0.25736120.0760.2062.68E-13progestin and adipoQ receptor family member VI [Source:MGI Symbol;Acc:MGI:1 916 207]
Rgs7bp9.33E-18−0.36288870.1540.3423.01E-13regulator of G-protein signalling 7 binding protein [Source:MGI Symbol;Acc:MGI:106 334]
Gm303821.03E-17−0.32001860.0370.1613.32E-13predicted gene, 30 382 [Source:MGI Symbol;Acc:MGI:5 589 541]
Nr3c21.42E-17−0.37639490.4660.6324.59E-13nuclear receptor subfamily 3, group C, member 2 [Source:MGI Symbol;Acc:MGI:99 459]
Gm295141.61E-17−0.31190710.0460.2185.19E-13predicted gene 29 514 [Source:MGI Symbol;Acc:MGI:5 580 220]
Cdh202.29E-17−0.32722130.6230.7157.38E-13cadherin 20 [Source:MGI Symbol;Acc:MGI:1 346 069]
4930545L23Rik2.29E-17−0.31231950.0390.2077.39E-13RIKEN cDNA 4930545L23 gene [Source:MGI Symbol;Acc:MGI:1 926 055]
Tsc22d32.66E-17−0.35317440.1670.3088.58E-13TSC22 domain family, member 3 [Source:MGI Symbol;Acc:MGI:1 196 284]
Mir124-2hg2.83E-17−0.30729330.1110.2879.14E-13Mir124-2 host gene (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 917 691]
Unc5c3.79E-170.51 316 4480.3450.2171.22E-12unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Ralgps23.84E-170.30 587 3090.3470.1761.24E-12Ral GEF with PH domain and SH3 binding motif 2 [Source:MGI Symbol;Acc:MGI:1 925 505]
Naaladl23.86E-170.47 242 1590.5270.3341.25E-12N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Spred13.92E-17−0.35151260.2540.4611.27E-12sprouty protein with EVH-1 domain 1, related sequence [Source:MGI Symbol;Acc:MGI:2 150 016]
Prkce4.64E-170.32 778 0490.5380.3571.50E-12protein kinase C, epsilon [Source:MGI Symbol;Acc:MGI:97 599]
Erbb45.00E-17−0.27353870.5640.561.61E-12erb-b2 receptor tyrosine kinase 4 [Source:MGI Symbol;Acc:MGI:104 771]
Arhgap265.43E-17−0.3746340.3540.5291.75E-12Rho GTPase activating protein 26 [Source:MGI Symbol;Acc:MGI:1 918 552]
Tgfb26.00E-170.27 281 3620.2520.1011.94E-12transforming growth factor, beta 2 [Source:MGI Symbol;Acc:MGI:98 726]
Rfx46.00E-170.50 589 5770.6680.5241.94E-12regulatory factor X, 4 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:1 918 387]
Actr3b6.84E-17−0.30921650.0950.2792.21E-12ARP3 actin-related protein 3B [Source:MGI Symbol;Acc:MGI:2 661 120]
Cacna1c6.97E-170.30 918 3930.2340.1132.25E-12calcium channel, voltage-dependent, L type, alpha 1C subunit [Source:MGI Symbol;Acc:MGI:103 013]
Nrg27.41E-170.40 615 1540.4250.2272.39E-12neuregulin 2 [Source:MGI Symbol;Acc:MGI:1 098 246]
Abcc128.05E-170.27 124 3680.1240.0012.60E-12ATP-binding cassette, sub-family C (CFTR/MRP), member 12 [Source:MGI Symbol;Acc:MGI:2 441 679]
Lhfp1.32E-16−0.44843810.4210.5584.25E-12lipoma HMGIC fusion partner [Source:MGI Symbol;Acc:MGI:1 920 048]
Cdh191.37E-16−0.39954830.4160.6394.42E-12cadherin 19, type 2 [Source:MGI Symbol;Acc:MGI:3 588 198]
Efr3b2.37E-16−0.35896560.2520.4367.66E-12EFR3 homolog B [Source:MGI Symbol;Acc:MGI:2 444 851]
Snrk2.59E-16−0.27634490.130.2768.35E-12SNF related kinase [Source:MGI Symbol;Acc:MGI:108 104]
Nrbp22.67E-160.31 083 0320.3640.1988.61E-12nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Znrf32.68E-16−0.36015180.3490.5418.67E-12zinc and ring finger 3 [Source:MGI Symbol;Acc:MGI:3 039 616]
Slc25a182.73E-16−0.293550.1820.3318.81E-12solute carrier family 25 (mitochondrial carrier), member 18 [Source:MGI Symbol;Acc:MGI:1 919 053]
Frem12.81E-16−0.26884840.0410.1839.07E-12Fras1 related extracellular matrix protein 1 [Source:MGI Symbol;Acc:MGI:2 670 972]
Irak23.22E-16−0.35947760.2840.4621.04E-11interleukin-1 receptor-associated kinase 2 [Source:MGI Symbol;Acc:MGI:2 429 603]
Nnat3.46E-160.49 109 3640.2490.1681.12E-11neuronatin [Source:MGI Symbol;Acc:MGI:104 716]
Robo14.72E-16−0.34446260.3040.4121.52E-11roundabout guidance receptor 1 [Source:MGI Symbol;Acc:MGI:1 274 781]
Macrod15.02E-16−0.27263890.1240.2741.62E-11mono-ADP ribosylhydrolase 1 [Source:MGI Symbol;Acc:MGI:2 147 583]
Tafa56.98E-160.30 683 6790.3950.2362.25E-11TAFA chemokine like family member 5 [Source:MGI Symbol;Acc:MGI:2 146 182]
Hif3a8.85E-16−0.30664720.2280.3992.86E-11hypoxia inducible factor 3, alpha subunit [Source:MGI Symbol;Acc:MGI:1 859 778]
Per31.19E-15−0.27632390.210.3523.83E-11period circadian clock 3 [Source:MGI Symbol;Acc:MGI:1 277 134]
Gm61451.55E-15−0.34107270.4840.6315.01E-11predicted gene 6145 [Source:MGI Symbol;Acc:MGI:3 779 559]
Cdh221.77E-15−0.25025550.0930.1935.71E-11cadherin 22 [Source:MGI Symbol;Acc:MGI:1 341 843]
Itgav2.98E-15−0.30584590.1930.3759.61E-11integrin alpha V [Source:MGI Symbol;Acc:MGI:96 608]
Ripor23.01E-15−0.26244060.0330.1779.73E-11RHO family interacting cell polarization regulator 2 [Source:MGI Symbol;Acc:MGI:2 444 879]
Map1b3.10E-150.33 093 8720.5310.4281.00E-10microtubule-associated protein 1B [Source:MGI Symbol;Acc:MGI:1 306 778]
Stk32a3.37E-150.63 100 5440.410.2261.09E-10serine/threonine kinase 32A [Source:MGI Symbol;Acc:MGI:2 442 403]
Slc7a23.54E-150.38 023 4180.4580.3091.14E-10solute carrier family 7 (cationic amino acid transporter, y + system), member 2 [Source:MGI Symbol;Acc:MGI:99 828]
Pros13.70E-150.26 161 4790.1840.0761.19E-10protein S (alpha) [Source:MGI Symbol;Acc:MGI:1 095 733]
Glul4.09E-15−0.37453610.3930.5971.32E-10glutamate-ammonia ligase (glutamine synthetase) [Source:MGI Symbol;Acc:MGI:95 739]
Washc24.58E-15−0.29666350.20.3591.48E-10WASH complex subunit 2 [Source:MGI Symbol;Acc:MGI:106 463]
Sat14.69E-15−0.32853420.260.4161.52E-10spermidine/spermine N1-acetyl transferase 1 [Source:MGI Symbol;Acc:MGI:98 233]
Man1a5.06E-150.25 671 6970.2170.091.63E-10mannosidase 1, alpha [Source:MGI Symbol;Acc:MGI:104 677]
Cap25.07E-15−0.29239790.1610.3331.64E-10CAP, adenylate cyclase-associated protein, 2 (yeast) [Source:MGI Symbol;Acc:MGI:1 914 502]
Pla2g75.26E-15−0.32651650.4160.5951.70E-10phospholipase A2, group VII (platelet-activating factor acetylhydrolase, plasma) [Source:MGI Symbol;Acc:MGI:1 351 327]
Cdh25.37E-15−0.35713410.4620.6291.73E-10cadherin 2 [Source:MGI Symbol;Acc:MGI:88 355]
Prex28.14E-15−0.42284340.7050.8262.63E-10phosphatidylinositol-3,4,5-trisphosphate-dependent Rac exchange factor 2 [Source:MGI Symbol;Acc:MGI:1 923 385]
Tmcc39.77E-15−0.30733460.4430.5673.16E-10transmembrane and coiled coil domains 3 [Source:MGI Symbol;Acc:MGI:2 442 900]
Spag91.02E-14−0.30034320.5860.6963.28E-10sperm associated antigen 9 [Source:MGI Symbol;Acc:MGI:1 918 084]
Adcy21.06E-140.29 525 0120.5770.4873.41E-10adenylate cyclase 2 [Source:MGI Symbol;Acc:MGI:99 676]
Gli31.10E-14−0.33010320.5420.6923.55E-10GLI-Kruppel family member GLI3 [Source:MGI Symbol;Acc:MGI:95 729]
Hmgn31.10E-14−0.30435120.1410.3243.57E-10high mobility group nucleosomal binding domain 3 [Source:MGI Symbol;Acc:MGI:2 138 069]
Ldlrad41.19E-14−0.31893250.2130.3563.84E-10low density lipoprotein receptor class A domain containing 4 [Source:MGI Symbol;Acc:MGI:1 277 150]
Eps151.28E-14−0.29645940.4620.6064.14E-10epidermal growth factor receptor pathway substrate 15 [Source:MGI Symbol;Acc:MGI:104 583]
Gli21.39E-14−0.32220330.2840.4594.47E-10GLI-Kruppel family member GLI2 [Source:MGI Symbol;Acc:MGI:95 728]
Dock11.56E-14−0.32618150.5230.6735.04E-10dedicator of cytokinesis 1 [Source:MGI Symbol;Acc:MGI:2 429 765]
Sox2ot1.64E-14−0.33052370.4340.5045.30E-10SOX2 overlapping transcript (non-protein coding) [Source:MGI Symbol;Acc:MGI:2 444 112]
Cnn31.70E-140.28 344 2520.3170.1945.50E-10calponin 3, acidic [Source:MGI Symbol;Acc:MGI:1 919 244]
Ttyh11.92E-14−0.29267970.6050.7186.19E-10tweety family member 1 [Source:MGI Symbol;Acc:MGI:1 889 007]
Gm442572.12E-14−0.26098730.0330.1976.85E-10predicted gene, 44 257 [Source:MGI Symbol;Acc:MGI:5 690 649]
Adamts202.16E-140.29 924 1810.2730.1486.97E-10a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 20 [Source:MGI Symbol;Acc:MGI:2 660 628]
Dclk22.20E-140.30 007 3780.4190.2677.11E-10doublecortin-like kinase 2 [Source:MGI Symbol;Acc:MGI:1 918 012]
Cacna1a2.21E-140.25 941 8020.3190.1927.14E-10calcium channel, voltage-dependent, P/Q type, alpha 1A subunit [Source:MGI Symbol;Acc:MGI:109 482]
Plekha52.37E-140.28 678 2280.3560.2177.64E-10pleckstrin homology domain containing, family A member 5 [Source:MGI Symbol;Acc:MGI:1 923 802]
Kifc32.45E-14−0.25976760.1610.3177.90E-10kinesin family member C3 [Source:MGI Symbol;Acc:MGI:109 202]
Lgr62.51E-14−0.2593910.0240.1568.11E-10leucine-rich repeat-containing G protein-coupled receptor 6 [Source:MGI Symbol;Acc:MGI:2 441 805]
Eda2.59E-140.32 338 3020.3620.2228.37E-10ectodysplasin-A [Source:MGI Symbol;Acc:MGI:1 195 272]
Ccdc1622.67E-140.31 699 3020.2690.1248.61E-10coiled-coil domain containing 162 [Source:MGI Symbol;Acc:MGI:1 923 223]
Arid5b3.24E-140.2 963 0380.2820.151.04E-09AT rich interactive domain 5B (MRF1-like) [Source:MGI Symbol;Acc:MGI:2 175 912]
Garem13.77E-14−0.36059850.2540.4491.22E-09GRB2 associated regulator of MAPK1 subtype 1 [Source:MGI Symbol;Acc:MGI:2 685 790]
Arhgap53.93E-14−0.33484380.6620.7571.27E-09Rho GTPase activating protein 5 [Source:MGI Symbol;Acc:MGI:1 332 637]
Immp2l3.95E-140.31 435 5180.330.1941.27E-09IMP2 inner mitochondrial membrane peptidase-like (S. cerevisiae) [Source:MGI Symbol;Acc:MGI:2 135 611]
Aldoc4.99E-14−0.25647490.3560.4761.61E-09aldolase C, fructose-bisphosphate [Source:MGI Symbol;Acc:MGI:101 863]
Grip15.24E-14−0.3209810.1240.2691.69E-09glutamate receptor interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 921 303]
Fgf15.34E-14−0.27476260.1970.3461.73E-09fibroblast growth factor 1 [Source:MGI Symbol;Acc:MGI:95 515]
App5.83E-140.32 161 6870.6550.531.88E-09amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Wipf16.20E-14−0.28437770.1390.2542.00E-09WAS/WASL interacting protein family, member 1 [Source:MGI Symbol;Acc:MGI:2 178 801]
Cyfip17.55E-14−0.27023090.2190.3672.44E-09cytoplasmic FMR1 interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 338 801]
Gnao18.00E-14−0.54154020.5940.6752.58E-09guanine nucleotide binding protein, alpha O [Source:MGI Symbol;Acc:MGI:95 775]
Ccdc1418.02E-14−0.29317220.3410.4542.59E-09coiled-coil domain containing 141 [Source:MGI Symbol;Acc:MGI:1 919 735]
Stard138.21E-140.4 152 6490.5550.3882.65E-09StAR-related lipid transfer (START) domain containing 13 [Source:MGI Symbol;Acc:MGI:2 385 331]
Fut98.62E-14−0.3228330.5380.662.78E-09fucosyltransferase 9 [Source:MGI Symbol;Acc:MGI:1 330 859]
Sycp29.81E-14−0.26892640.1040.2673.17E-09synaptonemal complex protein 2 [Source:MGI Symbol;Acc:MGI:1 933 281]
Tox1.04E-13−0.37116680.2990.5143.36E-09thymocyte selection-associated high mobility group box [Source:MGI Symbol;Acc:MGI:2 181 659]
Eif4g31.08E-13−0.32461490.4010.5713.48E-09eukaryotic translation initiation factor 4 gamma, 3 [Source:MGI Symbol;Acc:MGI:1 923 935]
Stat31.34E-130.27 159 3520.3060.1534.34E-09signal transducer and activator of transcription 3 [Source:MGI Symbol;Acc:MGI:103 038]
Sned11.48E-130.2 999 9790.3470.24.78E-09sushi, nidogen and EGF-like domains 1 [Source:MGI Symbol;Acc:MGI:3 045 960]
Usp541.72E-13−0.2713570.2060.3455.55E-09ubiquitin specific peptidase 54 [Source:MGI Symbol;Acc:MGI:1 926 037]
Tle42.16E-13−0.31412170.2490.4416.97E-09transducin-like enhancer of split 4 [Source:MGI Symbol;Acc:MGI:104 633]
Dbx22.45E-13−0.25818290.2210.3587.91E-09developing brain homeobox 2 [Source:MGI Symbol;Acc:MGI:107 445]
Btbd92.62E-130.31 317 4530.5080.3468.47E-09BTB (POZ) domain containing 9 [Source:MGI Symbol;Acc:MGI:1 916 625]
Fam214a2.90E-13−0.27770730.2130.3549.37E-09NA
Cachd13.12E-130.33 962 3370.4770.3271.01E-08cache domain containing 1 [Source:MGI Symbol;Acc:MGI:2 444 177]
Fnbp13.31E-13−0.29308250.6360.7341.07E-08formin binding protein 1 [Source:MGI Symbol;Acc:MGI:109 606]
Pid13.41E-13−0.31881280.3470.5121.10E-08phosphotyrosine interaction domain containing 1 [Source:MGI Symbol;Acc:MGI:2 138 391]
Id43.49E-130.36 185 5740.4620.2821.13E-08inhibitor of DNA binding 4 [Source:MGI Symbol;Acc:MGI:99 414]
Chst113.52E-130.31 210 5770.4120.2621.14E-08carbohydrate sulfotransferase 11 [Source:MGI Symbol;Acc:MGI:1 927 166]
Atl24.05E-13−0.26108010.3040.4241.31E-08atlastin GTPase 2 [Source:MGI Symbol;Acc:MGI:1 929 492]
Dpf35.01E-13−0.29100540.2650.4261.62E-08double PHD fingers 3 [Source:MGI Symbol;Acc:MGI:1 917 377]
Arrb15.31E-13−0.25373280.180.3391.71E-08arrestin, beta 1 [Source:MGI Symbol;Acc:MGI:99 473]
Fam155a5.80E-130.69 052 6150.4840.2871.87E-08NA
Zfhx47.06E-130.3 268 6590.3560.232.28E-08zinc finger homeodomain 4 [Source:MGI Symbol;Acc:MGI:2 137 668]
Fgf147.06E-130.39 407 1390.8630.7582.28E-08fibroblast growth factor 14 [Source:MGI Symbol;Acc:MGI:109 189]
Hivep37.55E-13−0.32663020.5750.7292.44E-08human immunodeficiency virus type I enhancer binding protein 3 [Source:MGI Symbol;Acc:MGI:106 589]
Fermt28.05E-13−0.29984070.3410.5012.60E-08fermitin family member 2 [Source:MGI Symbol;Acc:MGI:2 385 001]
Rnf2208.48E-13−0.29992290.1020.1932.74E-08ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Rmst1.07E-120.52 794 9370.8030.7583.47E-08rhabdomyosarcoma 2 associated transcript (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 099 806]
Dnm31.48E-120.3 694 3220.490.3064.77E-08dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Gulp11.67E-12−0.27018140.150.2955.38E-08GULP, engulfment adaptor PTB domain containing 1 [Source:MGI Symbol;Acc:MGI:1 920 407]
Prkn1.96E-120.42 415 9410.7350.66.32E-08parkin RBR E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 355 296]
Hivep22.85E-12−0.30008690.4010.5449.21E-08human immunodeficiency virus type I enhancer binding protein 2 [Source:MGI Symbol;Acc:MGI:1 338 076]
Agl2.91E-12−0.25301560.2820.419.40E-08amylo-1,6-glucosidase, 4-alpha-glucanotransferase [Source:MGI Symbol;Acc:MGI:1 924 809]
Astn23.41E-120.43 229 7550.590.5141.10E-07astrotactin 2 [Source:MGI Symbol;Acc:MGI:1 889 277]
Abi13.62E-12−0.26955890.3340.4761.17E-07abl interactor 1 [Source:MGI Symbol;Acc:MGI:104 913]
Enah4.34E-12−0.29490060.5570.6891.40E-07ENAH actin regulator [Source:MGI Symbol;Acc:MGI:108 360]
Tmem1645.37E-12−0.32205140.3560.5141.74E-07transmembrane protein 164 [Source:MGI Symbol;Acc:MGI:2 148 020]
Aco25.41E-12−0.2500020.2950.4341.75E-07aconitase 2, mitochondrial [Source:MGI Symbol;Acc:MGI:87 880]
Dlgap15.65E-12−0.32803280.7250.8471.82E-07DLG associated protein 1 [Source:MGI Symbol;Acc:MGI:1 346 065]
Cpeb35.85E-12−0.27077850.4380.5531.89E-07cytoplasmic polyadenylation element binding protein 3 [Source:MGI Symbol;Acc:MGI:2 443 075]
Nfib7.15E-12−0.27996810.740.8212.31E-07nuclear factor I/B [Source:MGI Symbol;Acc:MGI:103 188]
Iqsec28.06E-120.25 033 8210.3360.1962.60E-07IQ motif and Sec7 domain 2 [Source:MGI Symbol;Acc:MGI:3 528 396]
Shisa68.24E-12−0.25758450.10.1592.66E-07shisa family member 6 [Source:MGI Symbol;Acc:MGI:2 685 725]
Nfkb18.60E-120.31 729 2130.4510.3092.78E-07nuclear factor of kappa light polypeptide gene enhancer in B cells 1, p105 [Source:MGI Symbol;Acc:MGI:97 312]
Myo18a9.58E-12−0.26612360.2320.3853.09E-07myosin XVIIIA [Source:MGI Symbol;Acc:MGI:2 667 185]
Ugp21.08E-110.26 792 9520.5160.3723.49E-07UDP-glucose pyrophosphorylase 2 [Source:MGI Symbol;Acc:MGI:2 183 447]
Enpp21.36E-110.30 137 9840.410.2424.40E-07ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
Frmpd11.37E-11−0.27250150.2540.4044.42E-07FERM and PDZ domain containing 1 [Source:MGI Symbol;Acc:MGI:2 446 274]
Ano62.02E-110.28 037 3710.2690.1426.53E-07anoctamin 6 [Source:MGI Symbol;Acc:MGI:2 145 890]
Tcf252.14E-11−0.25243530.4950.6256.92E-07transcription factor 25 (basic helix-loop-helix) [Source:MGI Symbol;Acc:MGI:1 914 105]
Sel1l32.21E-110.25 017 1740.20.1017.13E-07sel-1 suppressor of lin-12-like 3 (C. elegans) [Source:MGI Symbol;Acc:MGI:1 916 941]
Pigk2.24E-11−0.31922570.1080.2577.24E-07phosphatidylinositol glycan anchor biosynthesis, class K [Source:MGI Symbol;Acc:MGI:1 913 863]
Meis22.39E-110.28 700 8230.7220.647.73E-07Meis homeobox 2 [Source:MGI Symbol;Acc:MGI:108 564]
Clmn2.43E-11−0.37419370.3380.5017.85E-07calmin [Source:MGI Symbol;Acc:MGI:2 136 957]
Pard3b2.59E-110.36 304 2810.6770.578.37E-07par-3 family cell polarity regulator beta [Source:MGI Symbol;Acc:MGI:1 919 301]
Zfhx32.74E-110.44 295 7930.5180.3638.84E-07zinc finger homeobox 3 [Source:MGI Symbol;Acc:MGI:99 948]
Bcan2.75E-11−0.25547580.5570.6498.87E-07brevican [Source:MGI Symbol;Acc:MGI:1 096 385]
Acss13.09E-11−0.25673650.2430.3979.98E-07acyl-CoA synthetase short-chain family member 1 [Source:MGI Symbol;Acc:MGI:1 915 988]
Adk3.22E-11−0.28200380.6570.7661.04E-06adenosine kinase [Source:MGI Symbol;Acc:MGI:87 930]
Clasp24.17E-11−0.27344010.5990.6911.35E-06CLIP associating protein 2 [Source:MGI Symbol;Acc:MGI:1 923 749]
Alcam5.04E-11−0.32091160.3640.5191.63E-06activated leukocyte cell adhesion molecule [Source:MGI Symbol;Acc:MGI:1 313 266]
Cspp15.14E-110.26 083 5650.4860.3481.66E-06centrosome and spindle pole associated protein 1 [Source:MGI Symbol;Acc:MGI:2 681 832]
Plpp35.22E-11−0.3177850.6960.7881.68E-06phospholipid phosphatase 3 [Source:MGI Symbol;Acc:MGI:1 915 166]
Megf105.80E-11−0.25197490.280.4191.87E-06multiple EGF-like-domains 10 [Source:MGI Symbol;Acc:MGI:2 685 177]
Gphn6.45E-11−0.26894960.8740.9112.08E-06gephyrin [Source:MGI Symbol;Acc:MGI:109 602]
Fus6.61E-110.25 396 1730.5160.3762.13E-06fused in sarcoma [Source:MGI Symbol;Acc:MGI:1 353 633]
Wwc18.27E-11−0.26592630.4120.5382.67E-06WW, C2 and coiled-coil domain containing 1 [Source:MGI Symbol;Acc:MGI:2 388 637]
Lrrc4c8.56E-11−0.44154730.8940.9012.76E-06leucine rich repeat containing 4C [Source:MGI Symbol;Acc:MGI:2 442 636]
Rorb1.46E-10−0.32772560.7460.8574.71E-06RAR-related orphan receptor beta [Source:MGI Symbol;Acc:MGI:1 343 464]
Sgip11.72E-10−0.28270460.6250.7265.55E-06SH3-domain GRB2-like (endophilin) interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 920 344]
Gm487421.76E-10−0.25864250.230.3675.69E-06predicted gene, 48 742 [Source:MGI Symbol;Acc:MGI:6 098 410]
Ttc282.09E-100.28 895 9350.4970.3736.76E-06tetratricopeptide repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 140 873]
Igsf112.14E-100.28 984 7290.4920.3536.90E-06immunoglobulin superfamily, member 11 [Source:MGI Symbol;Acc:MGI:2 388 477]
Fbxl72.42E-100.30 362 5530.2150.0827.83E-06F-box and leucine-rich repeat protein 7 [Source:MGI Symbol;Acc:MGI:3 052 506]
Lama22.60E-10−0.31068160.6160.7188.39E-06laminin, alpha 2 [Source:MGI Symbol;Acc:MGI:99 912]
Camk2n12.74E-10−0.27324110.2690.4598.84E-06calcium/calmodulin-dependent protein kinase II inhibitor 1 [Source:MGI Symbol;Acc:MGI:1 913 509]
Spire13.03E-10−0.26781420.5510.6729.78E-06spire type actin nucleation factor 1 [Source:MGI Symbol;Acc:MGI:1 915 416]
Thrb3.43E-10−0.26550690.6160.6761.11E-05thyroid hormone receptor beta [Source:MGI Symbol;Acc:MGI:98 743]
Grid13.76E-10−0.27218740.2750.4451.21E-05glutamate receptor, ionotropic, delta 1 [Source:MGI Symbol;Acc:MGI:95 812]
Dst3.99E-100.33 094 5720.6880.6351.29E-05dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Lhfpl35.06E-100.52 784 1760.4380.2881.63E-05lipoma HMGIC fusion partner-like 3 [Source:MGI Symbol;Acc:MGI:1 925 076]
Lrmda5.92E-10−0.33622630.2190.361.91E-05leucine rich melanocyte differentiation associated [Source:MGI Symbol;Acc:MGI:1 923 883]
Slc9a91.26E-090.27 808 9960.4880.3734.08E-05solute carrier family 9 (sodium/hydrogen exchanger), member 9 [Source:MGI Symbol;Acc:MGI:2 679 732]
Mapk101.51E-09−0.26380080.5680.6624.87E-05mitogen-activated protein kinase 10 [Source:MGI Symbol;Acc:MGI:1 346 863]
B3galt12.00E-09−0.26546690.8610.9196.45E-05UDP-Gal:betaGlcNAc beta 1,3-galactosyltransferase, polypeptide 1 [Source:MGI Symbol;Acc:MGI:1 349 403]
Ddah12.19E-09−0.25509760.2170.3817.07E-05dimethylarginine dimethylaminohydrolase 1 [Source:MGI Symbol;Acc:MGI:1 916 469]
Smyd33.06E-090.30 146 9810.5120.3619.89E-05SET and MYND domain containing 3 [Source:MGI Symbol;Acc:MGI:1 916 976]
Pde4d3.57E-090.49 104 4540.8160.7410.00 011 538phosphodiesterase 4D, cAMP specific [Source:MGI Symbol;Acc:MGI:99 555]
Prdx63.89E-090.28 389 0770.640.5270.00 012 564peroxiredoxin 6 [Source:MGI Symbol;Acc:MGI:894 320]
Ankrd283.94E-090.27 308 2010.4790.3550.0 001 273ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Map4k44.15E-090.25 600 6240.5180.4170.00 013 397mitogen-activated protein kinase kinase kinase kinase 4 [Source:MGI Symbol;Acc:MGI:1 349 394]
Acss34.20E-090.26 918 8530.3210.1890.00 013 546acyl-CoA synthetase short-chain family member 3 [Source:MGI Symbol;Acc:MGI:2 685 720]
Dock74.82E-090.27 946 9240.4080.2920.00 015 556dedicator of cytokinesis 7 [Source:MGI Symbol;Acc:MGI:1 914 549]
Bcl28.22E-090.25 489 8510.4080.3380.00 026 533B cell leukemia/lymphoma 2 [Source:MGI Symbol;Acc:MGI:88 138]
4930488L21Rik1.21E-08−0.31219660.1430.2830.00 039 211RIKEN cDNA 4930488L21 gene [Source:MGI Symbol;Acc:MGI:1 923 059]
Fhit2.18E-080.40 458 5420.5530.3880.00 070 321fragile histidine triad gene [Source:MGI Symbol;Acc:MGI:1 277 947]
Ank2.18E-080.32 658 1310.5120.4220.00 070 377progressive ankylosis [Source:MGI Symbol;Acc:MGI:3 045 421]
Fam13c3.14E-08−0.25229780.150.2780.00 101 426family with sequence similarity 13, member C [Source:MGI Symbol;Acc:MGI:1 918 971]
Thsd7a3.44E-080.31 348 4940.4510.3030.00 111 155thrombospondin, type I, domain containing 7A [Source:MGI Symbol;Acc:MGI:2 685 683]
Epha54.54E-080.30 165 5980.5420.3820.00 146 634Eph receptor A5 [Source:MGI Symbol;Acc:MGI:99 654]
Phactr15.31E-08−0.27994040.3320.4980.00 171 272phosphatase and actin regulator 1 [Source:MGI Symbol;Acc:MGI:2 659 021]
Inpp4b9.18E-080.25 348 1230.2650.1510.00 296 391inositol polyphosphate-4-phosphatase, type II [Source:MGI Symbol;Acc:MGI:2 158 925]

Among the enriched biological terms associated with the upregulated genes are neuron and cell differentiation, regulation of cell migration, cell junction organization, and protein binding. Additionally, enriched biological functions unique to AG2 and not observed in AG1 included astrocyte end-foot, T-tubule, actin filament organization, and regulation of cell migration.

Moreover, we identified 16 TFs (only 1 shared with AG1 population) found upregulated, including Glis3, Stat3, Smad6, Atoh8, Arid5b, Nfkb1 and Id3.

Complement component 3 (C3) was exclusively expressed in AG2 of spinal cord. GFAP/C3-positive astrocytes subpopulations have been reported in numerous brain samples from neurodegenerative disease patients such as Alzheimer's disease, multiple sclerosis, Huntington's disease, Parkinson's disease, and ALS [67, 95, 96].

The expression of Gfap and other accompanying markers links AG2 with the Gfap positive astrocyte population reported in previous studies and described as an activated-state glial population in normal physiological conditions, and reactive astrocytes in disease [64, 67, 97, 98, 80].

Identification of a large astrocytic population related with mature astrocyte functions

AG 3, by comparison, was the largest and most heterogeneous. Each AG3 was comprised on average by three clusters on each sample indicating intra-specimen heterogeneity, with a high similarity score and bound tightly together in the similarity graph (Fig. 3B). We found 158 genes significantly overexpressed (P-value < 0.005) in contrast to AG1 and AG2 (Table 3). Biological term enrichment and ontology analysis of upregulated genes uncover functions such as post synapse, neuron projection, synaptic membrane, glutamatergic synapse, neuron to neuron synapse, postsynaptic specialization, and postsynaptic density.

Table 3.

Differentially upregulated genes (P-value < 0.005) in AG 3 in comparison with AG1 and AG2

Genep_valavg_log2FCpct.1pct.2p_val_adjdescription
St6galnac31.53E-241−1.59362790.0990.5374.95E-237ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Ablim21.04E-231−1.64232250.1320.4723.36E-227actin-binding LIM protein 2 [Source:MGI Symbol;Acc:MGI:2 385 758]
Nkain21.31E-205−1.78428380.4360.7114.24E-201Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Gpc53.70E-1561.4 386 1110.9850.6551.19E-151glypican 5 [Source:MGI Symbol;Acc:MGI:1 194 894]
Lsamp2.79E-1491.03 552 76610.9969.01E-145limbic system-associated membrane protein [Source:MGI Symbol;Acc:MGI:1 261 760]
Pkp48.39E-146−1.0036560.2150.542.71E-141plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Gfap4.94E-145−1.44464860.2080.5361.60E-140glial fibrillary acidic protein [Source:MGI Symbol;Acc:MGI:95 697]
Prune24.16E-140−1.05526780.1270.4761.34E-135prune homolog 2 [Source:MGI Symbol;Acc:MGI:1 925 004]
Grik22.62E-136−1.16448380.4440.7458.45E-132glutamate receptor, ionotropic, kainate 2 (beta 2) [Source:MGI Symbol;Acc:MGI:95 815]
Prr5l2.29E-127−1.00589180.050.3527.38E-123proline rich 5 like [Source:MGI Symbol;Acc:MGI:1 919 696]
Slc8a11.72E-121−1.01436890.2180.5235.56E-117solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Trpm31.51E-1171.51 328 0140.9520.5634.88E-113transient receptor potential cation channel, subfamily M, member 3 [Source:MGI Symbol;Acc:MGI:2 443 101]
Sorbs22.64E-116−1.16436880.1720.4678.53E-112sorbin and SH3 domain containing 2 [Source:MGI Symbol;Acc:MGI:1 924 574]
Gm37641.75E-1120.96 079 9840.9520.7495.65E-108predicted gene 3764 [Source:MGI Symbol;Acc:MGI:3 781 938]
Adamtsl14.27E-109−0.84474680.020.3161.38E-104ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
Cacnb24.88E-109−1.14120210.2510.5281.58E-104calcium channel, voltage-dependent, beta 2 subunit [Source:MGI Symbol;Acc:MGI:894 644]
Kirrel33.05E-1081.28 033 1720.890.5289.85E-104kirre like nephrin family adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 914 953]
Mdga28.42E-950.93 802 8950.9790.852.72E-90MAM domain containing glycosylphosphatidylinositol anchor 2 [Source:MGI Symbol;Acc:MGI:2 444 706]
Cobll14.35E-94−0.59498850.0440.3181.41E-89Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Slc38a11.99E-92−0.89661440.2320.5076.42E-88solute carrier family 38, member 1 [Source:MGI Symbol;Acc:MGI:2 145 895]
Ccdc1484.14E-92−0.78608480.0530.2911.34E-87coiled-coil domain containing 148 [Source:MGI Symbol;Acc:MGI:3 039 583]
Nrxn14.43E-920.87 728 2530.9980.911.43E-87neurexin I [Source:MGI Symbol;Acc:MGI:1 096 391]
Plcb11.88E-911.13 264 8610.9510.7486.07E-87phospholipase C, beta 1 [Source:MGI Symbol;Acc:MGI:97 613]
A2m4.93E-90−0.88175570.0650.2981.59E-85alpha-2-macroglobulin [Source:MGI Symbol;Acc:MGI:2 449 119]
Tmeff26.26E-89−0.85731650.1580.3532.02E-84transmembrane protein with EGF-like and two follistatin-like domains 2 [Source:MGI Symbol;Acc:MGI:1 861 735]
Dgki8.89E-87−0.77686950.2210.5362.87E-82diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Kcnd21.16E-841.29 103 5480.720.443.74E-80potassium voltage-gated channel, Shal-related family, member 2 [Source:MGI Symbol;Acc:MGI:102 663]
Pdzrn31.83E-84−0.6136950.0840.3725.89E-80PDZ domain containing RING finger 3 [Source:MGI Symbol;Acc:MGI:1 933 157]
Slc24a22.21E-83−0.89372330.3150.4277.15E-79solute carrier family 24 (sodium/potassium/calcium exchanger), member 2 [Source:MGI Symbol;Acc:MGI:1 923 626]
Gria25.83E-830.91 744 6170.7750.4931.88E-78glutamate receptor, ionotropic, AMPA2 (alpha 2) [Source:MGI Symbol;Acc:MGI:95 809]
Grm71.28E-82−0.85193080.2120.4364.12E-78glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Gm207132.19E-810.85 012 0780.7270.2837.08E-77predicted gene 20 713 [Source:MGI Symbol;Acc:MGI:5 313 160]
Cadps1.18E-80−0.81690650.2990.5713.79E-76Ca2+-dependent secretion activator [Source:MGI Symbol;Acc:MGI:1 350 922]
Rora2.23E-780.80 516 0940.9910.9597.20E-74RAR-related orphan receptor alpha [Source:MGI Symbol;Acc:MGI:104 661]
Kcnj31.93E-77−0.69385630.1580.4536.24E-73potassium inwardly-rectifying channel, subfamily J, member 3 [Source:MGI Symbol;Acc:MGI:104 742]
Slc6a112.45E-770.82 740 9090.5970.3027.92E-73solute carrier family 6 (neurotransmitter transporter, GABA), member 11 [Source:MGI Symbol;Acc:MGI:95 630]
Gm149645.63E-76−0.58123850.1540.4031.82E-71predicted gene 14 964 [Source:MGI Symbol;Acc:MGI:3 641 621]
Slc7a108.30E-750.80 503 3510.570.1722.68E-70solute carrier family 7 (cationic amino acid transporter, y + system), member 10 [Source:MGI Symbol;Acc:MGI:1 858 261]
Ccdc31.94E-73−0.56467980.020.2446.25E-69coiled-coil domain containing 3 [Source:MGI Symbol;Acc:MGI:1 921 436]
Prickle28.03E-73−0.7091480.3450.6072.59E-68prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
Brinp31.40E-700.82 937 7710.7160.3534.52E-66bone morphogenetic protein/retinoic acid inducible neural specific 3 [Source:MGI Symbol;Acc:MGI:2 443 035]
Pex5l1.61E-70−0.83276840.1830.3295.20E-66peroxisomal biogenesis factor 5-like [Source:MGI Symbol;Acc:MGI:1 916 672]
Prkca2.52E-70−0.77768890.5510.7528.12E-66protein kinase C, alpha [Source:MGI Symbol;Acc:MGI:97 595]
Asap37.08E-70−0.45261050.0250.2392.29E-65ArfGAP with SH3 domain, ankyrin repeat and PH domain 3 [Source:MGI Symbol;Acc:MGI:2 684 986]
St188.32E-70−0.70185880.0630.2252.69E-65suppression of tumorigenicity 18 [Source:MGI Symbol;Acc:MGI:2 446 700]
Ldb21.58E-69−0.57966620.1140.3595.09E-65LIM domain binding 2 [Source:MGI Symbol;Acc:MGI:894 670]
Edil32.54E-69−0.689130.1780.3628.21E-65EGF-like repeats and discoidin I-like domains 3 [Source:MGI Symbol;Acc:MGI:1 329 025]
Unc5c5.97E-68−0.73579040.1820.421.93E-63unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Gm122399.70E-681.08 440 5170.5810.2423.13E-63predicted gene 12 239 [Source:MGI Symbol;Acc:MGI:3 651 547]
C4b1.35E-67−0.51007120.0660.3124.35E-63complement component 4B (Chido blood group) [Source:MGI Symbol;Acc:MGI:88 228]
Tmem1082.42E-67−0.5227890.0430.2457.80E-63transmembrane protein 108 [Source:MGI Symbol;Acc:MGI:1 932 411]
Dock102.55E-66−0.6171340.1050.2668.24E-62dedicator of cytokinesis 10 [Source:MGI Symbol;Acc:MGI:2 146 320]
Gm48761.07E-65−0.61758020.1280.3683.45E-61predicted gene 4876 [Source:MGI Symbol;Acc:MGI:3 647 654]
Sulf21.90E-64−0.42984590.0340.2386.14E-60sulfatase 2 [Source:MGI Symbol;Acc:MGI:1 919 293]
Col23a12.45E-64−0.8123560.1120.347.92E-60collagen, type XXIII, alpha 1 [Source:MGI Symbol;Acc:MGI:2 653 243]
Prkag26.39E-63−0.56851360.1560.3762.06E-58protein kinase, AMP-activated, gamma 2 non-catalytic subunit [Source:MGI Symbol;Acc:MGI:1 336 153]
Ctnna22.00E-61−0.85708440.6690.8096.45E-57catenin (cadherin associated protein), alpha 2 [Source:MGI Symbol;Acc:MGI:88 275]
Myoc1.78E-60−0.57942840.0110.1885.74E-56myocilin [Source:MGI Symbol;Acc:MGI:1 202 864]
Enpp22.58E-60−0.52837730.2120.4538.33E-56ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
Frmd56.05E-60−0.67540120.1030.2551.95E-55FERM domain containing 5 [Source:MGI Symbol;Acc:MGI:2 442 557]
Sema6a9.70E-60−0.41414330.0590.2833.13E-55sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
Arhgef41.15E-59−0.73589960.5650.6973.70E-55Rho guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:2 442 507]
Zfp5365.69E-59−0.52649440.0440.2041.84E-54zinc finger protein 536 [Source:MGI Symbol;Acc:MGI:1 926 102]
Enox11.09E-58−0.71177450.2490.5043.51E-54ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Pakap8.14E-57−0.4203850.0330.2142.63E-52paralemmin A kinase anchor protein [Source:MGI Symbol;Acc:MGI:5 141 924]
Man1c11.77E-56−0.46972530.0590.2565.71E-52mannosidase, alpha, class 1C, member 1 [Source:MGI Symbol;Acc:MGI:2 446 214]
Nrp22.58E-56−0.39141450.0430.2368.32E-52neuropilin 2 [Source:MGI Symbol;Acc:MGI:1 100 492]
Csmd14.93E-56−0.59264430.3860.5441.59E-51CUB and Sushi multiple domains 1 [Source:MGI Symbol;Acc:MGI:2 137 383]
Nhsl17.81E-560.7 363 4140.7370.4432.52E-51NHS-like 1 [Source:MGI Symbol;Acc:MGI:106 390]
Cd443.70E-55−0.4325580.0220.1981.19E-50CD44 antigen [Source:MGI Symbol;Acc:MGI:88 338]
Dnm31.96E-54−0.56683620.2810.5116.32E-50dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Pde4b2.27E-54−0.7656010.5480.5067.32E-50phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Atp1a26.26E-540.67 797 4270.9380.8112.02E-49ATPase, Na+/K + transporting, alpha 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 106]
Pacrg7.92E-54−0.61658490.2790.5472.56E-49PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Rgs71.69E-530.75 771 7180.6530.3425.44E-49regulator of G protein signaling 7 [Source:MGI Symbol;Acc:MGI:1 346 089]
Pitpnc11.79E-530.77 375 0720.9160.7615.79E-49phosphatidylinositol transfer protein, cytoplasmic 1 [Source:MGI Symbol;Acc:MGI:1 919 045]
Pde7b2.22E-530.75 004 2570.7130.3797.18E-49phosphodiesterase 7B [Source:MGI Symbol;Acc:MGI:1 352 752]
Sorbs14.64E-53−0.70896350.6330.7791.50E-48sorbin and SH3 domain containing 1 [Source:MGI Symbol;Acc:MGI:700 014]
Kif21a6.38E-53−0.4973930.3880.6232.06E-48kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
Ccser19.85E-53−0.65703470.2760.4463.18E-48coiled-coil serine rich 1 [Source:MGI Symbol;Acc:MGI:3 045 354]
Adgrb31.78E-520.71 451 4760.960.895.76E-48adhesion G protein-coupled receptor B3 [Source:MGI Symbol;Acc:MGI:2 441 837]
Sntg24.21E-52−0.34334370.0150.1911.36E-47syntrophin, gamma 2 [Source:MGI Symbol;Acc:MGI:1 919 541]
Mbp6.86E-52−0.5974130.3760.5132.21E-47myelin basic protein [Source:MGI Symbol;Acc:MGI:96 925]
Tmem132b3.47E-51−0.34043890.0620.2641.12E-46transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Phyhd12.24E-50−0.50595120.2210.4527.24E-46phytanoyl-CoA dioxygenase domain containing 1 [Source:MGI Symbol;Acc:MGI:3 612 860]
Glis33.59E-50−0.62542110.5240.7151.16E-45GLIS family zinc finger 3 [Source:MGI Symbol;Acc:MGI:2 444 289]
Elmo17.87E-50−0.52881910.1040.2682.54E-45engulfment and cell motility 1 [Source:MGI Symbol;Acc:MGI:2 153 044]
Car102.40E-490.85 983 3940.4940.2827.75E-45carbonic anhydrase 10 [Source:MGI Symbol;Acc:MGI:1 919 855]
Ptch13.37E-490.70 455 4390.5810.2851.09E-44patched 1 [Source:MGI Symbol;Acc:MGI:105 373]
Aebp11.40E-48−0.34100280.0110.1824.52E-44AE binding protein 1 [Source:MGI Symbol;Acc:MGI:1 197 012]
Pcdh72.00E-480.5 983 1060.8860.7446.47E-44protocadherin 7 [Source:MGI Symbol;Acc:MGI:1 860 487]
Dok66.61E-48−0.54490440.1560.3822.13E-43docking protein 6 [Source:MGI Symbol;Acc:MGI:3 639 495]
Garnl31.52E-47−0.37356950.0830.2664.90E-43GTPase activating RANGAP domain-like 3 [Source:MGI Symbol;Acc:MGI:2 139 309]
Robo21.53E-47−0.67838390.5650.7284.95E-43roundabout guidance receptor 2 [Source:MGI Symbol;Acc:MGI:1 890 110]
Synpo24.98E-47−0.62419530.1620.3931.61E-42synaptopodin 2 [Source:MGI Symbol;Acc:MGI:2 153 070]
Zeb25.73E-46−0.54897780.5140.6571.85E-41zinc finger E-box binding homeobox 2 [Source:MGI Symbol;Acc:MGI:1 344 407]
Padi25.77E-46−0.45318580.1240.3361.86E-41peptidyl arginine deiminase, type II [Source:MGI Symbol;Acc:MGI:1 338 892]
C530044C16Rik5.84E-46−0.34399180.0110.1621.89E-41RIKEN cDNA C530044C16 gene [Source:MGI Symbol;Acc:MGI:2 443 109]
Reep12.13E-44−0.44857350.0710.2396.88E-40receptor accessory protein 1 [Source:MGI Symbol;Acc:MGI:1 098 827]
Map76.02E-44−0.46314340.1470.2981.94E-39microtubule-associated protein 7 [Source:MGI Symbol;Acc:MGI:1 328 328]
Atp13a46.00E-430.52 133 6030.4980.2191.94E-38ATPase type 13A4 [Source:MGI Symbol;Acc:MGI:1 924 456]
Cpne83.12E-42−0.29628670.0350.1921.01E-37copine VIII [Source:MGI Symbol;Acc:MGI:1 914 121]
Tagln33.76E-42−0.45100630.2970.4871.21E-37transgelin 3 [Source:MGI Symbol;Acc:MGI:1 926 784]
Frmd4a4.71E-420.63 758 1730.9350.7821.52E-37FERM domain containing 4A [Source:MGI Symbol;Acc:MGI:1 919 850]
Sema3a7.94E-42−0.37426410.0310.1742.56E-37sema domain, immunoglobulin domain (Ig), short basic domain, secreted, (semaphorin) 3A [Source:MGI Symbol;Acc:MGI:107 558]
Tnc1.52E-41−0.28987480.0190.1774.89E-37tenascin C [Source:MGI Symbol;Acc:MGI:101 922]
Cacnb45.46E-41−0.55386590.2310.4231.76E-36calcium channel, voltage-dependent, beta 4 subunit [Source:MGI Symbol;Acc:MGI:103 301]
Neat16.65E-41−0.64808040.5210.6272.15E-36nuclear paraspeckle assembly transcript 1 (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 914 211]
Ano43.04E-40−0.37170070.0740.2099.82E-36anoctamin 4 [Source:MGI Symbol;Acc:MGI:2 443 344]
Adamts94.01E-40−0.51521880.1950.4191.29E-35a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 9 [Source:MGI Symbol;Acc:MGI:1 916 320]
Luzp24.27E-400.98 895 0870.9030.6811.38E-35leucine zipper protein 2 [Source:MGI Symbol;Acc:MGI:1 889 615]
March16.66E-40−0.4157750.0850.2212.15E-35NA
Igfbp57.96E-40−0.40115060.0920.2812.57E-35insulin-like growth factor binding protein 5 [Source:MGI Symbol;Acc:MGI:96 440]
Hecw29.58E-40−0.39168580.090.2153.09E-35HECT, C2 and WW domain containing E3 ubiquitin protein ligase 2 [Source:MGI Symbol;Acc:MGI:2 685 817]
Ank21.52E-39−0.69756270.9540.9494.92E-35ankyrin 2, brain [Source:MGI Symbol;Acc:MGI:88 025]
Trp632.59E-390.64 506 9460.3240.1118.35E-35transformation related protein 63 [Source:MGI Symbol;Acc:MGI:1 330 810]
Adgrl32.95E-390.53 274 2270.9060.7969.52E-35adhesion G protein-coupled receptor L3 [Source:MGI Symbol;Acc:MGI:2 441 950]
9530026P05Rik1.12E-38−0.59699570.2250.4223.61E-34RIKEN cDNA 9530026P05 gene [Source:MGI Symbol;Acc:MGI:1 924 659]
Fmn12.01E-38−0.57518580.1950.3586.49E-34formin 1 [Source:MGI Symbol;Acc:MGI:101 815]
D7Ertd443e3.39E-38−0.29014660.0260.161.09E-33DNA segment, Chr 7, ERATO Doi 443, expressed [Source:MGI Symbol;Acc:MGI:1 196 431]
Tex117.26E-38−0.25602360.0110.152.34E-33testis expressed gene 11 [Source:MGI Symbol;Acc:MGI:1 933 237]
Sema6d1.10E-37−0.73744820.5280.6643.54E-33sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6D [Source:MGI Symbol;Acc:MGI:2 387 661]
Tulp42.02E-37−0.44931220.3790.5636.51E-33tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Aqp43.92E-37−0.4956280.4040.5931.27E-32aquaporin 4 [Source:MGI Symbol;Acc:MGI:107 387]
Dscaml16.17E-37−0.32478570.0310.1451.99E-32DS cell adhesion molecule like 1 [Source:MGI Symbol;Acc:MGI:2 150 309]
Eya49.63E-37−0.36639930.0930.2683.11E-32EYA transcriptional coactivator and phosphatase 4 [Source:MGI Symbol;Acc:MGI:1 337 104]
Thbs42.03E-36−0.28644410.0070.1286.56E-32thrombospondin 4 [Source:MGI Symbol;Acc:MGI:1 101 779]
Apbb1ip2.03E-36−0.27603990.0120.1646.57E-32amyloid beta (A4) precursor protein-binding, family B, member 1 interacting protein [Source:MGI Symbol;Acc:MGI:1 861 354]
Ank32.07E-36−0.43101190.2380.3666.67E-32ankyrin 3, epithelial [Source:MGI Symbol;Acc:MGI:88 026]
Slc4a42.32E-360.53 869 8480.9270.8467.47E-32solute carrier family 4 (anion exchanger), member 4 [Source:MGI Symbol;Acc:MGI:1 927 555]
Syne12.48E-360.48 914 0070.8840.7748.02E-32spectrin repeat containing, nuclear envelope 1 [Source:MGI Symbol;Acc:MGI:1 927 152]
Cadm28.59E-360.47 857 2720.9920.922.77E-31cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:2 442 722]
Pxdn3.14E-35−0.29168010.0710.2221.02E-30peroxidasin [Source:MGI Symbol;Acc:MGI:1 916 925]
Cmya54.19E-35−0.33401310.0930.2721.35E-30cardiomyopathy associated 5 [Source:MGI Symbol;Acc:MGI:1 923 719]
4930402H24Rik5.42E-35−0.48683070.830.861.75E-30NA
Reln6.39E-35−0.43203110.110.2952.06E-30reelin [Source:MGI Symbol;Acc:MGI:103 022]
Retreg19.38E-35−0.29235920.0960.2663.03E-30reticulophagy regulator 1 [Source:MGI Symbol;Acc:MGI:1 913 520]
Gpld11.38E-340.46 185 2080.3950.1514.47E-30glycosylphosphatidylinositol specific phospholipase D1 [Source:MGI Symbol;Acc:MGI:106 604]
Plp11.47E-34−0.4348560.5990.7314.76E-30proteolipid protein (myelin) 1 [Source:MGI Symbol;Acc:MGI:97 623]
Mapt2.50E-34−0.44176690.4270.568.06E-30microtubule-associated protein tau [Source:MGI Symbol;Acc:MGI:97 180]
Eps82.62E-340.47 960 3480.5370.2748.46E-30epidermal growth factor receptor pathway substrate 8 [Source:MGI Symbol;Acc:MGI:104 684]
Tab23.98E-34−0.38333140.2510.451.28E-29TGF-beta activated kinase 1/MAP3K7 binding protein 2 [Source:MGI Symbol;Acc:MGI:1 915 902]
Dock44.61E-340.53 604 3730.8150.6411.49E-29dedicator of cytokinesis 4 [Source:MGI Symbol;Acc:MGI:1 918 006]
Ptprk2.18E-33−0.32661880.0860.2197.02E-29protein tyrosine phosphatase, receptor type, K [Source:MGI Symbol;Acc:MGI:103 310]
Airn4.11E-33−0.31793050.0540.1841.33E-28antisense Igf2r RNA [Source:MGI Symbol;Acc:MGI:1 353 471]
Erbin2.15E-32−0.41815980.2990.466.94E-28Erbb2 interacting protein [Source:MGI Symbol;Acc:MGI:1 890 169]
Plxdc22.72E-32−0.43980.2670.4438.77E-28plexin domain containing 2 [Source:MGI Symbol;Acc:MGI:1 914 698]
Vav33.24E-320.49 950 3790.4460.1871.05E-27vav 3 oncogene [Source:MGI Symbol;Acc:MGI:1 888 518]
Sh3d194.83E-32−0.25908980.0410.1711.56E-27SH3 domain protein D19 [Source:MGI Symbol;Acc:MGI:1 350 923]
Gm106356.44E-32−0.31841620.0230.152.08E-27predicted gene 10 635 [Source:MGI Symbol;Acc:MGI:3 641 740]
Itih31.22E-310.46 778 9670.3420.1283.95E-27inter-alpha trypsin inhibitor, heavy chain 3 [Source:MGI Symbol;Acc:MGI:96 620]
Kcnma11.29E-310.58 278 3970.6720.4164.18E-27potassium large conductance calcium-activated channel, subfamily M, alpha member 1 [Source:MGI Symbol;Acc:MGI:99 923]
Acsbg11.66E-310.46 229 4430.6060.4065.36E-27acyl-CoA synthetase bubblegum family member 1 [Source:MGI Symbol;Acc:MGI:2 385 656]
Naaladl22.22E-31−0.50596970.3140.5287.16E-27N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Rps6ka52.78E-31−0.35757310.2040.3958.99E-27ribosomal protein S6 kinase, polypeptide 5 [Source:MGI Symbol;Acc:MGI:1 920 336]
Mobp3.94E-31−0.3479790.1350.2581.27E-26myelin-associated oligodendrocytic basic protein [Source:MGI Symbol;Acc:MGI:108 511]
Cdh109.07E-310.49 836 4990.7380.5362.93E-26cadherin 10 [Source:MGI Symbol;Acc:MGI:107 436]
Cadm11.31E-300.50 571 3360.8350.6484.24E-26cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:1 889 272]
Arhgap61.40E-30−0.25423430.0340.1444.51E-26Rho GTPase activating protein 6 [Source:MGI Symbol;Acc:MGI:1 196 332]
Dner2.35E-30−0.3441610.1730.337.57E-26delta/notch-like EGF repeat containing [Source:MGI Symbol;Acc:MGI:2 152 889]
Disp32.80E-30−0.30234690.0770.1999.04E-26dispatched RND transporter family member 3 [Source:MGI Symbol;Acc:MGI:2 444 403]
Npas34.84E-300.46 551 2690.9850.9431.56E-25neuronal PAS domain protein 3 [Source:MGI Symbol;Acc:MGI:1 351 610]
Id36.28E-30−0.3400750.1340.3122.03E-25inhibitor of DNA binding 3 [Source:MGI Symbol;Acc:MGI:96 398]
Kalrn6.35E-300.44 370 4620.5660.3212.05E-25kalirin, RhoGEF kinase [Source:MGI Symbol;Acc:MGI:2 685 385]
Fgfr31.96E-290.41 311 4010.6340.4576.32E-25fibroblast growth factor receptor 3 [Source:MGI Symbol;Acc:MGI:95 524]
Agap12.08E-29−0.34621550.1980.3436.72E-25ArfGAP with GTPase domain, ankyrin repeat and PH domain 1 [Source:MGI Symbol;Acc:MGI:2 653 690]
Bin12.61E-29−0.29684230.130.2628.41E-25bridging integrator 1 [Source:MGI Symbol;Acc:MGI:108 092]
Tspan73.06E-290.46 649 1080.7840.639.89E-25tetraspanin 7 [Source:MGI Symbol;Acc:MGI:1 298 407]
Cables13.75E-290.43 697 1520.470.2181.21E-24CDK5 and Abl enzyme substrate 1 [Source:MGI Symbol;Acc:MGI:1 927 065]
Ddr14.57E-29−0.29183040.1340.2881.47E-24discoidin domain receptor family, member 1 [Source:MGI Symbol;Acc:MGI:99 216]
Ano14.74E-29−0.32992270.0030.1441.53E-24anoctamin 1, calcium activated chloride channel [Source:MGI Symbol;Acc:MGI:2 142 149]
Grin2c7.34E-290.38 585 4430.4280.1882.37E-24glutamate receptor, ionotropic, NMDA2C (epsilon 3) [Source:MGI Symbol;Acc:MGI:95 822]
Slco1c18.32E-290.44 635 9410.4590.2352.69E-24solute carrier organic anion transporter family, member 1c1 [Source:MGI Symbol;Acc:MGI:1 889 679]
Trim29.96E-29−0.37651730.3080.4913.21E-24tripartite motif-containing 2 [Source:MGI Symbol;Acc:MGI:1 933 163]
Fat31.02E-280.48 826 9490.6850.5263.29E-24FAT atypical cadherin 3 [Source:MGI Symbol;Acc:MGI:2 444 314]
Spock11.36E-28−0.30109010.1110.2284.39E-24sparc/osteonectin, cwcv and kazal-like domains proteoglycan 1 [Source:MGI Symbol;Acc:MGI:105 371]
Grin3a1.95E-28−0.39370810.1380.2936.30E-24glutamate receptor ionotropic, NMDA3A [Source:MGI Symbol;Acc:MGI:1 933 206]
Ptprg2.33E-280.48 924 4260.6420.4967.51E-24NA
Nwd12.35E-280.41 679 6270.7050.5067.59E-24NACHT and WD repeat domain containing 1 [Source:MGI Symbol;Acc:MGI:2 442 268]
Wwox3.10E-28−0.5667150.5260.6781.00E-23WW domain-containing oxidoreductase [Source:MGI Symbol;Acc:MGI:1 931 237]
Cep85l6.31E-280.4 097 8750.5780.3822.04E-23centrosomal protein 85-like [Source:MGI Symbol;Acc:MGI:3 642 684]
Gria46.44E-280.59 105 0450.4260.2582.08E-23glutamate receptor, ionotropic, AMPA4 (alpha 4) [Source:MGI Symbol;Acc:MGI:95 811]
Nxn9.83E-28−0.47264220.4210.5953.17E-23nucleoredoxin [Source:MGI Symbol;Acc:MGI:109 331]
2610307P16Rik1.27E-27−0.31659830.0640.1984.11E-23RIKEN cDNA 2610307P16 gene [Source:MGI Symbol;Acc:MGI:1 919 768]
Ccdc85a1.29E-270.47 682 1040.5240.2824.16E-23coiled-coil domain containing 85A [Source:MGI Symbol;Acc:MGI:2 445 069]
Grid22.01E-270.48 400 7850.910.7616.50E-23glutamate receptor, ionotropic, delta 2 [Source:MGI Symbol;Acc:MGI:95 813]
Nrbp23.89E-27−0.3131650.1840.3551.25E-22nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Etv46.28E-270.34 377 1190.2810.0732.03E-22ets variant 4 [Source:MGI Symbol;Acc:MGI:99 423]
Cep1126.56E-27−0.25664220.0720.2252.12E-22centrosomal protein 112 [Source:MGI Symbol;Acc:MGI:1 923 673]
Rnf2201.42E-26−0.38293090.1610.2424.60E-22ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Rtn43.75E-26−0.35591380.5030.6521.21E-21reticulon 4 [Source:MGI Symbol;Acc:MGI:1 915 835]
Klhl294.42E-26−0.28145850.1230.2781.43E-21kelch-like 29 [Source:MGI Symbol;Acc:MGI:2 683 857]
Sorcs17.06E-26−0.32927210.1120.2262.28E-21sortilin-related VPS10 domain containing receptor 1 [Source:MGI Symbol;Acc:MGI:1 929 666]
App8.22E-26−0.36787750.5210.6422.65E-21amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Grk31.23E-250.38 379 0140.5720.3393.97E-21G protein-coupled receptor kinase 3 [Source:MGI Symbol;Acc:MGI:87 941]
Atp1b21.53E-250.45 621 0180.5410.4264.95E-21ATPase, Na+/K + transporting, beta 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 109]
Bmp61.82E-25−0.25663580.0390.165.88E-21bone morphogenetic protein 6 [Source:MGI Symbol;Acc:MGI:88 182]
Ndrg21.93E-250.40 022 6160.730.626.22E-21N-myc downstream regulated gene 2 [Source:MGI Symbol;Acc:MGI:1 352 498]
Mgat4c3.09E-250.47 103 3120.5650.4799.97E-21MGAT4 family, member C [Source:MGI Symbol;Acc:MGI:1 914 819]
Pdgfd5.25E-25−0.43084350.390.5281.69E-20platelet-derived growth factor, D polypeptide [Source:MGI Symbol;Acc:MGI:1 919 035]
Nav26.00E-25−0.42033420.5210.641.94E-20neuron navigator 2 [Source:MGI Symbol;Acc:MGI:2 183 691]
Shc39.06E-250.35 170 7430.3870.1722.92E-20src homology 2 domain-containing transforming protein C3 [Source:MGI Symbol;Acc:MGI:106 179]
Plscr41.07E-24−0.26351470.0990.2513.44E-20phospholipid scramblase 4 [Source:MGI Symbol;Acc:MGI:2 143 267]
Dgkb1.55E-240.41 451 4060.8990.7885.02E-20diacylglycerol kinase, beta [Source:MGI Symbol;Acc:MGI:2 442 474]
Fry1.97E-240.38 056 9650.6770.5676.35E-20FRY microtubule binding protein [Source:MGI Symbol;Acc:MGI:2 443 895]
Tnik2.85E-240.39 465 1720.9260.8529.19E-20TRAF2 and NCK interacting kinase [Source:MGI Symbol;Acc:MGI:1 916 264]
Slc1a24.57E-240.38 376 7960.9990.9761.47E-19solute carrier family 1 (glial high affinity glutamate transporter), member 2 [Source:MGI Symbol;Acc:MGI:101 931]
Tmc74.76E-240.36 285 4910.3430.1521.54E-19transmembrane channel-like gene family 7 [Source:MGI Symbol;Acc:MGI:2 443 317]
Nrcam5.21E-240.38 906 2530.8310.6841.68E-19neuronal cell adhesion molecule [Source:MGI Symbol;Acc:MGI:104 750]
Pgm51.33E-23−0.26781540.0340.1614.28E-19phosphoglucomutase 5 [Source:MGI Symbol;Acc:MGI:1 925 668]
Rapgef41.55E-23−0.30338410.1230.2365.00E-19Rap guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:1 917 723]
Adipor22.96E-23−0.29242370.1520.2419.56E-19adiponectin receptor 2 [Source:MGI Symbol;Acc:MGI:93 830]
Gabbr28.65E-230.40 045 0430.330.1512.79E-18gamma-aminobutyric acid (GABA) B receptor, 2 [Source:MGI Symbol;Acc:MGI:2 386 030]
Phactr31.14E-220.36 083 1550.5180.2853.68E-18phosphatase and actin regulator 3 [Source:MGI Symbol;Acc:MGI:1 921 439]
Dst1.39E-22−0.36711630.6210.7184.49E-18dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Gjb61.94E-220.31 796 4270.3470.1646.27E-18gap junction protein, beta 6 [Source:MGI Symbol;Acc:MGI:107 588]
Dip2b2.13E-22−0.3137080.3440.4876.89E-18disco interacting protein 2 homolog B [Source:MGI Symbol;Acc:MGI:2 145 977]
Ntng13.12E-22−0.31572520.0620.1771.01E-17netrin G1 [Source:MGI Symbol;Acc:MGI:1 934 028]
Frmpd43.81E-22−0.26677090.1360.2341.23E-17FERM and PDZ domain containing 4 [Source:MGI Symbol;Acc:MGI:3 042 378]
Kcnip33.99E-220.37 212 3660.3770.1871.29E-17Kv channel interacting protein 3, calsenilin [Source:MGI Symbol;Acc:MGI:1 929 258]
Ppp1r16b4.87E-22−0.26358730.0940.1741.57E-17protein phosphatase 1, regulatory subunit 16B [Source:MGI Symbol;Acc:MGI:2 151 841]
Slc6a17.68E-220.35 533 7630.6010.4422.48E-17solute carrier family 6 (neurotransmitter transporter, GABA), member 1 [Source:MGI Symbol;Acc:MGI:95 627]
Sorcs28.98E-220.31 923 2460.3490.1612.90E-17sortilin-related VPS10 domain containing receptor 2 [Source:MGI Symbol;Acc:MGI:1 932 289]
Mpdz1.18E-21−0.264380.1550.2993.81E-17multiple PDZ domain crumbs cell polarity complex component [Source:MGI Symbol;Acc:MGI:1 343 489]
Tsc22d11.35E-21−0.27447680.2610.4154.35E-17TSC22 domain family, member 1 [Source:MGI Symbol;Acc:MGI:109 127]
Xylt11.69E-210.39 333 3490.5110.2885.45E-17xylosyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 451 073]
Ski2.22E-21−0.2875370.1710.3127.18E-17ski sarcoma viral oncogene homolog (avian) [Source:MGI Symbol;Acc:MGI:98 310]
Tenm42.83E-210.39 167 5450.4230.2519.12E-17teneurin transmembrane protein 4 [Source:MGI Symbol;Acc:MGI:2 447 063]
Ablim12.84E-210.35 555 5790.5170.3159.15E-17actin-binding LIM protein 1 [Source:MGI Symbol;Acc:MGI:1 194 500]
Ahcyl13.24E-210.36 060 6420.6680.5041.05E-16S-adenosylhomocysteine hydrolase-like 1 [Source:MGI Symbol;Acc:MGI:2 385 184]
Shroom35.82E-210.39 782 5920.4570.3191.88E-16shroom family member 3 [Source:MGI Symbol;Acc:MGI:1 351 655]
Mertk1.09E-200.43 718 9990.7980.6383.51E-16MER proto-oncogene tyrosine kinase [Source:MGI Symbol;Acc:MGI:96 965]
Wasf31.16E-200.33 069 6330.5510.3623.75E-16WASP family, member 3 [Source:MGI Symbol;Acc:MGI:2 658 986]
Myo162.10E-20−0.26815250.0950.2096.78E-16myosin XVI [Source:MGI Symbol;Acc:MGI:2 685 951]
9630028H03Rik2.28E-200.32 473 4260.3040.1257.38E-16RIKEN cDNA 9630028H03 gene [Source:MGI Symbol;Acc:MGI:2 444 526]
Plekha54.64E-20−0.27234810.2040.3521.50E-15pleckstrin homology domain containing, family A member 5 [Source:MGI Symbol;Acc:MGI:1 923 802]
Npas24.88E-200.38 493 5470.5710.3891.58E-15neuronal PAS domain protein 2 [Source:MGI Symbol;Acc:MGI:109 232]
St3gal41.26E-190.3 840 1030.5460.3434.07E-15ST3 beta-galactoside alpha-2,3-sialyltransferase 4 [Source:MGI Symbol;Acc:MGI:1 316 743]
Dmd1.92E-190.42 285 6190.8240.6986.19E-15dystrophin, muscular dystrophy [Source:MGI Symbol;Acc:MGI:94 909]
Myo5a1.96E-19−0.26387170.2090.3356.32E-15myosin VA [Source:MGI Symbol;Acc:MGI:105 976]
Ralgps23.83E-19−0.25903480.1680.3161.24E-14Ral GEF with PH domain and SH3 binding motif 2 [Source:MGI Symbol;Acc:MGI:1 925 505]
Tprkb5.94E-19−0.34531490.360.5041.92E-14Tp53rk binding protein [Source:MGI Symbol;Acc:MGI:1 917 036]
Plcl16.13E-19−0.40963640.5850.5211.98E-14phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Mgat56.17E-19−0.31846110.3260.4861.99E-14mannoside acetylglucosaminyltransferase 5 [Source:MGI Symbol;Acc:MGI:894 701]
Htra17.27E-190.36 090 7440.6620.4722.35E-14HtrA serine peptidase 1 [Source:MGI Symbol;Acc:MGI:1 929 076]
Vegfa7.45E-190.35 819 2410.5390.3732.41E-14vascular endothelial growth factor A [Source:MGI Symbol;Acc:MGI:103 178]
Nim1k1.14E-180.321 9310.4130.2413.68E-14NIM1 serine/threonine protein kinase [Source:MGI Symbol;Acc:MGI:2 442 399]
Nrg21.19E-18−0.30421890.2230.3733.84E-14neuregulin 2 [Source:MGI Symbol;Acc:MGI:1 098 246]
Hif1a1.93E-180.27 065 1160.2740.1386.25E-14hypoxia inducible factor 1, alpha subunit [Source:MGI Symbol;Acc:MGI:106 918]
Mical22.68E-180.32 752 0130.6480.4838.64E-14microtubule associated monooxygenase, calponin and LIM domain containing 2 [Source:MGI Symbol;Acc:MGI:2 444 947]
Lhfpl33.27E-18−0.39838020.2910.3751.05E-13lipoma HMGIC fusion partner-like 3 [Source:MGI Symbol;Acc:MGI:1 925 076]
Ntm3.91E-180.2 944 4280.9950.971.26E-13neurotrimin [Source:MGI Symbol;Acc:MGI:2 446 259]
Tafa14.53E-180.48 678 1360.3110.1651.46E-13TAFA chemokine like family member 1 [Source:MGI Symbol;Acc:MGI:2 443 695]
Arid5b5.38E-18−0.26222790.1420.2621.74E-13AT rich interactive domain 5B (MRF1-like) [Source:MGI Symbol;Acc:MGI:2 175 912]
Esrrg6.07E-180.36 245 5160.4910.3681.96E-13estrogen-related receptor gamma [Source:MGI Symbol;Acc:MGI:1 347 056]
Ankrd286.58E-18−0.29471650.3410.4832.13E-13ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Wdr177.20E-180.40 737 0870.8440.7512.32E-13WD repeat domain 17 [Source:MGI Symbol;Acc:MGI:1 924 662]
Fus7.50E-18−0.27191570.3640.5112.42E-13fused in sarcoma [Source:MGI Symbol;Acc:MGI:1 353 633]
Dpyd8.99E-18−0.297580.2540.3852.90E-13dihydropyrimidine dehydrogenase [Source:MGI Symbol;Acc:MGI:2 139 667]
Stard131.30E-17−0.37483710.3750.5414.20E-13StAR-related lipid transfer (START) domain containing 13 [Source:MGI Symbol;Acc:MGI:2 385 331]
Adcy81.36E-17−0.30606340.2410.3494.41E-13adenylate cyclase 8 [Source:MGI Symbol;Acc:MGI:1 341 110]
Ptprd1.76E-17−0.3245270.8480.8485.68E-13protein tyrosine phosphatase, receptor type, D [Source:MGI Symbol;Acc:MGI:97 812]
9630014M24Rik2.04E-170.26 701 2950.2730.1056.58E-13RIKEN cDNA 9630014M24 gene [Source:MGI Symbol;Acc:MGI:3 588 234]
Btbd92.29E-17−0.28980790.3360.4867.39E-13BTB (POZ) domain containing 9 [Source:MGI Symbol;Acc:MGI:1 916 625]
Auts22.68E-170.3 804 8110.9110.8028.65E-13autism susceptibility candidate 2 [Source:MGI Symbol;Acc:MGI:1 919 847]
Arhgap233.14E-17−0.27142860.2340.3221.01E-12Rho GTPase activating protein 23 [Source:MGI Symbol;Acc:MGI:3 697 726]
Pde10a3.38E-170.58 969 9390.4040.2341.09E-12phosphodiesterase 10A [Source:MGI Symbol;Acc:MGI:1 345 143]
Grip14.32E-170.31 380 7160.2810.1341.40E-12glutamate receptor interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 921 303]
St6galnac57.24E-170.32 665 3220.2550.1042.34E-12ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 5 [Source:MGI Symbol;Acc:MGI:1 349 471]
Ctnnd27.33E-170.29 063 9440.9810.9592.37E-12catenin (cadherin associated protein), delta 2 [Source:MGI Symbol;Acc:MGI:1 195 966]
Map2k67.54E-170.2 867 0680.3820.2052.43E-12mitogen-activated protein kinase kinase 6 [Source:MGI Symbol;Acc:MGI:1 346 870]
Gm351881.00E-160.33 492 2850.6420.4773.23E-12predicted gene, 35 188 [Source:MGI Symbol;Acc:MGI:5 594 347]
Kmt2c1.20E-160.32 629 1870.6490.5433.89E-12lysine (K)-specific methyltransferase 2C [Source:MGI Symbol;Acc:MGI:2 444 959]
Eda1.43E-16−0.31566060.210.3564.62E-12ectodysplasin-A [Source:MGI Symbol;Acc:MGI:1 195 272]
Egfr1.70E-160.3 217 7370.4580.2585.49E-12epidermal growth factor receptor [Source:MGI Symbol;Acc:MGI:95 294]
Negr12.09E-160.37 537 6390.8530.6976.76E-12neuronal growth regulator 1 [Source:MGI Symbol;Acc:MGI:2 444 846]
Chd92.70E-160.31 204 8060.7730.668.72E-12chromodomain helicase DNA binding protein 9 [Source:MGI Symbol;Acc:MGI:1 924 001]
4930545L23Rik3.15E-160.2 525 5620.2130.0751.02E-11RIKEN cDNA 4930545L23 gene [Source:MGI Symbol;Acc:MGI:1 926 055]
Mbnl23.57E-16−0.29711720.5840.6871.15E-11muscleblind like splicing factor 2 [Source:MGI Symbol;Acc:MGI:2 145 597]
Cdc42bpa3.90E-16−0.28820290.5660.6451.26E-11CDC42 binding protein kinase alpha [Source:MGI Symbol;Acc:MGI:2 441 841]
Rgs7bp5.91E-160.28 765 1370.3440.2141.91E-11regulator of G-protein signalling 7 binding protein [Source:MGI Symbol;Acc:MGI:106 334]
Hip16.79E-160.31 045 9310.4820.3022.19E-11huntingtin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 099 804]
Kcnj107.30E-160.28 764 8760.3580.2382.36E-11potassium inwardly-rectifying channel, subfamily J, member 10 [Source:MGI Symbol;Acc:MGI:1 194 504]
Gab18.69E-16−0.25106650.2290.3392.80E-11growth factor receptor bound protein 2-associated protein 1 [Source:MGI Symbol;Acc:MGI:108 088]
Limch11.22E-150.3 424 3420.6760.5073.95E-11LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Gm303821.52E-150.27 365 5450.1680.0584.92E-11predicted gene, 30 382 [Source:MGI Symbol;Acc:MGI:5 589 541]
Aldoc1.70E-150.27 040 7730.4890.3565.48E-11aldolase C, fructose-bisphosphate [Source:MGI Symbol;Acc:MGI:101 863]
Wwc11.81E-150.30 910 5710.5530.4035.85E-11WW, C2 and coiled-coil domain containing 1 [Source:MGI Symbol;Acc:MGI:2 388 637]
Phka11.91E-150.35 229 3050.6470.5216.17E-11phosphorylase kinase alpha 1 [Source:MGI Symbol;Acc:MGI:97 576]
Map4k41.93E-15−0.26654580.4050.5246.22E-11mitogen-activated protein kinase kinase kinase kinase 4 [Source:MGI Symbol;Acc:MGI:1 349 394]
Stk32a2.16E-15−0.42537670.2270.3436.99E-11serine/threonine kinase 32A [Source:MGI Symbol;Acc:MGI:2 442 403]
Igsf112.48E-15−0.2698380.3420.488.01E-11immunoglobulin superfamily, member 11 [Source:MGI Symbol;Acc:MGI:2 388 477]
Utrn2.56E-15−0.35209440.5960.6478.26E-11utrophin [Source:MGI Symbol;Acc:MGI:104 631]
Prkn2.62E-15−0.356710.5920.7158.46E-11parkin RBR E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 355 296]
Syn23.73E-150.29 810 5870.520.3921.21E-10synapsin II [Source:MGI Symbol;Acc:MGI:103 020]
Dbx24.19E-150.25 917 6930.370.2261.35E-10developing brain homeobox 2 [Source:MGI Symbol;Acc:MGI:107 445]
Gm61454.52E-150.30 080 3970.6410.51.46E-10predicted gene 6145 [Source:MGI Symbol;Acc:MGI:3 779 559]
Id44.92E-15−0.29273950.2740.4291.59E-10inhibitor of DNA binding 4 [Source:MGI Symbol;Acc:MGI:99 414]
Dpf35.68E-150.2 822 1580.4370.2831.83E-10double PHD fingers 3 [Source:MGI Symbol;Acc:MGI:1 917 377]
F38.81E-150.30 629 6780.5420.4232.84E-10coagulation factor III [Source:MGI Symbol;Acc:MGI:88 381]
Sat12.02E-140.28 493 3810.4240.2886.51E-10spermidine/spermine N1-acetyl transferase 1 [Source:MGI Symbol;Acc:MGI:98 233]
Pbx12.05E-14−0.32819210.90.8976.62E-10pre B cell leukemia homeobox 1 [Source:MGI Symbol;Acc:MGI:97 495]
Tmem178b2.22E-14−0.34648750.3980.4847.18E-10transmembrane protein 178B [Source:MGI Symbol;Acc:MGI:3 647 581]
Ghr2.76E-140.30 505 4690.4920.3388.90E-10growth hormone receptor [Source:MGI Symbol;Acc:MGI:95 708]
Ptprz12.79E-140.29 632 4440.8980.8399.02E-10protein tyrosine phosphatase, receptor type Z, polypeptide 1 [Source:MGI Symbol;Acc:MGI:97 816]
Gm161682.81E-14−0.25244130.1990.3069.08E-10predicted gene 16 168 [Source:MGI Symbol;Acc:MGI:3 802 010]
Arhgap263.02E-140.30 202 1830.5340.49.74E-10Rho GTPase activating protein 26 [Source:MGI Symbol;Acc:MGI:1 918 552]
Etnppl3.68E-140.32 550 8230.4010.2491.19E-09ethanolamine phosphate phospholyase [Source:MGI Symbol;Acc:MGI:1 919 010]
Slc7a23.76E-14−0.26928090.3050.4171.22E-09solute carrier family 7 (cationic amino acid transporter, y + system), member 2 [Source:MGI Symbol;Acc:MGI:99 828]
Ube2e24.03E-14−0.30365550.4780.6011.30E-09ubiquitin-conjugating enzyme E2E 2 [Source:MGI Symbol;Acc:MGI:2 384 997]
Gli34.62E-140.28 367 6840.6990.5731.49E-09GLI-Kruppel family member GLI3 [Source:MGI Symbol;Acc:MGI:95 729]
Ccdc1414.83E-140.2 782 9790.4670.3381.56E-09coiled-coil domain containing 141 [Source:MGI Symbol;Acc:MGI:1 919 735]
Tmtc24.83E-140.36 794 5040.5730.3691.56E-09transmembrane and tetratricopeptide repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 914 057]
Immp2l6.36E-14−0.26882140.1850.3122.05E-09IMP2 inner mitochondrial membrane peptidase-like (S. cerevisiae) [Source:MGI Symbol;Acc:MGI:2 135 611]
Tenm37.88E-14−0.32306420.5270.6572.54E-09teneurin transmembrane protein 3 [Source:MGI Symbol;Acc:MGI:1 345 183]
Agl8.71E-140.25 181 8080.4210.2892.81E-09amylo-1,6-glucosidase, 4-alpha-glucanotransferase [Source:MGI Symbol;Acc:MGI:1 924 809]
Phkg18.88E-140.27 904 1170.6790.5732.87E-09phosphorylase kinase gamma 1 [Source:MGI Symbol;Acc:MGI:97 579]
Nbea9.70E-14−0.25885620.5130.6113.13E-09neurobeachin [Source:MGI Symbol;Acc:MGI:1 347 075]
Smyd31.16E-13−0.28255640.350.4973.74E-09SET and MYND domain containing 3 [Source:MGI Symbol;Acc:MGI:1 916 976]
Chst111.30E-13−0.26105280.2590.374.21E-09carbohydrate sulfotransferase 11 [Source:MGI Symbol;Acc:MGI:1 927 166]
Ptgds1.42E-13−0.27257340.3860.4694.57E-09prostaglandin D2 synthase (brain) [Source:MGI Symbol;Acc:MGI:99 261]
Bmpr1b1.51E-13−0.31688010.670.7414.86E-09bone morphogenetic protein receptor, type 1B [Source:MGI Symbol;Acc:MGI:107 191]
Rmst1.63E-13−0.38929720.7550.7955.26E-09rhabdomyosarcoma 2 associated transcript (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 099 806]
Camk1d1.68E-130.30 376 0590.6740.5195.42E-09calcium/calmodulin-dependent protein kinase ID [Source:MGI Symbol;Acc:MGI:2 442 190]
Ttc281.69E-13−0.26126680.3640.4865.45E-09tetratricopeptide repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 140 873]
Zfp4621.76E-13−0.27398350.3250.4465.67E-09zinc finger protein 462 [Source:MGI Symbol;Acc:MGI:107 690]
Pde8b2.74E-130.29 540 4520.430.2718.84E-09phosphodiesterase 8B [Source:MGI Symbol;Acc:MGI:2 443 999]
Slc25a213.38E-13−0.2738290.1370.2821.09E-08solute carrier family 25 (mitochondrial oxodicarboxylate carrier), member 21 [Source:MGI Symbol;Acc:MGI:2 445 059]
Arhgef285.58E-130.27 161 2430.4410.3621.80E-08Rho guanine nucleotide exchange factor (GEF) 28 [Source:MGI Symbol;Acc:MGI:1 346 016]
Pla2g76.34E-130.28 317 9970.6010.4572.05E-08phospholipase A2, group VII (platelet-activating factor acetylhydrolase, plasma) [Source:MGI Symbol;Acc:MGI:1 351 327]
Prr161.04E-120.30 343 2770.3070.1753.34E-08proline rich 16 [Source:MGI Symbol;Acc:MGI:1 918 623]
Spred11.39E-120.25 156 3280.4630.3194.48E-08sprouty protein with EVH-1 domain 1, related sequence [Source:MGI Symbol;Acc:MGI:2 150 016]
Atp2b21.40E-120.25 015 0340.5860.4274.53E-08ATPase, Ca++ transporting, plasma membrane 2 [Source:MGI Symbol;Acc:MGI:105 368]
Exoc6b1.53E-12−0.25067150.4340.5244.93E-08exocyst complex component 6B [Source:MGI Symbol;Acc:MGI:1 923 164]
Itpr21.56E-120.25 815 6070.490.3455.02E-08inositol 1,4,5-triphosphate receptor 2 [Source:MGI Symbol;Acc:MGI:99 418]
Serpine21.96E-120.27 511 2770.4960.3486.32E-08serine (or cysteine) peptidase inhibitor, clade E, member 2 [Source:MGI Symbol;Acc:MGI:101 780]
Irak21.97E-120.26 542 0630.4680.3256.36E-08interleukin-1 receptor-associated kinase 2 [Source:MGI Symbol;Acc:MGI:2 429 603]
Fgf142.41E-12−0.27184350.760.8237.79E-08fibroblast growth factor 14 [Source:MGI Symbol;Acc:MGI:109 189]
2610035D17Rik3.32E-12−0.27191880.4060.5341.07E-07RIKEN cDNA 2610035D17 gene [Source:MGI Symbol;Acc:MGI:1 919 636]
Gli23.49E-120.25 442 8620.4650.3231.13E-07GLI-Kruppel family member GLI2 [Source:MGI Symbol;Acc:MGI:95 728]
Map46.20E-12−0.25090260.4780.5612.00E-07microtubule-associated protein 4 [Source:MGI Symbol;Acc:MGI:97 178]
Ptprj6.24E-120.31 704 5660.430.2882.02E-07protein tyrosine phosphatase, receptor type, J [Source:MGI Symbol;Acc:MGI:104 574]
Nnat7.56E-12−0.33234990.1710.2112.44E-07neuronatin [Source:MGI Symbol;Acc:MGI:104 716]
Fut98.43E-120.28 325 3660.6640.5642.72E-07fucosyltransferase 9 [Source:MGI Symbol;Acc:MGI:1 330 859]
Cpq1.19E-110.26 741 0010.5240.4343.83E-07carboxypeptidase Q [Source:MGI Symbol;Acc:MGI:1 889 205]
Pigk1.20E-110.25 920 6470.2630.1423.86E-07phosphatidylinositol glycan anchor biosynthesis, class K [Source:MGI Symbol;Acc:MGI:1 913 863]
Grid11.20E-110.25 653 8330.4520.3093.88E-07glutamate receptor, ionotropic, delta 1 [Source:MGI Symbol;Acc:MGI:95 812]
Plpp32.08E-110.27 305 6680.7940.7116.72E-07phospholipid phosphatase 3 [Source:MGI Symbol;Acc:MGI:1 915 166]
Tbc1d52.18E-11−0.25629020.3960.4637.05E-07TBC1 domain family, member 5 [Source:MGI Symbol;Acc:MGI:1 919 488]
Znrf32.20E-110.25 537 2480.5420.4127.12E-07zinc and ring finger 3 [Source:MGI Symbol;Acc:MGI:3 039 616]
Zfhx33.18E-11−0.28845420.3670.4521.03E-06zinc finger homeobox 3 [Source:MGI Symbol;Acc:MGI:99 948]
Hivep34.73E-110.2 583 2130.7320.6171.53E-06human immunodeficiency virus type I enhancer binding protein 3 [Source:MGI Symbol;Acc:MGI:106 589]
Nr3c25.97E-110.28 553 2910.6330.5211.93E-06nuclear receptor subfamily 3, group C, member 2 [Source:MGI Symbol;Acc:MGI:99 459]
Nav36.01E-110.32 715 6190.5190.3691.94E-06neuron navigator 3 [Source:MGI Symbol;Acc:MGI:2 183 703]
Rfx46.35E-11−0.32866310.5220.6242.05E-06regulatory factor X, 4 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:1 918 387]
Ank7.92E-11−0.25649490.4180.4932.56E-06progressive ankylosis [Source:MGI Symbol;Acc:MGI:3 045 421]
Rorb8.58E-110.28 096 1340.8630.7662.77E-06RAR-related orphan receptor beta [Source:MGI Symbol;Acc:MGI:1 343 464]
Paqr89.40E-100.26 548 7410.680.5853.03E-05progestin and adipoQ receptor family member VIII [Source:MGI Symbol;Acc:MGI:1 921 479]
Dlgap11.02E-090.25 343 1480.850.7583.28E-05DLG associated protein 1 [Source:MGI Symbol;Acc:MGI:1 346 065]
Pcdh91.62E-090.30 264 9330.9920.9595.25E-05protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Grm32.89E-090.43 138 1540.5690.4699.32E-05glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Cdh201.24E-080.27 398 5620.7170.650.000 399 728cadherin 20 [Source:MGI Symbol;Acc:MGI:1 346 069]
Fam155a1.75E-08−0.4497730.2930.3960.00 056 492NA
Lhfp5.61E-080.30 326 9220.560.460.001 810 805lipoma HMGIC fusion partner [Source:MGI Symbol;Acc:MGI:1 920 048]
Genep_valavg_log2FCpct.1pct.2p_val_adjdescription
St6galnac31.53E-241−1.59362790.0990.5374.95E-237ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Ablim21.04E-231−1.64232250.1320.4723.36E-227actin-binding LIM protein 2 [Source:MGI Symbol;Acc:MGI:2 385 758]
Nkain21.31E-205−1.78428380.4360.7114.24E-201Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Gpc53.70E-1561.4 386 1110.9850.6551.19E-151glypican 5 [Source:MGI Symbol;Acc:MGI:1 194 894]
Lsamp2.79E-1491.03 552 76610.9969.01E-145limbic system-associated membrane protein [Source:MGI Symbol;Acc:MGI:1 261 760]
Pkp48.39E-146−1.0036560.2150.542.71E-141plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Gfap4.94E-145−1.44464860.2080.5361.60E-140glial fibrillary acidic protein [Source:MGI Symbol;Acc:MGI:95 697]
Prune24.16E-140−1.05526780.1270.4761.34E-135prune homolog 2 [Source:MGI Symbol;Acc:MGI:1 925 004]
Grik22.62E-136−1.16448380.4440.7458.45E-132glutamate receptor, ionotropic, kainate 2 (beta 2) [Source:MGI Symbol;Acc:MGI:95 815]
Prr5l2.29E-127−1.00589180.050.3527.38E-123proline rich 5 like [Source:MGI Symbol;Acc:MGI:1 919 696]
Slc8a11.72E-121−1.01436890.2180.5235.56E-117solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Trpm31.51E-1171.51 328 0140.9520.5634.88E-113transient receptor potential cation channel, subfamily M, member 3 [Source:MGI Symbol;Acc:MGI:2 443 101]
Sorbs22.64E-116−1.16436880.1720.4678.53E-112sorbin and SH3 domain containing 2 [Source:MGI Symbol;Acc:MGI:1 924 574]
Gm37641.75E-1120.96 079 9840.9520.7495.65E-108predicted gene 3764 [Source:MGI Symbol;Acc:MGI:3 781 938]
Adamtsl14.27E-109−0.84474680.020.3161.38E-104ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
Cacnb24.88E-109−1.14120210.2510.5281.58E-104calcium channel, voltage-dependent, beta 2 subunit [Source:MGI Symbol;Acc:MGI:894 644]
Kirrel33.05E-1081.28 033 1720.890.5289.85E-104kirre like nephrin family adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 914 953]
Mdga28.42E-950.93 802 8950.9790.852.72E-90MAM domain containing glycosylphosphatidylinositol anchor 2 [Source:MGI Symbol;Acc:MGI:2 444 706]
Cobll14.35E-94−0.59498850.0440.3181.41E-89Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Slc38a11.99E-92−0.89661440.2320.5076.42E-88solute carrier family 38, member 1 [Source:MGI Symbol;Acc:MGI:2 145 895]
Ccdc1484.14E-92−0.78608480.0530.2911.34E-87coiled-coil domain containing 148 [Source:MGI Symbol;Acc:MGI:3 039 583]
Nrxn14.43E-920.87 728 2530.9980.911.43E-87neurexin I [Source:MGI Symbol;Acc:MGI:1 096 391]
Plcb11.88E-911.13 264 8610.9510.7486.07E-87phospholipase C, beta 1 [Source:MGI Symbol;Acc:MGI:97 613]
A2m4.93E-90−0.88175570.0650.2981.59E-85alpha-2-macroglobulin [Source:MGI Symbol;Acc:MGI:2 449 119]
Tmeff26.26E-89−0.85731650.1580.3532.02E-84transmembrane protein with EGF-like and two follistatin-like domains 2 [Source:MGI Symbol;Acc:MGI:1 861 735]
Dgki8.89E-87−0.77686950.2210.5362.87E-82diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Kcnd21.16E-841.29 103 5480.720.443.74E-80potassium voltage-gated channel, Shal-related family, member 2 [Source:MGI Symbol;Acc:MGI:102 663]
Pdzrn31.83E-84−0.6136950.0840.3725.89E-80PDZ domain containing RING finger 3 [Source:MGI Symbol;Acc:MGI:1 933 157]
Slc24a22.21E-83−0.89372330.3150.4277.15E-79solute carrier family 24 (sodium/potassium/calcium exchanger), member 2 [Source:MGI Symbol;Acc:MGI:1 923 626]
Gria25.83E-830.91 744 6170.7750.4931.88E-78glutamate receptor, ionotropic, AMPA2 (alpha 2) [Source:MGI Symbol;Acc:MGI:95 809]
Grm71.28E-82−0.85193080.2120.4364.12E-78glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Gm207132.19E-810.85 012 0780.7270.2837.08E-77predicted gene 20 713 [Source:MGI Symbol;Acc:MGI:5 313 160]
Cadps1.18E-80−0.81690650.2990.5713.79E-76Ca2+-dependent secretion activator [Source:MGI Symbol;Acc:MGI:1 350 922]
Rora2.23E-780.80 516 0940.9910.9597.20E-74RAR-related orphan receptor alpha [Source:MGI Symbol;Acc:MGI:104 661]
Kcnj31.93E-77−0.69385630.1580.4536.24E-73potassium inwardly-rectifying channel, subfamily J, member 3 [Source:MGI Symbol;Acc:MGI:104 742]
Slc6a112.45E-770.82 740 9090.5970.3027.92E-73solute carrier family 6 (neurotransmitter transporter, GABA), member 11 [Source:MGI Symbol;Acc:MGI:95 630]
Gm149645.63E-76−0.58123850.1540.4031.82E-71predicted gene 14 964 [Source:MGI Symbol;Acc:MGI:3 641 621]
Slc7a108.30E-750.80 503 3510.570.1722.68E-70solute carrier family 7 (cationic amino acid transporter, y + system), member 10 [Source:MGI Symbol;Acc:MGI:1 858 261]
Ccdc31.94E-73−0.56467980.020.2446.25E-69coiled-coil domain containing 3 [Source:MGI Symbol;Acc:MGI:1 921 436]
Prickle28.03E-73−0.7091480.3450.6072.59E-68prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
Brinp31.40E-700.82 937 7710.7160.3534.52E-66bone morphogenetic protein/retinoic acid inducible neural specific 3 [Source:MGI Symbol;Acc:MGI:2 443 035]
Pex5l1.61E-70−0.83276840.1830.3295.20E-66peroxisomal biogenesis factor 5-like [Source:MGI Symbol;Acc:MGI:1 916 672]
Prkca2.52E-70−0.77768890.5510.7528.12E-66protein kinase C, alpha [Source:MGI Symbol;Acc:MGI:97 595]
Asap37.08E-70−0.45261050.0250.2392.29E-65ArfGAP with SH3 domain, ankyrin repeat and PH domain 3 [Source:MGI Symbol;Acc:MGI:2 684 986]
St188.32E-70−0.70185880.0630.2252.69E-65suppression of tumorigenicity 18 [Source:MGI Symbol;Acc:MGI:2 446 700]
Ldb21.58E-69−0.57966620.1140.3595.09E-65LIM domain binding 2 [Source:MGI Symbol;Acc:MGI:894 670]
Edil32.54E-69−0.689130.1780.3628.21E-65EGF-like repeats and discoidin I-like domains 3 [Source:MGI Symbol;Acc:MGI:1 329 025]
Unc5c5.97E-68−0.73579040.1820.421.93E-63unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Gm122399.70E-681.08 440 5170.5810.2423.13E-63predicted gene 12 239 [Source:MGI Symbol;Acc:MGI:3 651 547]
C4b1.35E-67−0.51007120.0660.3124.35E-63complement component 4B (Chido blood group) [Source:MGI Symbol;Acc:MGI:88 228]
Tmem1082.42E-67−0.5227890.0430.2457.80E-63transmembrane protein 108 [Source:MGI Symbol;Acc:MGI:1 932 411]
Dock102.55E-66−0.6171340.1050.2668.24E-62dedicator of cytokinesis 10 [Source:MGI Symbol;Acc:MGI:2 146 320]
Gm48761.07E-65−0.61758020.1280.3683.45E-61predicted gene 4876 [Source:MGI Symbol;Acc:MGI:3 647 654]
Sulf21.90E-64−0.42984590.0340.2386.14E-60sulfatase 2 [Source:MGI Symbol;Acc:MGI:1 919 293]
Col23a12.45E-64−0.8123560.1120.347.92E-60collagen, type XXIII, alpha 1 [Source:MGI Symbol;Acc:MGI:2 653 243]
Prkag26.39E-63−0.56851360.1560.3762.06E-58protein kinase, AMP-activated, gamma 2 non-catalytic subunit [Source:MGI Symbol;Acc:MGI:1 336 153]
Ctnna22.00E-61−0.85708440.6690.8096.45E-57catenin (cadherin associated protein), alpha 2 [Source:MGI Symbol;Acc:MGI:88 275]
Myoc1.78E-60−0.57942840.0110.1885.74E-56myocilin [Source:MGI Symbol;Acc:MGI:1 202 864]
Enpp22.58E-60−0.52837730.2120.4538.33E-56ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
Frmd56.05E-60−0.67540120.1030.2551.95E-55FERM domain containing 5 [Source:MGI Symbol;Acc:MGI:2 442 557]
Sema6a9.70E-60−0.41414330.0590.2833.13E-55sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
Arhgef41.15E-59−0.73589960.5650.6973.70E-55Rho guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:2 442 507]
Zfp5365.69E-59−0.52649440.0440.2041.84E-54zinc finger protein 536 [Source:MGI Symbol;Acc:MGI:1 926 102]
Enox11.09E-58−0.71177450.2490.5043.51E-54ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Pakap8.14E-57−0.4203850.0330.2142.63E-52paralemmin A kinase anchor protein [Source:MGI Symbol;Acc:MGI:5 141 924]
Man1c11.77E-56−0.46972530.0590.2565.71E-52mannosidase, alpha, class 1C, member 1 [Source:MGI Symbol;Acc:MGI:2 446 214]
Nrp22.58E-56−0.39141450.0430.2368.32E-52neuropilin 2 [Source:MGI Symbol;Acc:MGI:1 100 492]
Csmd14.93E-56−0.59264430.3860.5441.59E-51CUB and Sushi multiple domains 1 [Source:MGI Symbol;Acc:MGI:2 137 383]
Nhsl17.81E-560.7 363 4140.7370.4432.52E-51NHS-like 1 [Source:MGI Symbol;Acc:MGI:106 390]
Cd443.70E-55−0.4325580.0220.1981.19E-50CD44 antigen [Source:MGI Symbol;Acc:MGI:88 338]
Dnm31.96E-54−0.56683620.2810.5116.32E-50dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Pde4b2.27E-54−0.7656010.5480.5067.32E-50phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Atp1a26.26E-540.67 797 4270.9380.8112.02E-49ATPase, Na+/K + transporting, alpha 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 106]
Pacrg7.92E-54−0.61658490.2790.5472.56E-49PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Rgs71.69E-530.75 771 7180.6530.3425.44E-49regulator of G protein signaling 7 [Source:MGI Symbol;Acc:MGI:1 346 089]
Pitpnc11.79E-530.77 375 0720.9160.7615.79E-49phosphatidylinositol transfer protein, cytoplasmic 1 [Source:MGI Symbol;Acc:MGI:1 919 045]
Pde7b2.22E-530.75 004 2570.7130.3797.18E-49phosphodiesterase 7B [Source:MGI Symbol;Acc:MGI:1 352 752]
Sorbs14.64E-53−0.70896350.6330.7791.50E-48sorbin and SH3 domain containing 1 [Source:MGI Symbol;Acc:MGI:700 014]
Kif21a6.38E-53−0.4973930.3880.6232.06E-48kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
Ccser19.85E-53−0.65703470.2760.4463.18E-48coiled-coil serine rich 1 [Source:MGI Symbol;Acc:MGI:3 045 354]
Adgrb31.78E-520.71 451 4760.960.895.76E-48adhesion G protein-coupled receptor B3 [Source:MGI Symbol;Acc:MGI:2 441 837]
Sntg24.21E-52−0.34334370.0150.1911.36E-47syntrophin, gamma 2 [Source:MGI Symbol;Acc:MGI:1 919 541]
Mbp6.86E-52−0.5974130.3760.5132.21E-47myelin basic protein [Source:MGI Symbol;Acc:MGI:96 925]
Tmem132b3.47E-51−0.34043890.0620.2641.12E-46transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Phyhd12.24E-50−0.50595120.2210.4527.24E-46phytanoyl-CoA dioxygenase domain containing 1 [Source:MGI Symbol;Acc:MGI:3 612 860]
Glis33.59E-50−0.62542110.5240.7151.16E-45GLIS family zinc finger 3 [Source:MGI Symbol;Acc:MGI:2 444 289]
Elmo17.87E-50−0.52881910.1040.2682.54E-45engulfment and cell motility 1 [Source:MGI Symbol;Acc:MGI:2 153 044]
Car102.40E-490.85 983 3940.4940.2827.75E-45carbonic anhydrase 10 [Source:MGI Symbol;Acc:MGI:1 919 855]
Ptch13.37E-490.70 455 4390.5810.2851.09E-44patched 1 [Source:MGI Symbol;Acc:MGI:105 373]
Aebp11.40E-48−0.34100280.0110.1824.52E-44AE binding protein 1 [Source:MGI Symbol;Acc:MGI:1 197 012]
Pcdh72.00E-480.5 983 1060.8860.7446.47E-44protocadherin 7 [Source:MGI Symbol;Acc:MGI:1 860 487]
Dok66.61E-48−0.54490440.1560.3822.13E-43docking protein 6 [Source:MGI Symbol;Acc:MGI:3 639 495]
Garnl31.52E-47−0.37356950.0830.2664.90E-43GTPase activating RANGAP domain-like 3 [Source:MGI Symbol;Acc:MGI:2 139 309]
Robo21.53E-47−0.67838390.5650.7284.95E-43roundabout guidance receptor 2 [Source:MGI Symbol;Acc:MGI:1 890 110]
Synpo24.98E-47−0.62419530.1620.3931.61E-42synaptopodin 2 [Source:MGI Symbol;Acc:MGI:2 153 070]
Zeb25.73E-46−0.54897780.5140.6571.85E-41zinc finger E-box binding homeobox 2 [Source:MGI Symbol;Acc:MGI:1 344 407]
Padi25.77E-46−0.45318580.1240.3361.86E-41peptidyl arginine deiminase, type II [Source:MGI Symbol;Acc:MGI:1 338 892]
C530044C16Rik5.84E-46−0.34399180.0110.1621.89E-41RIKEN cDNA C530044C16 gene [Source:MGI Symbol;Acc:MGI:2 443 109]
Reep12.13E-44−0.44857350.0710.2396.88E-40receptor accessory protein 1 [Source:MGI Symbol;Acc:MGI:1 098 827]
Map76.02E-44−0.46314340.1470.2981.94E-39microtubule-associated protein 7 [Source:MGI Symbol;Acc:MGI:1 328 328]
Atp13a46.00E-430.52 133 6030.4980.2191.94E-38ATPase type 13A4 [Source:MGI Symbol;Acc:MGI:1 924 456]
Cpne83.12E-42−0.29628670.0350.1921.01E-37copine VIII [Source:MGI Symbol;Acc:MGI:1 914 121]
Tagln33.76E-42−0.45100630.2970.4871.21E-37transgelin 3 [Source:MGI Symbol;Acc:MGI:1 926 784]
Frmd4a4.71E-420.63 758 1730.9350.7821.52E-37FERM domain containing 4A [Source:MGI Symbol;Acc:MGI:1 919 850]
Sema3a7.94E-42−0.37426410.0310.1742.56E-37sema domain, immunoglobulin domain (Ig), short basic domain, secreted, (semaphorin) 3A [Source:MGI Symbol;Acc:MGI:107 558]
Tnc1.52E-41−0.28987480.0190.1774.89E-37tenascin C [Source:MGI Symbol;Acc:MGI:101 922]
Cacnb45.46E-41−0.55386590.2310.4231.76E-36calcium channel, voltage-dependent, beta 4 subunit [Source:MGI Symbol;Acc:MGI:103 301]
Neat16.65E-41−0.64808040.5210.6272.15E-36nuclear paraspeckle assembly transcript 1 (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 914 211]
Ano43.04E-40−0.37170070.0740.2099.82E-36anoctamin 4 [Source:MGI Symbol;Acc:MGI:2 443 344]
Adamts94.01E-40−0.51521880.1950.4191.29E-35a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 9 [Source:MGI Symbol;Acc:MGI:1 916 320]
Luzp24.27E-400.98 895 0870.9030.6811.38E-35leucine zipper protein 2 [Source:MGI Symbol;Acc:MGI:1 889 615]
March16.66E-40−0.4157750.0850.2212.15E-35NA
Igfbp57.96E-40−0.40115060.0920.2812.57E-35insulin-like growth factor binding protein 5 [Source:MGI Symbol;Acc:MGI:96 440]
Hecw29.58E-40−0.39168580.090.2153.09E-35HECT, C2 and WW domain containing E3 ubiquitin protein ligase 2 [Source:MGI Symbol;Acc:MGI:2 685 817]
Ank21.52E-39−0.69756270.9540.9494.92E-35ankyrin 2, brain [Source:MGI Symbol;Acc:MGI:88 025]
Trp632.59E-390.64 506 9460.3240.1118.35E-35transformation related protein 63 [Source:MGI Symbol;Acc:MGI:1 330 810]
Adgrl32.95E-390.53 274 2270.9060.7969.52E-35adhesion G protein-coupled receptor L3 [Source:MGI Symbol;Acc:MGI:2 441 950]
9530026P05Rik1.12E-38−0.59699570.2250.4223.61E-34RIKEN cDNA 9530026P05 gene [Source:MGI Symbol;Acc:MGI:1 924 659]
Fmn12.01E-38−0.57518580.1950.3586.49E-34formin 1 [Source:MGI Symbol;Acc:MGI:101 815]
D7Ertd443e3.39E-38−0.29014660.0260.161.09E-33DNA segment, Chr 7, ERATO Doi 443, expressed [Source:MGI Symbol;Acc:MGI:1 196 431]
Tex117.26E-38−0.25602360.0110.152.34E-33testis expressed gene 11 [Source:MGI Symbol;Acc:MGI:1 933 237]
Sema6d1.10E-37−0.73744820.5280.6643.54E-33sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6D [Source:MGI Symbol;Acc:MGI:2 387 661]
Tulp42.02E-37−0.44931220.3790.5636.51E-33tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Aqp43.92E-37−0.4956280.4040.5931.27E-32aquaporin 4 [Source:MGI Symbol;Acc:MGI:107 387]
Dscaml16.17E-37−0.32478570.0310.1451.99E-32DS cell adhesion molecule like 1 [Source:MGI Symbol;Acc:MGI:2 150 309]
Eya49.63E-37−0.36639930.0930.2683.11E-32EYA transcriptional coactivator and phosphatase 4 [Source:MGI Symbol;Acc:MGI:1 337 104]
Thbs42.03E-36−0.28644410.0070.1286.56E-32thrombospondin 4 [Source:MGI Symbol;Acc:MGI:1 101 779]
Apbb1ip2.03E-36−0.27603990.0120.1646.57E-32amyloid beta (A4) precursor protein-binding, family B, member 1 interacting protein [Source:MGI Symbol;Acc:MGI:1 861 354]
Ank32.07E-36−0.43101190.2380.3666.67E-32ankyrin 3, epithelial [Source:MGI Symbol;Acc:MGI:88 026]
Slc4a42.32E-360.53 869 8480.9270.8467.47E-32solute carrier family 4 (anion exchanger), member 4 [Source:MGI Symbol;Acc:MGI:1 927 555]
Syne12.48E-360.48 914 0070.8840.7748.02E-32spectrin repeat containing, nuclear envelope 1 [Source:MGI Symbol;Acc:MGI:1 927 152]
Cadm28.59E-360.47 857 2720.9920.922.77E-31cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:2 442 722]
Pxdn3.14E-35−0.29168010.0710.2221.02E-30peroxidasin [Source:MGI Symbol;Acc:MGI:1 916 925]
Cmya54.19E-35−0.33401310.0930.2721.35E-30cardiomyopathy associated 5 [Source:MGI Symbol;Acc:MGI:1 923 719]
4930402H24Rik5.42E-35−0.48683070.830.861.75E-30NA
Reln6.39E-35−0.43203110.110.2952.06E-30reelin [Source:MGI Symbol;Acc:MGI:103 022]
Retreg19.38E-35−0.29235920.0960.2663.03E-30reticulophagy regulator 1 [Source:MGI Symbol;Acc:MGI:1 913 520]
Gpld11.38E-340.46 185 2080.3950.1514.47E-30glycosylphosphatidylinositol specific phospholipase D1 [Source:MGI Symbol;Acc:MGI:106 604]
Plp11.47E-34−0.4348560.5990.7314.76E-30proteolipid protein (myelin) 1 [Source:MGI Symbol;Acc:MGI:97 623]
Mapt2.50E-34−0.44176690.4270.568.06E-30microtubule-associated protein tau [Source:MGI Symbol;Acc:MGI:97 180]
Eps82.62E-340.47 960 3480.5370.2748.46E-30epidermal growth factor receptor pathway substrate 8 [Source:MGI Symbol;Acc:MGI:104 684]
Tab23.98E-34−0.38333140.2510.451.28E-29TGF-beta activated kinase 1/MAP3K7 binding protein 2 [Source:MGI Symbol;Acc:MGI:1 915 902]
Dock44.61E-340.53 604 3730.8150.6411.49E-29dedicator of cytokinesis 4 [Source:MGI Symbol;Acc:MGI:1 918 006]
Ptprk2.18E-33−0.32661880.0860.2197.02E-29protein tyrosine phosphatase, receptor type, K [Source:MGI Symbol;Acc:MGI:103 310]
Airn4.11E-33−0.31793050.0540.1841.33E-28antisense Igf2r RNA [Source:MGI Symbol;Acc:MGI:1 353 471]
Erbin2.15E-32−0.41815980.2990.466.94E-28Erbb2 interacting protein [Source:MGI Symbol;Acc:MGI:1 890 169]
Plxdc22.72E-32−0.43980.2670.4438.77E-28plexin domain containing 2 [Source:MGI Symbol;Acc:MGI:1 914 698]
Vav33.24E-320.49 950 3790.4460.1871.05E-27vav 3 oncogene [Source:MGI Symbol;Acc:MGI:1 888 518]
Sh3d194.83E-32−0.25908980.0410.1711.56E-27SH3 domain protein D19 [Source:MGI Symbol;Acc:MGI:1 350 923]
Gm106356.44E-32−0.31841620.0230.152.08E-27predicted gene 10 635 [Source:MGI Symbol;Acc:MGI:3 641 740]
Itih31.22E-310.46 778 9670.3420.1283.95E-27inter-alpha trypsin inhibitor, heavy chain 3 [Source:MGI Symbol;Acc:MGI:96 620]
Kcnma11.29E-310.58 278 3970.6720.4164.18E-27potassium large conductance calcium-activated channel, subfamily M, alpha member 1 [Source:MGI Symbol;Acc:MGI:99 923]
Acsbg11.66E-310.46 229 4430.6060.4065.36E-27acyl-CoA synthetase bubblegum family member 1 [Source:MGI Symbol;Acc:MGI:2 385 656]
Naaladl22.22E-31−0.50596970.3140.5287.16E-27N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Rps6ka52.78E-31−0.35757310.2040.3958.99E-27ribosomal protein S6 kinase, polypeptide 5 [Source:MGI Symbol;Acc:MGI:1 920 336]
Mobp3.94E-31−0.3479790.1350.2581.27E-26myelin-associated oligodendrocytic basic protein [Source:MGI Symbol;Acc:MGI:108 511]
Cdh109.07E-310.49 836 4990.7380.5362.93E-26cadherin 10 [Source:MGI Symbol;Acc:MGI:107 436]
Cadm11.31E-300.50 571 3360.8350.6484.24E-26cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:1 889 272]
Arhgap61.40E-30−0.25423430.0340.1444.51E-26Rho GTPase activating protein 6 [Source:MGI Symbol;Acc:MGI:1 196 332]
Dner2.35E-30−0.3441610.1730.337.57E-26delta/notch-like EGF repeat containing [Source:MGI Symbol;Acc:MGI:2 152 889]
Disp32.80E-30−0.30234690.0770.1999.04E-26dispatched RND transporter family member 3 [Source:MGI Symbol;Acc:MGI:2 444 403]
Npas34.84E-300.46 551 2690.9850.9431.56E-25neuronal PAS domain protein 3 [Source:MGI Symbol;Acc:MGI:1 351 610]
Id36.28E-30−0.3400750.1340.3122.03E-25inhibitor of DNA binding 3 [Source:MGI Symbol;Acc:MGI:96 398]
Kalrn6.35E-300.44 370 4620.5660.3212.05E-25kalirin, RhoGEF kinase [Source:MGI Symbol;Acc:MGI:2 685 385]
Fgfr31.96E-290.41 311 4010.6340.4576.32E-25fibroblast growth factor receptor 3 [Source:MGI Symbol;Acc:MGI:95 524]
Agap12.08E-29−0.34621550.1980.3436.72E-25ArfGAP with GTPase domain, ankyrin repeat and PH domain 1 [Source:MGI Symbol;Acc:MGI:2 653 690]
Bin12.61E-29−0.29684230.130.2628.41E-25bridging integrator 1 [Source:MGI Symbol;Acc:MGI:108 092]
Tspan73.06E-290.46 649 1080.7840.639.89E-25tetraspanin 7 [Source:MGI Symbol;Acc:MGI:1 298 407]
Cables13.75E-290.43 697 1520.470.2181.21E-24CDK5 and Abl enzyme substrate 1 [Source:MGI Symbol;Acc:MGI:1 927 065]
Ddr14.57E-29−0.29183040.1340.2881.47E-24discoidin domain receptor family, member 1 [Source:MGI Symbol;Acc:MGI:99 216]
Ano14.74E-29−0.32992270.0030.1441.53E-24anoctamin 1, calcium activated chloride channel [Source:MGI Symbol;Acc:MGI:2 142 149]
Grin2c7.34E-290.38 585 4430.4280.1882.37E-24glutamate receptor, ionotropic, NMDA2C (epsilon 3) [Source:MGI Symbol;Acc:MGI:95 822]
Slco1c18.32E-290.44 635 9410.4590.2352.69E-24solute carrier organic anion transporter family, member 1c1 [Source:MGI Symbol;Acc:MGI:1 889 679]
Trim29.96E-29−0.37651730.3080.4913.21E-24tripartite motif-containing 2 [Source:MGI Symbol;Acc:MGI:1 933 163]
Fat31.02E-280.48 826 9490.6850.5263.29E-24FAT atypical cadherin 3 [Source:MGI Symbol;Acc:MGI:2 444 314]
Spock11.36E-28−0.30109010.1110.2284.39E-24sparc/osteonectin, cwcv and kazal-like domains proteoglycan 1 [Source:MGI Symbol;Acc:MGI:105 371]
Grin3a1.95E-28−0.39370810.1380.2936.30E-24glutamate receptor ionotropic, NMDA3A [Source:MGI Symbol;Acc:MGI:1 933 206]
Ptprg2.33E-280.48 924 4260.6420.4967.51E-24NA
Nwd12.35E-280.41 679 6270.7050.5067.59E-24NACHT and WD repeat domain containing 1 [Source:MGI Symbol;Acc:MGI:2 442 268]
Wwox3.10E-28−0.5667150.5260.6781.00E-23WW domain-containing oxidoreductase [Source:MGI Symbol;Acc:MGI:1 931 237]
Cep85l6.31E-280.4 097 8750.5780.3822.04E-23centrosomal protein 85-like [Source:MGI Symbol;Acc:MGI:3 642 684]
Gria46.44E-280.59 105 0450.4260.2582.08E-23glutamate receptor, ionotropic, AMPA4 (alpha 4) [Source:MGI Symbol;Acc:MGI:95 811]
Nxn9.83E-28−0.47264220.4210.5953.17E-23nucleoredoxin [Source:MGI Symbol;Acc:MGI:109 331]
2610307P16Rik1.27E-27−0.31659830.0640.1984.11E-23RIKEN cDNA 2610307P16 gene [Source:MGI Symbol;Acc:MGI:1 919 768]
Ccdc85a1.29E-270.47 682 1040.5240.2824.16E-23coiled-coil domain containing 85A [Source:MGI Symbol;Acc:MGI:2 445 069]
Grid22.01E-270.48 400 7850.910.7616.50E-23glutamate receptor, ionotropic, delta 2 [Source:MGI Symbol;Acc:MGI:95 813]
Nrbp23.89E-27−0.3131650.1840.3551.25E-22nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Etv46.28E-270.34 377 1190.2810.0732.03E-22ets variant 4 [Source:MGI Symbol;Acc:MGI:99 423]
Cep1126.56E-27−0.25664220.0720.2252.12E-22centrosomal protein 112 [Source:MGI Symbol;Acc:MGI:1 923 673]
Rnf2201.42E-26−0.38293090.1610.2424.60E-22ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Rtn43.75E-26−0.35591380.5030.6521.21E-21reticulon 4 [Source:MGI Symbol;Acc:MGI:1 915 835]
Klhl294.42E-26−0.28145850.1230.2781.43E-21kelch-like 29 [Source:MGI Symbol;Acc:MGI:2 683 857]
Sorcs17.06E-26−0.32927210.1120.2262.28E-21sortilin-related VPS10 domain containing receptor 1 [Source:MGI Symbol;Acc:MGI:1 929 666]
App8.22E-26−0.36787750.5210.6422.65E-21amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Grk31.23E-250.38 379 0140.5720.3393.97E-21G protein-coupled receptor kinase 3 [Source:MGI Symbol;Acc:MGI:87 941]
Atp1b21.53E-250.45 621 0180.5410.4264.95E-21ATPase, Na+/K + transporting, beta 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 109]
Bmp61.82E-25−0.25663580.0390.165.88E-21bone morphogenetic protein 6 [Source:MGI Symbol;Acc:MGI:88 182]
Ndrg21.93E-250.40 022 6160.730.626.22E-21N-myc downstream regulated gene 2 [Source:MGI Symbol;Acc:MGI:1 352 498]
Mgat4c3.09E-250.47 103 3120.5650.4799.97E-21MGAT4 family, member C [Source:MGI Symbol;Acc:MGI:1 914 819]
Pdgfd5.25E-25−0.43084350.390.5281.69E-20platelet-derived growth factor, D polypeptide [Source:MGI Symbol;Acc:MGI:1 919 035]
Nav26.00E-25−0.42033420.5210.641.94E-20neuron navigator 2 [Source:MGI Symbol;Acc:MGI:2 183 691]
Shc39.06E-250.35 170 7430.3870.1722.92E-20src homology 2 domain-containing transforming protein C3 [Source:MGI Symbol;Acc:MGI:106 179]
Plscr41.07E-24−0.26351470.0990.2513.44E-20phospholipid scramblase 4 [Source:MGI Symbol;Acc:MGI:2 143 267]
Dgkb1.55E-240.41 451 4060.8990.7885.02E-20diacylglycerol kinase, beta [Source:MGI Symbol;Acc:MGI:2 442 474]
Fry1.97E-240.38 056 9650.6770.5676.35E-20FRY microtubule binding protein [Source:MGI Symbol;Acc:MGI:2 443 895]
Tnik2.85E-240.39 465 1720.9260.8529.19E-20TRAF2 and NCK interacting kinase [Source:MGI Symbol;Acc:MGI:1 916 264]
Slc1a24.57E-240.38 376 7960.9990.9761.47E-19solute carrier family 1 (glial high affinity glutamate transporter), member 2 [Source:MGI Symbol;Acc:MGI:101 931]
Tmc74.76E-240.36 285 4910.3430.1521.54E-19transmembrane channel-like gene family 7 [Source:MGI Symbol;Acc:MGI:2 443 317]
Nrcam5.21E-240.38 906 2530.8310.6841.68E-19neuronal cell adhesion molecule [Source:MGI Symbol;Acc:MGI:104 750]
Pgm51.33E-23−0.26781540.0340.1614.28E-19phosphoglucomutase 5 [Source:MGI Symbol;Acc:MGI:1 925 668]
Rapgef41.55E-23−0.30338410.1230.2365.00E-19Rap guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:1 917 723]
Adipor22.96E-23−0.29242370.1520.2419.56E-19adiponectin receptor 2 [Source:MGI Symbol;Acc:MGI:93 830]
Gabbr28.65E-230.40 045 0430.330.1512.79E-18gamma-aminobutyric acid (GABA) B receptor, 2 [Source:MGI Symbol;Acc:MGI:2 386 030]
Phactr31.14E-220.36 083 1550.5180.2853.68E-18phosphatase and actin regulator 3 [Source:MGI Symbol;Acc:MGI:1 921 439]
Dst1.39E-22−0.36711630.6210.7184.49E-18dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Gjb61.94E-220.31 796 4270.3470.1646.27E-18gap junction protein, beta 6 [Source:MGI Symbol;Acc:MGI:107 588]
Dip2b2.13E-22−0.3137080.3440.4876.89E-18disco interacting protein 2 homolog B [Source:MGI Symbol;Acc:MGI:2 145 977]
Ntng13.12E-22−0.31572520.0620.1771.01E-17netrin G1 [Source:MGI Symbol;Acc:MGI:1 934 028]
Frmpd43.81E-22−0.26677090.1360.2341.23E-17FERM and PDZ domain containing 4 [Source:MGI Symbol;Acc:MGI:3 042 378]
Kcnip33.99E-220.37 212 3660.3770.1871.29E-17Kv channel interacting protein 3, calsenilin [Source:MGI Symbol;Acc:MGI:1 929 258]
Ppp1r16b4.87E-22−0.26358730.0940.1741.57E-17protein phosphatase 1, regulatory subunit 16B [Source:MGI Symbol;Acc:MGI:2 151 841]
Slc6a17.68E-220.35 533 7630.6010.4422.48E-17solute carrier family 6 (neurotransmitter transporter, GABA), member 1 [Source:MGI Symbol;Acc:MGI:95 627]
Sorcs28.98E-220.31 923 2460.3490.1612.90E-17sortilin-related VPS10 domain containing receptor 2 [Source:MGI Symbol;Acc:MGI:1 932 289]
Mpdz1.18E-21−0.264380.1550.2993.81E-17multiple PDZ domain crumbs cell polarity complex component [Source:MGI Symbol;Acc:MGI:1 343 489]
Tsc22d11.35E-21−0.27447680.2610.4154.35E-17TSC22 domain family, member 1 [Source:MGI Symbol;Acc:MGI:109 127]
Xylt11.69E-210.39 333 3490.5110.2885.45E-17xylosyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 451 073]
Ski2.22E-21−0.2875370.1710.3127.18E-17ski sarcoma viral oncogene homolog (avian) [Source:MGI Symbol;Acc:MGI:98 310]
Tenm42.83E-210.39 167 5450.4230.2519.12E-17teneurin transmembrane protein 4 [Source:MGI Symbol;Acc:MGI:2 447 063]
Ablim12.84E-210.35 555 5790.5170.3159.15E-17actin-binding LIM protein 1 [Source:MGI Symbol;Acc:MGI:1 194 500]
Ahcyl13.24E-210.36 060 6420.6680.5041.05E-16S-adenosylhomocysteine hydrolase-like 1 [Source:MGI Symbol;Acc:MGI:2 385 184]
Shroom35.82E-210.39 782 5920.4570.3191.88E-16shroom family member 3 [Source:MGI Symbol;Acc:MGI:1 351 655]
Mertk1.09E-200.43 718 9990.7980.6383.51E-16MER proto-oncogene tyrosine kinase [Source:MGI Symbol;Acc:MGI:96 965]
Wasf31.16E-200.33 069 6330.5510.3623.75E-16WASP family, member 3 [Source:MGI Symbol;Acc:MGI:2 658 986]
Myo162.10E-20−0.26815250.0950.2096.78E-16myosin XVI [Source:MGI Symbol;Acc:MGI:2 685 951]
9630028H03Rik2.28E-200.32 473 4260.3040.1257.38E-16RIKEN cDNA 9630028H03 gene [Source:MGI Symbol;Acc:MGI:2 444 526]
Plekha54.64E-20−0.27234810.2040.3521.50E-15pleckstrin homology domain containing, family A member 5 [Source:MGI Symbol;Acc:MGI:1 923 802]
Npas24.88E-200.38 493 5470.5710.3891.58E-15neuronal PAS domain protein 2 [Source:MGI Symbol;Acc:MGI:109 232]
St3gal41.26E-190.3 840 1030.5460.3434.07E-15ST3 beta-galactoside alpha-2,3-sialyltransferase 4 [Source:MGI Symbol;Acc:MGI:1 316 743]
Dmd1.92E-190.42 285 6190.8240.6986.19E-15dystrophin, muscular dystrophy [Source:MGI Symbol;Acc:MGI:94 909]
Myo5a1.96E-19−0.26387170.2090.3356.32E-15myosin VA [Source:MGI Symbol;Acc:MGI:105 976]
Ralgps23.83E-19−0.25903480.1680.3161.24E-14Ral GEF with PH domain and SH3 binding motif 2 [Source:MGI Symbol;Acc:MGI:1 925 505]
Tprkb5.94E-19−0.34531490.360.5041.92E-14Tp53rk binding protein [Source:MGI Symbol;Acc:MGI:1 917 036]
Plcl16.13E-19−0.40963640.5850.5211.98E-14phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Mgat56.17E-19−0.31846110.3260.4861.99E-14mannoside acetylglucosaminyltransferase 5 [Source:MGI Symbol;Acc:MGI:894 701]
Htra17.27E-190.36 090 7440.6620.4722.35E-14HtrA serine peptidase 1 [Source:MGI Symbol;Acc:MGI:1 929 076]
Vegfa7.45E-190.35 819 2410.5390.3732.41E-14vascular endothelial growth factor A [Source:MGI Symbol;Acc:MGI:103 178]
Nim1k1.14E-180.321 9310.4130.2413.68E-14NIM1 serine/threonine protein kinase [Source:MGI Symbol;Acc:MGI:2 442 399]
Nrg21.19E-18−0.30421890.2230.3733.84E-14neuregulin 2 [Source:MGI Symbol;Acc:MGI:1 098 246]
Hif1a1.93E-180.27 065 1160.2740.1386.25E-14hypoxia inducible factor 1, alpha subunit [Source:MGI Symbol;Acc:MGI:106 918]
Mical22.68E-180.32 752 0130.6480.4838.64E-14microtubule associated monooxygenase, calponin and LIM domain containing 2 [Source:MGI Symbol;Acc:MGI:2 444 947]
Lhfpl33.27E-18−0.39838020.2910.3751.05E-13lipoma HMGIC fusion partner-like 3 [Source:MGI Symbol;Acc:MGI:1 925 076]
Ntm3.91E-180.2 944 4280.9950.971.26E-13neurotrimin [Source:MGI Symbol;Acc:MGI:2 446 259]
Tafa14.53E-180.48 678 1360.3110.1651.46E-13TAFA chemokine like family member 1 [Source:MGI Symbol;Acc:MGI:2 443 695]
Arid5b5.38E-18−0.26222790.1420.2621.74E-13AT rich interactive domain 5B (MRF1-like) [Source:MGI Symbol;Acc:MGI:2 175 912]
Esrrg6.07E-180.36 245 5160.4910.3681.96E-13estrogen-related receptor gamma [Source:MGI Symbol;Acc:MGI:1 347 056]
Ankrd286.58E-18−0.29471650.3410.4832.13E-13ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Wdr177.20E-180.40 737 0870.8440.7512.32E-13WD repeat domain 17 [Source:MGI Symbol;Acc:MGI:1 924 662]
Fus7.50E-18−0.27191570.3640.5112.42E-13fused in sarcoma [Source:MGI Symbol;Acc:MGI:1 353 633]
Dpyd8.99E-18−0.297580.2540.3852.90E-13dihydropyrimidine dehydrogenase [Source:MGI Symbol;Acc:MGI:2 139 667]
Stard131.30E-17−0.37483710.3750.5414.20E-13StAR-related lipid transfer (START) domain containing 13 [Source:MGI Symbol;Acc:MGI:2 385 331]
Adcy81.36E-17−0.30606340.2410.3494.41E-13adenylate cyclase 8 [Source:MGI Symbol;Acc:MGI:1 341 110]
Ptprd1.76E-17−0.3245270.8480.8485.68E-13protein tyrosine phosphatase, receptor type, D [Source:MGI Symbol;Acc:MGI:97 812]
9630014M24Rik2.04E-170.26 701 2950.2730.1056.58E-13RIKEN cDNA 9630014M24 gene [Source:MGI Symbol;Acc:MGI:3 588 234]
Btbd92.29E-17−0.28980790.3360.4867.39E-13BTB (POZ) domain containing 9 [Source:MGI Symbol;Acc:MGI:1 916 625]
Auts22.68E-170.3 804 8110.9110.8028.65E-13autism susceptibility candidate 2 [Source:MGI Symbol;Acc:MGI:1 919 847]
Arhgap233.14E-17−0.27142860.2340.3221.01E-12Rho GTPase activating protein 23 [Source:MGI Symbol;Acc:MGI:3 697 726]
Pde10a3.38E-170.58 969 9390.4040.2341.09E-12phosphodiesterase 10A [Source:MGI Symbol;Acc:MGI:1 345 143]
Grip14.32E-170.31 380 7160.2810.1341.40E-12glutamate receptor interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 921 303]
St6galnac57.24E-170.32 665 3220.2550.1042.34E-12ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 5 [Source:MGI Symbol;Acc:MGI:1 349 471]
Ctnnd27.33E-170.29 063 9440.9810.9592.37E-12catenin (cadherin associated protein), delta 2 [Source:MGI Symbol;Acc:MGI:1 195 966]
Map2k67.54E-170.2 867 0680.3820.2052.43E-12mitogen-activated protein kinase kinase 6 [Source:MGI Symbol;Acc:MGI:1 346 870]
Gm351881.00E-160.33 492 2850.6420.4773.23E-12predicted gene, 35 188 [Source:MGI Symbol;Acc:MGI:5 594 347]
Kmt2c1.20E-160.32 629 1870.6490.5433.89E-12lysine (K)-specific methyltransferase 2C [Source:MGI Symbol;Acc:MGI:2 444 959]
Eda1.43E-16−0.31566060.210.3564.62E-12ectodysplasin-A [Source:MGI Symbol;Acc:MGI:1 195 272]
Egfr1.70E-160.3 217 7370.4580.2585.49E-12epidermal growth factor receptor [Source:MGI Symbol;Acc:MGI:95 294]
Negr12.09E-160.37 537 6390.8530.6976.76E-12neuronal growth regulator 1 [Source:MGI Symbol;Acc:MGI:2 444 846]
Chd92.70E-160.31 204 8060.7730.668.72E-12chromodomain helicase DNA binding protein 9 [Source:MGI Symbol;Acc:MGI:1 924 001]
4930545L23Rik3.15E-160.2 525 5620.2130.0751.02E-11RIKEN cDNA 4930545L23 gene [Source:MGI Symbol;Acc:MGI:1 926 055]
Mbnl23.57E-16−0.29711720.5840.6871.15E-11muscleblind like splicing factor 2 [Source:MGI Symbol;Acc:MGI:2 145 597]
Cdc42bpa3.90E-16−0.28820290.5660.6451.26E-11CDC42 binding protein kinase alpha [Source:MGI Symbol;Acc:MGI:2 441 841]
Rgs7bp5.91E-160.28 765 1370.3440.2141.91E-11regulator of G-protein signalling 7 binding protein [Source:MGI Symbol;Acc:MGI:106 334]
Hip16.79E-160.31 045 9310.4820.3022.19E-11huntingtin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 099 804]
Kcnj107.30E-160.28 764 8760.3580.2382.36E-11potassium inwardly-rectifying channel, subfamily J, member 10 [Source:MGI Symbol;Acc:MGI:1 194 504]
Gab18.69E-16−0.25106650.2290.3392.80E-11growth factor receptor bound protein 2-associated protein 1 [Source:MGI Symbol;Acc:MGI:108 088]
Limch11.22E-150.3 424 3420.6760.5073.95E-11LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Gm303821.52E-150.27 365 5450.1680.0584.92E-11predicted gene, 30 382 [Source:MGI Symbol;Acc:MGI:5 589 541]
Aldoc1.70E-150.27 040 7730.4890.3565.48E-11aldolase C, fructose-bisphosphate [Source:MGI Symbol;Acc:MGI:101 863]
Wwc11.81E-150.30 910 5710.5530.4035.85E-11WW, C2 and coiled-coil domain containing 1 [Source:MGI Symbol;Acc:MGI:2 388 637]
Phka11.91E-150.35 229 3050.6470.5216.17E-11phosphorylase kinase alpha 1 [Source:MGI Symbol;Acc:MGI:97 576]
Map4k41.93E-15−0.26654580.4050.5246.22E-11mitogen-activated protein kinase kinase kinase kinase 4 [Source:MGI Symbol;Acc:MGI:1 349 394]
Stk32a2.16E-15−0.42537670.2270.3436.99E-11serine/threonine kinase 32A [Source:MGI Symbol;Acc:MGI:2 442 403]
Igsf112.48E-15−0.2698380.3420.488.01E-11immunoglobulin superfamily, member 11 [Source:MGI Symbol;Acc:MGI:2 388 477]
Utrn2.56E-15−0.35209440.5960.6478.26E-11utrophin [Source:MGI Symbol;Acc:MGI:104 631]
Prkn2.62E-15−0.356710.5920.7158.46E-11parkin RBR E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 355 296]
Syn23.73E-150.29 810 5870.520.3921.21E-10synapsin II [Source:MGI Symbol;Acc:MGI:103 020]
Dbx24.19E-150.25 917 6930.370.2261.35E-10developing brain homeobox 2 [Source:MGI Symbol;Acc:MGI:107 445]
Gm61454.52E-150.30 080 3970.6410.51.46E-10predicted gene 6145 [Source:MGI Symbol;Acc:MGI:3 779 559]
Id44.92E-15−0.29273950.2740.4291.59E-10inhibitor of DNA binding 4 [Source:MGI Symbol;Acc:MGI:99 414]
Dpf35.68E-150.2 822 1580.4370.2831.83E-10double PHD fingers 3 [Source:MGI Symbol;Acc:MGI:1 917 377]
F38.81E-150.30 629 6780.5420.4232.84E-10coagulation factor III [Source:MGI Symbol;Acc:MGI:88 381]
Sat12.02E-140.28 493 3810.4240.2886.51E-10spermidine/spermine N1-acetyl transferase 1 [Source:MGI Symbol;Acc:MGI:98 233]
Pbx12.05E-14−0.32819210.90.8976.62E-10pre B cell leukemia homeobox 1 [Source:MGI Symbol;Acc:MGI:97 495]
Tmem178b2.22E-14−0.34648750.3980.4847.18E-10transmembrane protein 178B [Source:MGI Symbol;Acc:MGI:3 647 581]
Ghr2.76E-140.30 505 4690.4920.3388.90E-10growth hormone receptor [Source:MGI Symbol;Acc:MGI:95 708]
Ptprz12.79E-140.29 632 4440.8980.8399.02E-10protein tyrosine phosphatase, receptor type Z, polypeptide 1 [Source:MGI Symbol;Acc:MGI:97 816]
Gm161682.81E-14−0.25244130.1990.3069.08E-10predicted gene 16 168 [Source:MGI Symbol;Acc:MGI:3 802 010]
Arhgap263.02E-140.30 202 1830.5340.49.74E-10Rho GTPase activating protein 26 [Source:MGI Symbol;Acc:MGI:1 918 552]
Etnppl3.68E-140.32 550 8230.4010.2491.19E-09ethanolamine phosphate phospholyase [Source:MGI Symbol;Acc:MGI:1 919 010]
Slc7a23.76E-14−0.26928090.3050.4171.22E-09solute carrier family 7 (cationic amino acid transporter, y + system), member 2 [Source:MGI Symbol;Acc:MGI:99 828]
Ube2e24.03E-14−0.30365550.4780.6011.30E-09ubiquitin-conjugating enzyme E2E 2 [Source:MGI Symbol;Acc:MGI:2 384 997]
Gli34.62E-140.28 367 6840.6990.5731.49E-09GLI-Kruppel family member GLI3 [Source:MGI Symbol;Acc:MGI:95 729]
Ccdc1414.83E-140.2 782 9790.4670.3381.56E-09coiled-coil domain containing 141 [Source:MGI Symbol;Acc:MGI:1 919 735]
Tmtc24.83E-140.36 794 5040.5730.3691.56E-09transmembrane and tetratricopeptide repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 914 057]
Immp2l6.36E-14−0.26882140.1850.3122.05E-09IMP2 inner mitochondrial membrane peptidase-like (S. cerevisiae) [Source:MGI Symbol;Acc:MGI:2 135 611]
Tenm37.88E-14−0.32306420.5270.6572.54E-09teneurin transmembrane protein 3 [Source:MGI Symbol;Acc:MGI:1 345 183]
Agl8.71E-140.25 181 8080.4210.2892.81E-09amylo-1,6-glucosidase, 4-alpha-glucanotransferase [Source:MGI Symbol;Acc:MGI:1 924 809]
Phkg18.88E-140.27 904 1170.6790.5732.87E-09phosphorylase kinase gamma 1 [Source:MGI Symbol;Acc:MGI:97 579]
Nbea9.70E-14−0.25885620.5130.6113.13E-09neurobeachin [Source:MGI Symbol;Acc:MGI:1 347 075]
Smyd31.16E-13−0.28255640.350.4973.74E-09SET and MYND domain containing 3 [Source:MGI Symbol;Acc:MGI:1 916 976]
Chst111.30E-13−0.26105280.2590.374.21E-09carbohydrate sulfotransferase 11 [Source:MGI Symbol;Acc:MGI:1 927 166]
Ptgds1.42E-13−0.27257340.3860.4694.57E-09prostaglandin D2 synthase (brain) [Source:MGI Symbol;Acc:MGI:99 261]
Bmpr1b1.51E-13−0.31688010.670.7414.86E-09bone morphogenetic protein receptor, type 1B [Source:MGI Symbol;Acc:MGI:107 191]
Rmst1.63E-13−0.38929720.7550.7955.26E-09rhabdomyosarcoma 2 associated transcript (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 099 806]
Camk1d1.68E-130.30 376 0590.6740.5195.42E-09calcium/calmodulin-dependent protein kinase ID [Source:MGI Symbol;Acc:MGI:2 442 190]
Ttc281.69E-13−0.26126680.3640.4865.45E-09tetratricopeptide repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 140 873]
Zfp4621.76E-13−0.27398350.3250.4465.67E-09zinc finger protein 462 [Source:MGI Symbol;Acc:MGI:107 690]
Pde8b2.74E-130.29 540 4520.430.2718.84E-09phosphodiesterase 8B [Source:MGI Symbol;Acc:MGI:2 443 999]
Slc25a213.38E-13−0.2738290.1370.2821.09E-08solute carrier family 25 (mitochondrial oxodicarboxylate carrier), member 21 [Source:MGI Symbol;Acc:MGI:2 445 059]
Arhgef285.58E-130.27 161 2430.4410.3621.80E-08Rho guanine nucleotide exchange factor (GEF) 28 [Source:MGI Symbol;Acc:MGI:1 346 016]
Pla2g76.34E-130.28 317 9970.6010.4572.05E-08phospholipase A2, group VII (platelet-activating factor acetylhydrolase, plasma) [Source:MGI Symbol;Acc:MGI:1 351 327]
Prr161.04E-120.30 343 2770.3070.1753.34E-08proline rich 16 [Source:MGI Symbol;Acc:MGI:1 918 623]
Spred11.39E-120.25 156 3280.4630.3194.48E-08sprouty protein with EVH-1 domain 1, related sequence [Source:MGI Symbol;Acc:MGI:2 150 016]
Atp2b21.40E-120.25 015 0340.5860.4274.53E-08ATPase, Ca++ transporting, plasma membrane 2 [Source:MGI Symbol;Acc:MGI:105 368]
Exoc6b1.53E-12−0.25067150.4340.5244.93E-08exocyst complex component 6B [Source:MGI Symbol;Acc:MGI:1 923 164]
Itpr21.56E-120.25 815 6070.490.3455.02E-08inositol 1,4,5-triphosphate receptor 2 [Source:MGI Symbol;Acc:MGI:99 418]
Serpine21.96E-120.27 511 2770.4960.3486.32E-08serine (or cysteine) peptidase inhibitor, clade E, member 2 [Source:MGI Symbol;Acc:MGI:101 780]
Irak21.97E-120.26 542 0630.4680.3256.36E-08interleukin-1 receptor-associated kinase 2 [Source:MGI Symbol;Acc:MGI:2 429 603]
Fgf142.41E-12−0.27184350.760.8237.79E-08fibroblast growth factor 14 [Source:MGI Symbol;Acc:MGI:109 189]
2610035D17Rik3.32E-12−0.27191880.4060.5341.07E-07RIKEN cDNA 2610035D17 gene [Source:MGI Symbol;Acc:MGI:1 919 636]
Gli23.49E-120.25 442 8620.4650.3231.13E-07GLI-Kruppel family member GLI2 [Source:MGI Symbol;Acc:MGI:95 728]
Map46.20E-12−0.25090260.4780.5612.00E-07microtubule-associated protein 4 [Source:MGI Symbol;Acc:MGI:97 178]
Ptprj6.24E-120.31 704 5660.430.2882.02E-07protein tyrosine phosphatase, receptor type, J [Source:MGI Symbol;Acc:MGI:104 574]
Nnat7.56E-12−0.33234990.1710.2112.44E-07neuronatin [Source:MGI Symbol;Acc:MGI:104 716]
Fut98.43E-120.28 325 3660.6640.5642.72E-07fucosyltransferase 9 [Source:MGI Symbol;Acc:MGI:1 330 859]
Cpq1.19E-110.26 741 0010.5240.4343.83E-07carboxypeptidase Q [Source:MGI Symbol;Acc:MGI:1 889 205]
Pigk1.20E-110.25 920 6470.2630.1423.86E-07phosphatidylinositol glycan anchor biosynthesis, class K [Source:MGI Symbol;Acc:MGI:1 913 863]
Grid11.20E-110.25 653 8330.4520.3093.88E-07glutamate receptor, ionotropic, delta 1 [Source:MGI Symbol;Acc:MGI:95 812]
Plpp32.08E-110.27 305 6680.7940.7116.72E-07phospholipid phosphatase 3 [Source:MGI Symbol;Acc:MGI:1 915 166]
Tbc1d52.18E-11−0.25629020.3960.4637.05E-07TBC1 domain family, member 5 [Source:MGI Symbol;Acc:MGI:1 919 488]
Znrf32.20E-110.25 537 2480.5420.4127.12E-07zinc and ring finger 3 [Source:MGI Symbol;Acc:MGI:3 039 616]
Zfhx33.18E-11−0.28845420.3670.4521.03E-06zinc finger homeobox 3 [Source:MGI Symbol;Acc:MGI:99 948]
Hivep34.73E-110.2 583 2130.7320.6171.53E-06human immunodeficiency virus type I enhancer binding protein 3 [Source:MGI Symbol;Acc:MGI:106 589]
Nr3c25.97E-110.28 553 2910.6330.5211.93E-06nuclear receptor subfamily 3, group C, member 2 [Source:MGI Symbol;Acc:MGI:99 459]
Nav36.01E-110.32 715 6190.5190.3691.94E-06neuron navigator 3 [Source:MGI Symbol;Acc:MGI:2 183 703]
Rfx46.35E-11−0.32866310.5220.6242.05E-06regulatory factor X, 4 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:1 918 387]
Ank7.92E-11−0.25649490.4180.4932.56E-06progressive ankylosis [Source:MGI Symbol;Acc:MGI:3 045 421]
Rorb8.58E-110.28 096 1340.8630.7662.77E-06RAR-related orphan receptor beta [Source:MGI Symbol;Acc:MGI:1 343 464]
Paqr89.40E-100.26 548 7410.680.5853.03E-05progestin and adipoQ receptor family member VIII [Source:MGI Symbol;Acc:MGI:1 921 479]
Dlgap11.02E-090.25 343 1480.850.7583.28E-05DLG associated protein 1 [Source:MGI Symbol;Acc:MGI:1 346 065]
Pcdh91.62E-090.30 264 9330.9920.9595.25E-05protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Grm32.89E-090.43 138 1540.5690.4699.32E-05glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Cdh201.24E-080.27 398 5620.7170.650.000 399 728cadherin 20 [Source:MGI Symbol;Acc:MGI:1 346 069]
Fam155a1.75E-08−0.4497730.2930.3960.00 056 492NA
Lhfp5.61E-080.30 326 9220.560.460.001 810 805lipoma HMGIC fusion partner [Source:MGI Symbol;Acc:MGI:1 920 048]
Table 3.

Differentially upregulated genes (P-value < 0.005) in AG 3 in comparison with AG1 and AG2

Genep_valavg_log2FCpct.1pct.2p_val_adjdescription
St6galnac31.53E-241−1.59362790.0990.5374.95E-237ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Ablim21.04E-231−1.64232250.1320.4723.36E-227actin-binding LIM protein 2 [Source:MGI Symbol;Acc:MGI:2 385 758]
Nkain21.31E-205−1.78428380.4360.7114.24E-201Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Gpc53.70E-1561.4 386 1110.9850.6551.19E-151glypican 5 [Source:MGI Symbol;Acc:MGI:1 194 894]
Lsamp2.79E-1491.03 552 76610.9969.01E-145limbic system-associated membrane protein [Source:MGI Symbol;Acc:MGI:1 261 760]
Pkp48.39E-146−1.0036560.2150.542.71E-141plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Gfap4.94E-145−1.44464860.2080.5361.60E-140glial fibrillary acidic protein [Source:MGI Symbol;Acc:MGI:95 697]
Prune24.16E-140−1.05526780.1270.4761.34E-135prune homolog 2 [Source:MGI Symbol;Acc:MGI:1 925 004]
Grik22.62E-136−1.16448380.4440.7458.45E-132glutamate receptor, ionotropic, kainate 2 (beta 2) [Source:MGI Symbol;Acc:MGI:95 815]
Prr5l2.29E-127−1.00589180.050.3527.38E-123proline rich 5 like [Source:MGI Symbol;Acc:MGI:1 919 696]
Slc8a11.72E-121−1.01436890.2180.5235.56E-117solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Trpm31.51E-1171.51 328 0140.9520.5634.88E-113transient receptor potential cation channel, subfamily M, member 3 [Source:MGI Symbol;Acc:MGI:2 443 101]
Sorbs22.64E-116−1.16436880.1720.4678.53E-112sorbin and SH3 domain containing 2 [Source:MGI Symbol;Acc:MGI:1 924 574]
Gm37641.75E-1120.96 079 9840.9520.7495.65E-108predicted gene 3764 [Source:MGI Symbol;Acc:MGI:3 781 938]
Adamtsl14.27E-109−0.84474680.020.3161.38E-104ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
Cacnb24.88E-109−1.14120210.2510.5281.58E-104calcium channel, voltage-dependent, beta 2 subunit [Source:MGI Symbol;Acc:MGI:894 644]
Kirrel33.05E-1081.28 033 1720.890.5289.85E-104kirre like nephrin family adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 914 953]
Mdga28.42E-950.93 802 8950.9790.852.72E-90MAM domain containing glycosylphosphatidylinositol anchor 2 [Source:MGI Symbol;Acc:MGI:2 444 706]
Cobll14.35E-94−0.59498850.0440.3181.41E-89Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Slc38a11.99E-92−0.89661440.2320.5076.42E-88solute carrier family 38, member 1 [Source:MGI Symbol;Acc:MGI:2 145 895]
Ccdc1484.14E-92−0.78608480.0530.2911.34E-87coiled-coil domain containing 148 [Source:MGI Symbol;Acc:MGI:3 039 583]
Nrxn14.43E-920.87 728 2530.9980.911.43E-87neurexin I [Source:MGI Symbol;Acc:MGI:1 096 391]
Plcb11.88E-911.13 264 8610.9510.7486.07E-87phospholipase C, beta 1 [Source:MGI Symbol;Acc:MGI:97 613]
A2m4.93E-90−0.88175570.0650.2981.59E-85alpha-2-macroglobulin [Source:MGI Symbol;Acc:MGI:2 449 119]
Tmeff26.26E-89−0.85731650.1580.3532.02E-84transmembrane protein with EGF-like and two follistatin-like domains 2 [Source:MGI Symbol;Acc:MGI:1 861 735]
Dgki8.89E-87−0.77686950.2210.5362.87E-82diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Kcnd21.16E-841.29 103 5480.720.443.74E-80potassium voltage-gated channel, Shal-related family, member 2 [Source:MGI Symbol;Acc:MGI:102 663]
Pdzrn31.83E-84−0.6136950.0840.3725.89E-80PDZ domain containing RING finger 3 [Source:MGI Symbol;Acc:MGI:1 933 157]
Slc24a22.21E-83−0.89372330.3150.4277.15E-79solute carrier family 24 (sodium/potassium/calcium exchanger), member 2 [Source:MGI Symbol;Acc:MGI:1 923 626]
Gria25.83E-830.91 744 6170.7750.4931.88E-78glutamate receptor, ionotropic, AMPA2 (alpha 2) [Source:MGI Symbol;Acc:MGI:95 809]
Grm71.28E-82−0.85193080.2120.4364.12E-78glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Gm207132.19E-810.85 012 0780.7270.2837.08E-77predicted gene 20 713 [Source:MGI Symbol;Acc:MGI:5 313 160]
Cadps1.18E-80−0.81690650.2990.5713.79E-76Ca2+-dependent secretion activator [Source:MGI Symbol;Acc:MGI:1 350 922]
Rora2.23E-780.80 516 0940.9910.9597.20E-74RAR-related orphan receptor alpha [Source:MGI Symbol;Acc:MGI:104 661]
Kcnj31.93E-77−0.69385630.1580.4536.24E-73potassium inwardly-rectifying channel, subfamily J, member 3 [Source:MGI Symbol;Acc:MGI:104 742]
Slc6a112.45E-770.82 740 9090.5970.3027.92E-73solute carrier family 6 (neurotransmitter transporter, GABA), member 11 [Source:MGI Symbol;Acc:MGI:95 630]
Gm149645.63E-76−0.58123850.1540.4031.82E-71predicted gene 14 964 [Source:MGI Symbol;Acc:MGI:3 641 621]
Slc7a108.30E-750.80 503 3510.570.1722.68E-70solute carrier family 7 (cationic amino acid transporter, y + system), member 10 [Source:MGI Symbol;Acc:MGI:1 858 261]
Ccdc31.94E-73−0.56467980.020.2446.25E-69coiled-coil domain containing 3 [Source:MGI Symbol;Acc:MGI:1 921 436]
Prickle28.03E-73−0.7091480.3450.6072.59E-68prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
Brinp31.40E-700.82 937 7710.7160.3534.52E-66bone morphogenetic protein/retinoic acid inducible neural specific 3 [Source:MGI Symbol;Acc:MGI:2 443 035]
Pex5l1.61E-70−0.83276840.1830.3295.20E-66peroxisomal biogenesis factor 5-like [Source:MGI Symbol;Acc:MGI:1 916 672]
Prkca2.52E-70−0.77768890.5510.7528.12E-66protein kinase C, alpha [Source:MGI Symbol;Acc:MGI:97 595]
Asap37.08E-70−0.45261050.0250.2392.29E-65ArfGAP with SH3 domain, ankyrin repeat and PH domain 3 [Source:MGI Symbol;Acc:MGI:2 684 986]
St188.32E-70−0.70185880.0630.2252.69E-65suppression of tumorigenicity 18 [Source:MGI Symbol;Acc:MGI:2 446 700]
Ldb21.58E-69−0.57966620.1140.3595.09E-65LIM domain binding 2 [Source:MGI Symbol;Acc:MGI:894 670]
Edil32.54E-69−0.689130.1780.3628.21E-65EGF-like repeats and discoidin I-like domains 3 [Source:MGI Symbol;Acc:MGI:1 329 025]
Unc5c5.97E-68−0.73579040.1820.421.93E-63unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Gm122399.70E-681.08 440 5170.5810.2423.13E-63predicted gene 12 239 [Source:MGI Symbol;Acc:MGI:3 651 547]
C4b1.35E-67−0.51007120.0660.3124.35E-63complement component 4B (Chido blood group) [Source:MGI Symbol;Acc:MGI:88 228]
Tmem1082.42E-67−0.5227890.0430.2457.80E-63transmembrane protein 108 [Source:MGI Symbol;Acc:MGI:1 932 411]
Dock102.55E-66−0.6171340.1050.2668.24E-62dedicator of cytokinesis 10 [Source:MGI Symbol;Acc:MGI:2 146 320]
Gm48761.07E-65−0.61758020.1280.3683.45E-61predicted gene 4876 [Source:MGI Symbol;Acc:MGI:3 647 654]
Sulf21.90E-64−0.42984590.0340.2386.14E-60sulfatase 2 [Source:MGI Symbol;Acc:MGI:1 919 293]
Col23a12.45E-64−0.8123560.1120.347.92E-60collagen, type XXIII, alpha 1 [Source:MGI Symbol;Acc:MGI:2 653 243]
Prkag26.39E-63−0.56851360.1560.3762.06E-58protein kinase, AMP-activated, gamma 2 non-catalytic subunit [Source:MGI Symbol;Acc:MGI:1 336 153]
Ctnna22.00E-61−0.85708440.6690.8096.45E-57catenin (cadherin associated protein), alpha 2 [Source:MGI Symbol;Acc:MGI:88 275]
Myoc1.78E-60−0.57942840.0110.1885.74E-56myocilin [Source:MGI Symbol;Acc:MGI:1 202 864]
Enpp22.58E-60−0.52837730.2120.4538.33E-56ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
Frmd56.05E-60−0.67540120.1030.2551.95E-55FERM domain containing 5 [Source:MGI Symbol;Acc:MGI:2 442 557]
Sema6a9.70E-60−0.41414330.0590.2833.13E-55sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
Arhgef41.15E-59−0.73589960.5650.6973.70E-55Rho guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:2 442 507]
Zfp5365.69E-59−0.52649440.0440.2041.84E-54zinc finger protein 536 [Source:MGI Symbol;Acc:MGI:1 926 102]
Enox11.09E-58−0.71177450.2490.5043.51E-54ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Pakap8.14E-57−0.4203850.0330.2142.63E-52paralemmin A kinase anchor protein [Source:MGI Symbol;Acc:MGI:5 141 924]
Man1c11.77E-56−0.46972530.0590.2565.71E-52mannosidase, alpha, class 1C, member 1 [Source:MGI Symbol;Acc:MGI:2 446 214]
Nrp22.58E-56−0.39141450.0430.2368.32E-52neuropilin 2 [Source:MGI Symbol;Acc:MGI:1 100 492]
Csmd14.93E-56−0.59264430.3860.5441.59E-51CUB and Sushi multiple domains 1 [Source:MGI Symbol;Acc:MGI:2 137 383]
Nhsl17.81E-560.7 363 4140.7370.4432.52E-51NHS-like 1 [Source:MGI Symbol;Acc:MGI:106 390]
Cd443.70E-55−0.4325580.0220.1981.19E-50CD44 antigen [Source:MGI Symbol;Acc:MGI:88 338]
Dnm31.96E-54−0.56683620.2810.5116.32E-50dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Pde4b2.27E-54−0.7656010.5480.5067.32E-50phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Atp1a26.26E-540.67 797 4270.9380.8112.02E-49ATPase, Na+/K + transporting, alpha 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 106]
Pacrg7.92E-54−0.61658490.2790.5472.56E-49PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Rgs71.69E-530.75 771 7180.6530.3425.44E-49regulator of G protein signaling 7 [Source:MGI Symbol;Acc:MGI:1 346 089]
Pitpnc11.79E-530.77 375 0720.9160.7615.79E-49phosphatidylinositol transfer protein, cytoplasmic 1 [Source:MGI Symbol;Acc:MGI:1 919 045]
Pde7b2.22E-530.75 004 2570.7130.3797.18E-49phosphodiesterase 7B [Source:MGI Symbol;Acc:MGI:1 352 752]
Sorbs14.64E-53−0.70896350.6330.7791.50E-48sorbin and SH3 domain containing 1 [Source:MGI Symbol;Acc:MGI:700 014]
Kif21a6.38E-53−0.4973930.3880.6232.06E-48kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
Ccser19.85E-53−0.65703470.2760.4463.18E-48coiled-coil serine rich 1 [Source:MGI Symbol;Acc:MGI:3 045 354]
Adgrb31.78E-520.71 451 4760.960.895.76E-48adhesion G protein-coupled receptor B3 [Source:MGI Symbol;Acc:MGI:2 441 837]
Sntg24.21E-52−0.34334370.0150.1911.36E-47syntrophin, gamma 2 [Source:MGI Symbol;Acc:MGI:1 919 541]
Mbp6.86E-52−0.5974130.3760.5132.21E-47myelin basic protein [Source:MGI Symbol;Acc:MGI:96 925]
Tmem132b3.47E-51−0.34043890.0620.2641.12E-46transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Phyhd12.24E-50−0.50595120.2210.4527.24E-46phytanoyl-CoA dioxygenase domain containing 1 [Source:MGI Symbol;Acc:MGI:3 612 860]
Glis33.59E-50−0.62542110.5240.7151.16E-45GLIS family zinc finger 3 [Source:MGI Symbol;Acc:MGI:2 444 289]
Elmo17.87E-50−0.52881910.1040.2682.54E-45engulfment and cell motility 1 [Source:MGI Symbol;Acc:MGI:2 153 044]
Car102.40E-490.85 983 3940.4940.2827.75E-45carbonic anhydrase 10 [Source:MGI Symbol;Acc:MGI:1 919 855]
Ptch13.37E-490.70 455 4390.5810.2851.09E-44patched 1 [Source:MGI Symbol;Acc:MGI:105 373]
Aebp11.40E-48−0.34100280.0110.1824.52E-44AE binding protein 1 [Source:MGI Symbol;Acc:MGI:1 197 012]
Pcdh72.00E-480.5 983 1060.8860.7446.47E-44protocadherin 7 [Source:MGI Symbol;Acc:MGI:1 860 487]
Dok66.61E-48−0.54490440.1560.3822.13E-43docking protein 6 [Source:MGI Symbol;Acc:MGI:3 639 495]
Garnl31.52E-47−0.37356950.0830.2664.90E-43GTPase activating RANGAP domain-like 3 [Source:MGI Symbol;Acc:MGI:2 139 309]
Robo21.53E-47−0.67838390.5650.7284.95E-43roundabout guidance receptor 2 [Source:MGI Symbol;Acc:MGI:1 890 110]
Synpo24.98E-47−0.62419530.1620.3931.61E-42synaptopodin 2 [Source:MGI Symbol;Acc:MGI:2 153 070]
Zeb25.73E-46−0.54897780.5140.6571.85E-41zinc finger E-box binding homeobox 2 [Source:MGI Symbol;Acc:MGI:1 344 407]
Padi25.77E-46−0.45318580.1240.3361.86E-41peptidyl arginine deiminase, type II [Source:MGI Symbol;Acc:MGI:1 338 892]
C530044C16Rik5.84E-46−0.34399180.0110.1621.89E-41RIKEN cDNA C530044C16 gene [Source:MGI Symbol;Acc:MGI:2 443 109]
Reep12.13E-44−0.44857350.0710.2396.88E-40receptor accessory protein 1 [Source:MGI Symbol;Acc:MGI:1 098 827]
Map76.02E-44−0.46314340.1470.2981.94E-39microtubule-associated protein 7 [Source:MGI Symbol;Acc:MGI:1 328 328]
Atp13a46.00E-430.52 133 6030.4980.2191.94E-38ATPase type 13A4 [Source:MGI Symbol;Acc:MGI:1 924 456]
Cpne83.12E-42−0.29628670.0350.1921.01E-37copine VIII [Source:MGI Symbol;Acc:MGI:1 914 121]
Tagln33.76E-42−0.45100630.2970.4871.21E-37transgelin 3 [Source:MGI Symbol;Acc:MGI:1 926 784]
Frmd4a4.71E-420.63 758 1730.9350.7821.52E-37FERM domain containing 4A [Source:MGI Symbol;Acc:MGI:1 919 850]
Sema3a7.94E-42−0.37426410.0310.1742.56E-37sema domain, immunoglobulin domain (Ig), short basic domain, secreted, (semaphorin) 3A [Source:MGI Symbol;Acc:MGI:107 558]
Tnc1.52E-41−0.28987480.0190.1774.89E-37tenascin C [Source:MGI Symbol;Acc:MGI:101 922]
Cacnb45.46E-41−0.55386590.2310.4231.76E-36calcium channel, voltage-dependent, beta 4 subunit [Source:MGI Symbol;Acc:MGI:103 301]
Neat16.65E-41−0.64808040.5210.6272.15E-36nuclear paraspeckle assembly transcript 1 (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 914 211]
Ano43.04E-40−0.37170070.0740.2099.82E-36anoctamin 4 [Source:MGI Symbol;Acc:MGI:2 443 344]
Adamts94.01E-40−0.51521880.1950.4191.29E-35a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 9 [Source:MGI Symbol;Acc:MGI:1 916 320]
Luzp24.27E-400.98 895 0870.9030.6811.38E-35leucine zipper protein 2 [Source:MGI Symbol;Acc:MGI:1 889 615]
March16.66E-40−0.4157750.0850.2212.15E-35NA
Igfbp57.96E-40−0.40115060.0920.2812.57E-35insulin-like growth factor binding protein 5 [Source:MGI Symbol;Acc:MGI:96 440]
Hecw29.58E-40−0.39168580.090.2153.09E-35HECT, C2 and WW domain containing E3 ubiquitin protein ligase 2 [Source:MGI Symbol;Acc:MGI:2 685 817]
Ank21.52E-39−0.69756270.9540.9494.92E-35ankyrin 2, brain [Source:MGI Symbol;Acc:MGI:88 025]
Trp632.59E-390.64 506 9460.3240.1118.35E-35transformation related protein 63 [Source:MGI Symbol;Acc:MGI:1 330 810]
Adgrl32.95E-390.53 274 2270.9060.7969.52E-35adhesion G protein-coupled receptor L3 [Source:MGI Symbol;Acc:MGI:2 441 950]
9530026P05Rik1.12E-38−0.59699570.2250.4223.61E-34RIKEN cDNA 9530026P05 gene [Source:MGI Symbol;Acc:MGI:1 924 659]
Fmn12.01E-38−0.57518580.1950.3586.49E-34formin 1 [Source:MGI Symbol;Acc:MGI:101 815]
D7Ertd443e3.39E-38−0.29014660.0260.161.09E-33DNA segment, Chr 7, ERATO Doi 443, expressed [Source:MGI Symbol;Acc:MGI:1 196 431]
Tex117.26E-38−0.25602360.0110.152.34E-33testis expressed gene 11 [Source:MGI Symbol;Acc:MGI:1 933 237]
Sema6d1.10E-37−0.73744820.5280.6643.54E-33sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6D [Source:MGI Symbol;Acc:MGI:2 387 661]
Tulp42.02E-37−0.44931220.3790.5636.51E-33tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Aqp43.92E-37−0.4956280.4040.5931.27E-32aquaporin 4 [Source:MGI Symbol;Acc:MGI:107 387]
Dscaml16.17E-37−0.32478570.0310.1451.99E-32DS cell adhesion molecule like 1 [Source:MGI Symbol;Acc:MGI:2 150 309]
Eya49.63E-37−0.36639930.0930.2683.11E-32EYA transcriptional coactivator and phosphatase 4 [Source:MGI Symbol;Acc:MGI:1 337 104]
Thbs42.03E-36−0.28644410.0070.1286.56E-32thrombospondin 4 [Source:MGI Symbol;Acc:MGI:1 101 779]
Apbb1ip2.03E-36−0.27603990.0120.1646.57E-32amyloid beta (A4) precursor protein-binding, family B, member 1 interacting protein [Source:MGI Symbol;Acc:MGI:1 861 354]
Ank32.07E-36−0.43101190.2380.3666.67E-32ankyrin 3, epithelial [Source:MGI Symbol;Acc:MGI:88 026]
Slc4a42.32E-360.53 869 8480.9270.8467.47E-32solute carrier family 4 (anion exchanger), member 4 [Source:MGI Symbol;Acc:MGI:1 927 555]
Syne12.48E-360.48 914 0070.8840.7748.02E-32spectrin repeat containing, nuclear envelope 1 [Source:MGI Symbol;Acc:MGI:1 927 152]
Cadm28.59E-360.47 857 2720.9920.922.77E-31cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:2 442 722]
Pxdn3.14E-35−0.29168010.0710.2221.02E-30peroxidasin [Source:MGI Symbol;Acc:MGI:1 916 925]
Cmya54.19E-35−0.33401310.0930.2721.35E-30cardiomyopathy associated 5 [Source:MGI Symbol;Acc:MGI:1 923 719]
4930402H24Rik5.42E-35−0.48683070.830.861.75E-30NA
Reln6.39E-35−0.43203110.110.2952.06E-30reelin [Source:MGI Symbol;Acc:MGI:103 022]
Retreg19.38E-35−0.29235920.0960.2663.03E-30reticulophagy regulator 1 [Source:MGI Symbol;Acc:MGI:1 913 520]
Gpld11.38E-340.46 185 2080.3950.1514.47E-30glycosylphosphatidylinositol specific phospholipase D1 [Source:MGI Symbol;Acc:MGI:106 604]
Plp11.47E-34−0.4348560.5990.7314.76E-30proteolipid protein (myelin) 1 [Source:MGI Symbol;Acc:MGI:97 623]
Mapt2.50E-34−0.44176690.4270.568.06E-30microtubule-associated protein tau [Source:MGI Symbol;Acc:MGI:97 180]
Eps82.62E-340.47 960 3480.5370.2748.46E-30epidermal growth factor receptor pathway substrate 8 [Source:MGI Symbol;Acc:MGI:104 684]
Tab23.98E-34−0.38333140.2510.451.28E-29TGF-beta activated kinase 1/MAP3K7 binding protein 2 [Source:MGI Symbol;Acc:MGI:1 915 902]
Dock44.61E-340.53 604 3730.8150.6411.49E-29dedicator of cytokinesis 4 [Source:MGI Symbol;Acc:MGI:1 918 006]
Ptprk2.18E-33−0.32661880.0860.2197.02E-29protein tyrosine phosphatase, receptor type, K [Source:MGI Symbol;Acc:MGI:103 310]
Airn4.11E-33−0.31793050.0540.1841.33E-28antisense Igf2r RNA [Source:MGI Symbol;Acc:MGI:1 353 471]
Erbin2.15E-32−0.41815980.2990.466.94E-28Erbb2 interacting protein [Source:MGI Symbol;Acc:MGI:1 890 169]
Plxdc22.72E-32−0.43980.2670.4438.77E-28plexin domain containing 2 [Source:MGI Symbol;Acc:MGI:1 914 698]
Vav33.24E-320.49 950 3790.4460.1871.05E-27vav 3 oncogene [Source:MGI Symbol;Acc:MGI:1 888 518]
Sh3d194.83E-32−0.25908980.0410.1711.56E-27SH3 domain protein D19 [Source:MGI Symbol;Acc:MGI:1 350 923]
Gm106356.44E-32−0.31841620.0230.152.08E-27predicted gene 10 635 [Source:MGI Symbol;Acc:MGI:3 641 740]
Itih31.22E-310.46 778 9670.3420.1283.95E-27inter-alpha trypsin inhibitor, heavy chain 3 [Source:MGI Symbol;Acc:MGI:96 620]
Kcnma11.29E-310.58 278 3970.6720.4164.18E-27potassium large conductance calcium-activated channel, subfamily M, alpha member 1 [Source:MGI Symbol;Acc:MGI:99 923]
Acsbg11.66E-310.46 229 4430.6060.4065.36E-27acyl-CoA synthetase bubblegum family member 1 [Source:MGI Symbol;Acc:MGI:2 385 656]
Naaladl22.22E-31−0.50596970.3140.5287.16E-27N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Rps6ka52.78E-31−0.35757310.2040.3958.99E-27ribosomal protein S6 kinase, polypeptide 5 [Source:MGI Symbol;Acc:MGI:1 920 336]
Mobp3.94E-31−0.3479790.1350.2581.27E-26myelin-associated oligodendrocytic basic protein [Source:MGI Symbol;Acc:MGI:108 511]
Cdh109.07E-310.49 836 4990.7380.5362.93E-26cadherin 10 [Source:MGI Symbol;Acc:MGI:107 436]
Cadm11.31E-300.50 571 3360.8350.6484.24E-26cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:1 889 272]
Arhgap61.40E-30−0.25423430.0340.1444.51E-26Rho GTPase activating protein 6 [Source:MGI Symbol;Acc:MGI:1 196 332]
Dner2.35E-30−0.3441610.1730.337.57E-26delta/notch-like EGF repeat containing [Source:MGI Symbol;Acc:MGI:2 152 889]
Disp32.80E-30−0.30234690.0770.1999.04E-26dispatched RND transporter family member 3 [Source:MGI Symbol;Acc:MGI:2 444 403]
Npas34.84E-300.46 551 2690.9850.9431.56E-25neuronal PAS domain protein 3 [Source:MGI Symbol;Acc:MGI:1 351 610]
Id36.28E-30−0.3400750.1340.3122.03E-25inhibitor of DNA binding 3 [Source:MGI Symbol;Acc:MGI:96 398]
Kalrn6.35E-300.44 370 4620.5660.3212.05E-25kalirin, RhoGEF kinase [Source:MGI Symbol;Acc:MGI:2 685 385]
Fgfr31.96E-290.41 311 4010.6340.4576.32E-25fibroblast growth factor receptor 3 [Source:MGI Symbol;Acc:MGI:95 524]
Agap12.08E-29−0.34621550.1980.3436.72E-25ArfGAP with GTPase domain, ankyrin repeat and PH domain 1 [Source:MGI Symbol;Acc:MGI:2 653 690]
Bin12.61E-29−0.29684230.130.2628.41E-25bridging integrator 1 [Source:MGI Symbol;Acc:MGI:108 092]
Tspan73.06E-290.46 649 1080.7840.639.89E-25tetraspanin 7 [Source:MGI Symbol;Acc:MGI:1 298 407]
Cables13.75E-290.43 697 1520.470.2181.21E-24CDK5 and Abl enzyme substrate 1 [Source:MGI Symbol;Acc:MGI:1 927 065]
Ddr14.57E-29−0.29183040.1340.2881.47E-24discoidin domain receptor family, member 1 [Source:MGI Symbol;Acc:MGI:99 216]
Ano14.74E-29−0.32992270.0030.1441.53E-24anoctamin 1, calcium activated chloride channel [Source:MGI Symbol;Acc:MGI:2 142 149]
Grin2c7.34E-290.38 585 4430.4280.1882.37E-24glutamate receptor, ionotropic, NMDA2C (epsilon 3) [Source:MGI Symbol;Acc:MGI:95 822]
Slco1c18.32E-290.44 635 9410.4590.2352.69E-24solute carrier organic anion transporter family, member 1c1 [Source:MGI Symbol;Acc:MGI:1 889 679]
Trim29.96E-29−0.37651730.3080.4913.21E-24tripartite motif-containing 2 [Source:MGI Symbol;Acc:MGI:1 933 163]
Fat31.02E-280.48 826 9490.6850.5263.29E-24FAT atypical cadherin 3 [Source:MGI Symbol;Acc:MGI:2 444 314]
Spock11.36E-28−0.30109010.1110.2284.39E-24sparc/osteonectin, cwcv and kazal-like domains proteoglycan 1 [Source:MGI Symbol;Acc:MGI:105 371]
Grin3a1.95E-28−0.39370810.1380.2936.30E-24glutamate receptor ionotropic, NMDA3A [Source:MGI Symbol;Acc:MGI:1 933 206]
Ptprg2.33E-280.48 924 4260.6420.4967.51E-24NA
Nwd12.35E-280.41 679 6270.7050.5067.59E-24NACHT and WD repeat domain containing 1 [Source:MGI Symbol;Acc:MGI:2 442 268]
Wwox3.10E-28−0.5667150.5260.6781.00E-23WW domain-containing oxidoreductase [Source:MGI Symbol;Acc:MGI:1 931 237]
Cep85l6.31E-280.4 097 8750.5780.3822.04E-23centrosomal protein 85-like [Source:MGI Symbol;Acc:MGI:3 642 684]
Gria46.44E-280.59 105 0450.4260.2582.08E-23glutamate receptor, ionotropic, AMPA4 (alpha 4) [Source:MGI Symbol;Acc:MGI:95 811]
Nxn9.83E-28−0.47264220.4210.5953.17E-23nucleoredoxin [Source:MGI Symbol;Acc:MGI:109 331]
2610307P16Rik1.27E-27−0.31659830.0640.1984.11E-23RIKEN cDNA 2610307P16 gene [Source:MGI Symbol;Acc:MGI:1 919 768]
Ccdc85a1.29E-270.47 682 1040.5240.2824.16E-23coiled-coil domain containing 85A [Source:MGI Symbol;Acc:MGI:2 445 069]
Grid22.01E-270.48 400 7850.910.7616.50E-23glutamate receptor, ionotropic, delta 2 [Source:MGI Symbol;Acc:MGI:95 813]
Nrbp23.89E-27−0.3131650.1840.3551.25E-22nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Etv46.28E-270.34 377 1190.2810.0732.03E-22ets variant 4 [Source:MGI Symbol;Acc:MGI:99 423]
Cep1126.56E-27−0.25664220.0720.2252.12E-22centrosomal protein 112 [Source:MGI Symbol;Acc:MGI:1 923 673]
Rnf2201.42E-26−0.38293090.1610.2424.60E-22ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Rtn43.75E-26−0.35591380.5030.6521.21E-21reticulon 4 [Source:MGI Symbol;Acc:MGI:1 915 835]
Klhl294.42E-26−0.28145850.1230.2781.43E-21kelch-like 29 [Source:MGI Symbol;Acc:MGI:2 683 857]
Sorcs17.06E-26−0.32927210.1120.2262.28E-21sortilin-related VPS10 domain containing receptor 1 [Source:MGI Symbol;Acc:MGI:1 929 666]
App8.22E-26−0.36787750.5210.6422.65E-21amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Grk31.23E-250.38 379 0140.5720.3393.97E-21G protein-coupled receptor kinase 3 [Source:MGI Symbol;Acc:MGI:87 941]
Atp1b21.53E-250.45 621 0180.5410.4264.95E-21ATPase, Na+/K + transporting, beta 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 109]
Bmp61.82E-25−0.25663580.0390.165.88E-21bone morphogenetic protein 6 [Source:MGI Symbol;Acc:MGI:88 182]
Ndrg21.93E-250.40 022 6160.730.626.22E-21N-myc downstream regulated gene 2 [Source:MGI Symbol;Acc:MGI:1 352 498]
Mgat4c3.09E-250.47 103 3120.5650.4799.97E-21MGAT4 family, member C [Source:MGI Symbol;Acc:MGI:1 914 819]
Pdgfd5.25E-25−0.43084350.390.5281.69E-20platelet-derived growth factor, D polypeptide [Source:MGI Symbol;Acc:MGI:1 919 035]
Nav26.00E-25−0.42033420.5210.641.94E-20neuron navigator 2 [Source:MGI Symbol;Acc:MGI:2 183 691]
Shc39.06E-250.35 170 7430.3870.1722.92E-20src homology 2 domain-containing transforming protein C3 [Source:MGI Symbol;Acc:MGI:106 179]
Plscr41.07E-24−0.26351470.0990.2513.44E-20phospholipid scramblase 4 [Source:MGI Symbol;Acc:MGI:2 143 267]
Dgkb1.55E-240.41 451 4060.8990.7885.02E-20diacylglycerol kinase, beta [Source:MGI Symbol;Acc:MGI:2 442 474]
Fry1.97E-240.38 056 9650.6770.5676.35E-20FRY microtubule binding protein [Source:MGI Symbol;Acc:MGI:2 443 895]
Tnik2.85E-240.39 465 1720.9260.8529.19E-20TRAF2 and NCK interacting kinase [Source:MGI Symbol;Acc:MGI:1 916 264]
Slc1a24.57E-240.38 376 7960.9990.9761.47E-19solute carrier family 1 (glial high affinity glutamate transporter), member 2 [Source:MGI Symbol;Acc:MGI:101 931]
Tmc74.76E-240.36 285 4910.3430.1521.54E-19transmembrane channel-like gene family 7 [Source:MGI Symbol;Acc:MGI:2 443 317]
Nrcam5.21E-240.38 906 2530.8310.6841.68E-19neuronal cell adhesion molecule [Source:MGI Symbol;Acc:MGI:104 750]
Pgm51.33E-23−0.26781540.0340.1614.28E-19phosphoglucomutase 5 [Source:MGI Symbol;Acc:MGI:1 925 668]
Rapgef41.55E-23−0.30338410.1230.2365.00E-19Rap guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:1 917 723]
Adipor22.96E-23−0.29242370.1520.2419.56E-19adiponectin receptor 2 [Source:MGI Symbol;Acc:MGI:93 830]
Gabbr28.65E-230.40 045 0430.330.1512.79E-18gamma-aminobutyric acid (GABA) B receptor, 2 [Source:MGI Symbol;Acc:MGI:2 386 030]
Phactr31.14E-220.36 083 1550.5180.2853.68E-18phosphatase and actin regulator 3 [Source:MGI Symbol;Acc:MGI:1 921 439]
Dst1.39E-22−0.36711630.6210.7184.49E-18dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Gjb61.94E-220.31 796 4270.3470.1646.27E-18gap junction protein, beta 6 [Source:MGI Symbol;Acc:MGI:107 588]
Dip2b2.13E-22−0.3137080.3440.4876.89E-18disco interacting protein 2 homolog B [Source:MGI Symbol;Acc:MGI:2 145 977]
Ntng13.12E-22−0.31572520.0620.1771.01E-17netrin G1 [Source:MGI Symbol;Acc:MGI:1 934 028]
Frmpd43.81E-22−0.26677090.1360.2341.23E-17FERM and PDZ domain containing 4 [Source:MGI Symbol;Acc:MGI:3 042 378]
Kcnip33.99E-220.37 212 3660.3770.1871.29E-17Kv channel interacting protein 3, calsenilin [Source:MGI Symbol;Acc:MGI:1 929 258]
Ppp1r16b4.87E-22−0.26358730.0940.1741.57E-17protein phosphatase 1, regulatory subunit 16B [Source:MGI Symbol;Acc:MGI:2 151 841]
Slc6a17.68E-220.35 533 7630.6010.4422.48E-17solute carrier family 6 (neurotransmitter transporter, GABA), member 1 [Source:MGI Symbol;Acc:MGI:95 627]
Sorcs28.98E-220.31 923 2460.3490.1612.90E-17sortilin-related VPS10 domain containing receptor 2 [Source:MGI Symbol;Acc:MGI:1 932 289]
Mpdz1.18E-21−0.264380.1550.2993.81E-17multiple PDZ domain crumbs cell polarity complex component [Source:MGI Symbol;Acc:MGI:1 343 489]
Tsc22d11.35E-21−0.27447680.2610.4154.35E-17TSC22 domain family, member 1 [Source:MGI Symbol;Acc:MGI:109 127]
Xylt11.69E-210.39 333 3490.5110.2885.45E-17xylosyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 451 073]
Ski2.22E-21−0.2875370.1710.3127.18E-17ski sarcoma viral oncogene homolog (avian) [Source:MGI Symbol;Acc:MGI:98 310]
Tenm42.83E-210.39 167 5450.4230.2519.12E-17teneurin transmembrane protein 4 [Source:MGI Symbol;Acc:MGI:2 447 063]
Ablim12.84E-210.35 555 5790.5170.3159.15E-17actin-binding LIM protein 1 [Source:MGI Symbol;Acc:MGI:1 194 500]
Ahcyl13.24E-210.36 060 6420.6680.5041.05E-16S-adenosylhomocysteine hydrolase-like 1 [Source:MGI Symbol;Acc:MGI:2 385 184]
Shroom35.82E-210.39 782 5920.4570.3191.88E-16shroom family member 3 [Source:MGI Symbol;Acc:MGI:1 351 655]
Mertk1.09E-200.43 718 9990.7980.6383.51E-16MER proto-oncogene tyrosine kinase [Source:MGI Symbol;Acc:MGI:96 965]
Wasf31.16E-200.33 069 6330.5510.3623.75E-16WASP family, member 3 [Source:MGI Symbol;Acc:MGI:2 658 986]
Myo162.10E-20−0.26815250.0950.2096.78E-16myosin XVI [Source:MGI Symbol;Acc:MGI:2 685 951]
9630028H03Rik2.28E-200.32 473 4260.3040.1257.38E-16RIKEN cDNA 9630028H03 gene [Source:MGI Symbol;Acc:MGI:2 444 526]
Plekha54.64E-20−0.27234810.2040.3521.50E-15pleckstrin homology domain containing, family A member 5 [Source:MGI Symbol;Acc:MGI:1 923 802]
Npas24.88E-200.38 493 5470.5710.3891.58E-15neuronal PAS domain protein 2 [Source:MGI Symbol;Acc:MGI:109 232]
St3gal41.26E-190.3 840 1030.5460.3434.07E-15ST3 beta-galactoside alpha-2,3-sialyltransferase 4 [Source:MGI Symbol;Acc:MGI:1 316 743]
Dmd1.92E-190.42 285 6190.8240.6986.19E-15dystrophin, muscular dystrophy [Source:MGI Symbol;Acc:MGI:94 909]
Myo5a1.96E-19−0.26387170.2090.3356.32E-15myosin VA [Source:MGI Symbol;Acc:MGI:105 976]
Ralgps23.83E-19−0.25903480.1680.3161.24E-14Ral GEF with PH domain and SH3 binding motif 2 [Source:MGI Symbol;Acc:MGI:1 925 505]
Tprkb5.94E-19−0.34531490.360.5041.92E-14Tp53rk binding protein [Source:MGI Symbol;Acc:MGI:1 917 036]
Plcl16.13E-19−0.40963640.5850.5211.98E-14phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Mgat56.17E-19−0.31846110.3260.4861.99E-14mannoside acetylglucosaminyltransferase 5 [Source:MGI Symbol;Acc:MGI:894 701]
Htra17.27E-190.36 090 7440.6620.4722.35E-14HtrA serine peptidase 1 [Source:MGI Symbol;Acc:MGI:1 929 076]
Vegfa7.45E-190.35 819 2410.5390.3732.41E-14vascular endothelial growth factor A [Source:MGI Symbol;Acc:MGI:103 178]
Nim1k1.14E-180.321 9310.4130.2413.68E-14NIM1 serine/threonine protein kinase [Source:MGI Symbol;Acc:MGI:2 442 399]
Nrg21.19E-18−0.30421890.2230.3733.84E-14neuregulin 2 [Source:MGI Symbol;Acc:MGI:1 098 246]
Hif1a1.93E-180.27 065 1160.2740.1386.25E-14hypoxia inducible factor 1, alpha subunit [Source:MGI Symbol;Acc:MGI:106 918]
Mical22.68E-180.32 752 0130.6480.4838.64E-14microtubule associated monooxygenase, calponin and LIM domain containing 2 [Source:MGI Symbol;Acc:MGI:2 444 947]
Lhfpl33.27E-18−0.39838020.2910.3751.05E-13lipoma HMGIC fusion partner-like 3 [Source:MGI Symbol;Acc:MGI:1 925 076]
Ntm3.91E-180.2 944 4280.9950.971.26E-13neurotrimin [Source:MGI Symbol;Acc:MGI:2 446 259]
Tafa14.53E-180.48 678 1360.3110.1651.46E-13TAFA chemokine like family member 1 [Source:MGI Symbol;Acc:MGI:2 443 695]
Arid5b5.38E-18−0.26222790.1420.2621.74E-13AT rich interactive domain 5B (MRF1-like) [Source:MGI Symbol;Acc:MGI:2 175 912]
Esrrg6.07E-180.36 245 5160.4910.3681.96E-13estrogen-related receptor gamma [Source:MGI Symbol;Acc:MGI:1 347 056]
Ankrd286.58E-18−0.29471650.3410.4832.13E-13ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Wdr177.20E-180.40 737 0870.8440.7512.32E-13WD repeat domain 17 [Source:MGI Symbol;Acc:MGI:1 924 662]
Fus7.50E-18−0.27191570.3640.5112.42E-13fused in sarcoma [Source:MGI Symbol;Acc:MGI:1 353 633]
Dpyd8.99E-18−0.297580.2540.3852.90E-13dihydropyrimidine dehydrogenase [Source:MGI Symbol;Acc:MGI:2 139 667]
Stard131.30E-17−0.37483710.3750.5414.20E-13StAR-related lipid transfer (START) domain containing 13 [Source:MGI Symbol;Acc:MGI:2 385 331]
Adcy81.36E-17−0.30606340.2410.3494.41E-13adenylate cyclase 8 [Source:MGI Symbol;Acc:MGI:1 341 110]
Ptprd1.76E-17−0.3245270.8480.8485.68E-13protein tyrosine phosphatase, receptor type, D [Source:MGI Symbol;Acc:MGI:97 812]
9630014M24Rik2.04E-170.26 701 2950.2730.1056.58E-13RIKEN cDNA 9630014M24 gene [Source:MGI Symbol;Acc:MGI:3 588 234]
Btbd92.29E-17−0.28980790.3360.4867.39E-13BTB (POZ) domain containing 9 [Source:MGI Symbol;Acc:MGI:1 916 625]
Auts22.68E-170.3 804 8110.9110.8028.65E-13autism susceptibility candidate 2 [Source:MGI Symbol;Acc:MGI:1 919 847]
Arhgap233.14E-17−0.27142860.2340.3221.01E-12Rho GTPase activating protein 23 [Source:MGI Symbol;Acc:MGI:3 697 726]
Pde10a3.38E-170.58 969 9390.4040.2341.09E-12phosphodiesterase 10A [Source:MGI Symbol;Acc:MGI:1 345 143]
Grip14.32E-170.31 380 7160.2810.1341.40E-12glutamate receptor interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 921 303]
St6galnac57.24E-170.32 665 3220.2550.1042.34E-12ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 5 [Source:MGI Symbol;Acc:MGI:1 349 471]
Ctnnd27.33E-170.29 063 9440.9810.9592.37E-12catenin (cadherin associated protein), delta 2 [Source:MGI Symbol;Acc:MGI:1 195 966]
Map2k67.54E-170.2 867 0680.3820.2052.43E-12mitogen-activated protein kinase kinase 6 [Source:MGI Symbol;Acc:MGI:1 346 870]
Gm351881.00E-160.33 492 2850.6420.4773.23E-12predicted gene, 35 188 [Source:MGI Symbol;Acc:MGI:5 594 347]
Kmt2c1.20E-160.32 629 1870.6490.5433.89E-12lysine (K)-specific methyltransferase 2C [Source:MGI Symbol;Acc:MGI:2 444 959]
Eda1.43E-16−0.31566060.210.3564.62E-12ectodysplasin-A [Source:MGI Symbol;Acc:MGI:1 195 272]
Egfr1.70E-160.3 217 7370.4580.2585.49E-12epidermal growth factor receptor [Source:MGI Symbol;Acc:MGI:95 294]
Negr12.09E-160.37 537 6390.8530.6976.76E-12neuronal growth regulator 1 [Source:MGI Symbol;Acc:MGI:2 444 846]
Chd92.70E-160.31 204 8060.7730.668.72E-12chromodomain helicase DNA binding protein 9 [Source:MGI Symbol;Acc:MGI:1 924 001]
4930545L23Rik3.15E-160.2 525 5620.2130.0751.02E-11RIKEN cDNA 4930545L23 gene [Source:MGI Symbol;Acc:MGI:1 926 055]
Mbnl23.57E-16−0.29711720.5840.6871.15E-11muscleblind like splicing factor 2 [Source:MGI Symbol;Acc:MGI:2 145 597]
Cdc42bpa3.90E-16−0.28820290.5660.6451.26E-11CDC42 binding protein kinase alpha [Source:MGI Symbol;Acc:MGI:2 441 841]
Rgs7bp5.91E-160.28 765 1370.3440.2141.91E-11regulator of G-protein signalling 7 binding protein [Source:MGI Symbol;Acc:MGI:106 334]
Hip16.79E-160.31 045 9310.4820.3022.19E-11huntingtin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 099 804]
Kcnj107.30E-160.28 764 8760.3580.2382.36E-11potassium inwardly-rectifying channel, subfamily J, member 10 [Source:MGI Symbol;Acc:MGI:1 194 504]
Gab18.69E-16−0.25106650.2290.3392.80E-11growth factor receptor bound protein 2-associated protein 1 [Source:MGI Symbol;Acc:MGI:108 088]
Limch11.22E-150.3 424 3420.6760.5073.95E-11LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Gm303821.52E-150.27 365 5450.1680.0584.92E-11predicted gene, 30 382 [Source:MGI Symbol;Acc:MGI:5 589 541]
Aldoc1.70E-150.27 040 7730.4890.3565.48E-11aldolase C, fructose-bisphosphate [Source:MGI Symbol;Acc:MGI:101 863]
Wwc11.81E-150.30 910 5710.5530.4035.85E-11WW, C2 and coiled-coil domain containing 1 [Source:MGI Symbol;Acc:MGI:2 388 637]
Phka11.91E-150.35 229 3050.6470.5216.17E-11phosphorylase kinase alpha 1 [Source:MGI Symbol;Acc:MGI:97 576]
Map4k41.93E-15−0.26654580.4050.5246.22E-11mitogen-activated protein kinase kinase kinase kinase 4 [Source:MGI Symbol;Acc:MGI:1 349 394]
Stk32a2.16E-15−0.42537670.2270.3436.99E-11serine/threonine kinase 32A [Source:MGI Symbol;Acc:MGI:2 442 403]
Igsf112.48E-15−0.2698380.3420.488.01E-11immunoglobulin superfamily, member 11 [Source:MGI Symbol;Acc:MGI:2 388 477]
Utrn2.56E-15−0.35209440.5960.6478.26E-11utrophin [Source:MGI Symbol;Acc:MGI:104 631]
Prkn2.62E-15−0.356710.5920.7158.46E-11parkin RBR E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 355 296]
Syn23.73E-150.29 810 5870.520.3921.21E-10synapsin II [Source:MGI Symbol;Acc:MGI:103 020]
Dbx24.19E-150.25 917 6930.370.2261.35E-10developing brain homeobox 2 [Source:MGI Symbol;Acc:MGI:107 445]
Gm61454.52E-150.30 080 3970.6410.51.46E-10predicted gene 6145 [Source:MGI Symbol;Acc:MGI:3 779 559]
Id44.92E-15−0.29273950.2740.4291.59E-10inhibitor of DNA binding 4 [Source:MGI Symbol;Acc:MGI:99 414]
Dpf35.68E-150.2 822 1580.4370.2831.83E-10double PHD fingers 3 [Source:MGI Symbol;Acc:MGI:1 917 377]
F38.81E-150.30 629 6780.5420.4232.84E-10coagulation factor III [Source:MGI Symbol;Acc:MGI:88 381]
Sat12.02E-140.28 493 3810.4240.2886.51E-10spermidine/spermine N1-acetyl transferase 1 [Source:MGI Symbol;Acc:MGI:98 233]
Pbx12.05E-14−0.32819210.90.8976.62E-10pre B cell leukemia homeobox 1 [Source:MGI Symbol;Acc:MGI:97 495]
Tmem178b2.22E-14−0.34648750.3980.4847.18E-10transmembrane protein 178B [Source:MGI Symbol;Acc:MGI:3 647 581]
Ghr2.76E-140.30 505 4690.4920.3388.90E-10growth hormone receptor [Source:MGI Symbol;Acc:MGI:95 708]
Ptprz12.79E-140.29 632 4440.8980.8399.02E-10protein tyrosine phosphatase, receptor type Z, polypeptide 1 [Source:MGI Symbol;Acc:MGI:97 816]
Gm161682.81E-14−0.25244130.1990.3069.08E-10predicted gene 16 168 [Source:MGI Symbol;Acc:MGI:3 802 010]
Arhgap263.02E-140.30 202 1830.5340.49.74E-10Rho GTPase activating protein 26 [Source:MGI Symbol;Acc:MGI:1 918 552]
Etnppl3.68E-140.32 550 8230.4010.2491.19E-09ethanolamine phosphate phospholyase [Source:MGI Symbol;Acc:MGI:1 919 010]
Slc7a23.76E-14−0.26928090.3050.4171.22E-09solute carrier family 7 (cationic amino acid transporter, y + system), member 2 [Source:MGI Symbol;Acc:MGI:99 828]
Ube2e24.03E-14−0.30365550.4780.6011.30E-09ubiquitin-conjugating enzyme E2E 2 [Source:MGI Symbol;Acc:MGI:2 384 997]
Gli34.62E-140.28 367 6840.6990.5731.49E-09GLI-Kruppel family member GLI3 [Source:MGI Symbol;Acc:MGI:95 729]
Ccdc1414.83E-140.2 782 9790.4670.3381.56E-09coiled-coil domain containing 141 [Source:MGI Symbol;Acc:MGI:1 919 735]
Tmtc24.83E-140.36 794 5040.5730.3691.56E-09transmembrane and tetratricopeptide repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 914 057]
Immp2l6.36E-14−0.26882140.1850.3122.05E-09IMP2 inner mitochondrial membrane peptidase-like (S. cerevisiae) [Source:MGI Symbol;Acc:MGI:2 135 611]
Tenm37.88E-14−0.32306420.5270.6572.54E-09teneurin transmembrane protein 3 [Source:MGI Symbol;Acc:MGI:1 345 183]
Agl8.71E-140.25 181 8080.4210.2892.81E-09amylo-1,6-glucosidase, 4-alpha-glucanotransferase [Source:MGI Symbol;Acc:MGI:1 924 809]
Phkg18.88E-140.27 904 1170.6790.5732.87E-09phosphorylase kinase gamma 1 [Source:MGI Symbol;Acc:MGI:97 579]
Nbea9.70E-14−0.25885620.5130.6113.13E-09neurobeachin [Source:MGI Symbol;Acc:MGI:1 347 075]
Smyd31.16E-13−0.28255640.350.4973.74E-09SET and MYND domain containing 3 [Source:MGI Symbol;Acc:MGI:1 916 976]
Chst111.30E-13−0.26105280.2590.374.21E-09carbohydrate sulfotransferase 11 [Source:MGI Symbol;Acc:MGI:1 927 166]
Ptgds1.42E-13−0.27257340.3860.4694.57E-09prostaglandin D2 synthase (brain) [Source:MGI Symbol;Acc:MGI:99 261]
Bmpr1b1.51E-13−0.31688010.670.7414.86E-09bone morphogenetic protein receptor, type 1B [Source:MGI Symbol;Acc:MGI:107 191]
Rmst1.63E-13−0.38929720.7550.7955.26E-09rhabdomyosarcoma 2 associated transcript (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 099 806]
Camk1d1.68E-130.30 376 0590.6740.5195.42E-09calcium/calmodulin-dependent protein kinase ID [Source:MGI Symbol;Acc:MGI:2 442 190]
Ttc281.69E-13−0.26126680.3640.4865.45E-09tetratricopeptide repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 140 873]
Zfp4621.76E-13−0.27398350.3250.4465.67E-09zinc finger protein 462 [Source:MGI Symbol;Acc:MGI:107 690]
Pde8b2.74E-130.29 540 4520.430.2718.84E-09phosphodiesterase 8B [Source:MGI Symbol;Acc:MGI:2 443 999]
Slc25a213.38E-13−0.2738290.1370.2821.09E-08solute carrier family 25 (mitochondrial oxodicarboxylate carrier), member 21 [Source:MGI Symbol;Acc:MGI:2 445 059]
Arhgef285.58E-130.27 161 2430.4410.3621.80E-08Rho guanine nucleotide exchange factor (GEF) 28 [Source:MGI Symbol;Acc:MGI:1 346 016]
Pla2g76.34E-130.28 317 9970.6010.4572.05E-08phospholipase A2, group VII (platelet-activating factor acetylhydrolase, plasma) [Source:MGI Symbol;Acc:MGI:1 351 327]
Prr161.04E-120.30 343 2770.3070.1753.34E-08proline rich 16 [Source:MGI Symbol;Acc:MGI:1 918 623]
Spred11.39E-120.25 156 3280.4630.3194.48E-08sprouty protein with EVH-1 domain 1, related sequence [Source:MGI Symbol;Acc:MGI:2 150 016]
Atp2b21.40E-120.25 015 0340.5860.4274.53E-08ATPase, Ca++ transporting, plasma membrane 2 [Source:MGI Symbol;Acc:MGI:105 368]
Exoc6b1.53E-12−0.25067150.4340.5244.93E-08exocyst complex component 6B [Source:MGI Symbol;Acc:MGI:1 923 164]
Itpr21.56E-120.25 815 6070.490.3455.02E-08inositol 1,4,5-triphosphate receptor 2 [Source:MGI Symbol;Acc:MGI:99 418]
Serpine21.96E-120.27 511 2770.4960.3486.32E-08serine (or cysteine) peptidase inhibitor, clade E, member 2 [Source:MGI Symbol;Acc:MGI:101 780]
Irak21.97E-120.26 542 0630.4680.3256.36E-08interleukin-1 receptor-associated kinase 2 [Source:MGI Symbol;Acc:MGI:2 429 603]
Fgf142.41E-12−0.27184350.760.8237.79E-08fibroblast growth factor 14 [Source:MGI Symbol;Acc:MGI:109 189]
2610035D17Rik3.32E-12−0.27191880.4060.5341.07E-07RIKEN cDNA 2610035D17 gene [Source:MGI Symbol;Acc:MGI:1 919 636]
Gli23.49E-120.25 442 8620.4650.3231.13E-07GLI-Kruppel family member GLI2 [Source:MGI Symbol;Acc:MGI:95 728]
Map46.20E-12−0.25090260.4780.5612.00E-07microtubule-associated protein 4 [Source:MGI Symbol;Acc:MGI:97 178]
Ptprj6.24E-120.31 704 5660.430.2882.02E-07protein tyrosine phosphatase, receptor type, J [Source:MGI Symbol;Acc:MGI:104 574]
Nnat7.56E-12−0.33234990.1710.2112.44E-07neuronatin [Source:MGI Symbol;Acc:MGI:104 716]
Fut98.43E-120.28 325 3660.6640.5642.72E-07fucosyltransferase 9 [Source:MGI Symbol;Acc:MGI:1 330 859]
Cpq1.19E-110.26 741 0010.5240.4343.83E-07carboxypeptidase Q [Source:MGI Symbol;Acc:MGI:1 889 205]
Pigk1.20E-110.25 920 6470.2630.1423.86E-07phosphatidylinositol glycan anchor biosynthesis, class K [Source:MGI Symbol;Acc:MGI:1 913 863]
Grid11.20E-110.25 653 8330.4520.3093.88E-07glutamate receptor, ionotropic, delta 1 [Source:MGI Symbol;Acc:MGI:95 812]
Plpp32.08E-110.27 305 6680.7940.7116.72E-07phospholipid phosphatase 3 [Source:MGI Symbol;Acc:MGI:1 915 166]
Tbc1d52.18E-11−0.25629020.3960.4637.05E-07TBC1 domain family, member 5 [Source:MGI Symbol;Acc:MGI:1 919 488]
Znrf32.20E-110.25 537 2480.5420.4127.12E-07zinc and ring finger 3 [Source:MGI Symbol;Acc:MGI:3 039 616]
Zfhx33.18E-11−0.28845420.3670.4521.03E-06zinc finger homeobox 3 [Source:MGI Symbol;Acc:MGI:99 948]
Hivep34.73E-110.2 583 2130.7320.6171.53E-06human immunodeficiency virus type I enhancer binding protein 3 [Source:MGI Symbol;Acc:MGI:106 589]
Nr3c25.97E-110.28 553 2910.6330.5211.93E-06nuclear receptor subfamily 3, group C, member 2 [Source:MGI Symbol;Acc:MGI:99 459]
Nav36.01E-110.32 715 6190.5190.3691.94E-06neuron navigator 3 [Source:MGI Symbol;Acc:MGI:2 183 703]
Rfx46.35E-11−0.32866310.5220.6242.05E-06regulatory factor X, 4 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:1 918 387]
Ank7.92E-11−0.25649490.4180.4932.56E-06progressive ankylosis [Source:MGI Symbol;Acc:MGI:3 045 421]
Rorb8.58E-110.28 096 1340.8630.7662.77E-06RAR-related orphan receptor beta [Source:MGI Symbol;Acc:MGI:1 343 464]
Paqr89.40E-100.26 548 7410.680.5853.03E-05progestin and adipoQ receptor family member VIII [Source:MGI Symbol;Acc:MGI:1 921 479]
Dlgap11.02E-090.25 343 1480.850.7583.28E-05DLG associated protein 1 [Source:MGI Symbol;Acc:MGI:1 346 065]
Pcdh91.62E-090.30 264 9330.9920.9595.25E-05protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Grm32.89E-090.43 138 1540.5690.4699.32E-05glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Cdh201.24E-080.27 398 5620.7170.650.000 399 728cadherin 20 [Source:MGI Symbol;Acc:MGI:1 346 069]
Fam155a1.75E-08−0.4497730.2930.3960.00 056 492NA
Lhfp5.61E-080.30 326 9220.560.460.001 810 805lipoma HMGIC fusion partner [Source:MGI Symbol;Acc:MGI:1 920 048]
Genep_valavg_log2FCpct.1pct.2p_val_adjdescription
St6galnac31.53E-241−1.59362790.0990.5374.95E-237ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 3 [Source:MGI Symbol;Acc:MGI:1 341 828]
Ablim21.04E-231−1.64232250.1320.4723.36E-227actin-binding LIM protein 2 [Source:MGI Symbol;Acc:MGI:2 385 758]
Nkain21.31E-205−1.78428380.4360.7114.24E-201Na+/K + transporting ATPase interacting 2 [Source:MGI Symbol;Acc:MGI:1 923 447]
Gpc53.70E-1561.4 386 1110.9850.6551.19E-151glypican 5 [Source:MGI Symbol;Acc:MGI:1 194 894]
Lsamp2.79E-1491.03 552 76610.9969.01E-145limbic system-associated membrane protein [Source:MGI Symbol;Acc:MGI:1 261 760]
Pkp48.39E-146−1.0036560.2150.542.71E-141plakophilin 4 [Source:MGI Symbol;Acc:MGI:109 281]
Gfap4.94E-145−1.44464860.2080.5361.60E-140glial fibrillary acidic protein [Source:MGI Symbol;Acc:MGI:95 697]
Prune24.16E-140−1.05526780.1270.4761.34E-135prune homolog 2 [Source:MGI Symbol;Acc:MGI:1 925 004]
Grik22.62E-136−1.16448380.4440.7458.45E-132glutamate receptor, ionotropic, kainate 2 (beta 2) [Source:MGI Symbol;Acc:MGI:95 815]
Prr5l2.29E-127−1.00589180.050.3527.38E-123proline rich 5 like [Source:MGI Symbol;Acc:MGI:1 919 696]
Slc8a11.72E-121−1.01436890.2180.5235.56E-117solute carrier family 8 (sodium/calcium exchanger), member 1 [Source:MGI Symbol;Acc:MGI:107 956]
Trpm31.51E-1171.51 328 0140.9520.5634.88E-113transient receptor potential cation channel, subfamily M, member 3 [Source:MGI Symbol;Acc:MGI:2 443 101]
Sorbs22.64E-116−1.16436880.1720.4678.53E-112sorbin and SH3 domain containing 2 [Source:MGI Symbol;Acc:MGI:1 924 574]
Gm37641.75E-1120.96 079 9840.9520.7495.65E-108predicted gene 3764 [Source:MGI Symbol;Acc:MGI:3 781 938]
Adamtsl14.27E-109−0.84474680.020.3161.38E-104ADAMTS-like 1 [Source:MGI Symbol;Acc:MGI:1 924 989]
Cacnb24.88E-109−1.14120210.2510.5281.58E-104calcium channel, voltage-dependent, beta 2 subunit [Source:MGI Symbol;Acc:MGI:894 644]
Kirrel33.05E-1081.28 033 1720.890.5289.85E-104kirre like nephrin family adhesion molecule 3 [Source:MGI Symbol;Acc:MGI:1 914 953]
Mdga28.42E-950.93 802 8950.9790.852.72E-90MAM domain containing glycosylphosphatidylinositol anchor 2 [Source:MGI Symbol;Acc:MGI:2 444 706]
Cobll14.35E-94−0.59498850.0440.3181.41E-89Cobl-like 1 [Source:MGI Symbol;Acc:MGI:2 442 894]
Slc38a11.99E-92−0.89661440.2320.5076.42E-88solute carrier family 38, member 1 [Source:MGI Symbol;Acc:MGI:2 145 895]
Ccdc1484.14E-92−0.78608480.0530.2911.34E-87coiled-coil domain containing 148 [Source:MGI Symbol;Acc:MGI:3 039 583]
Nrxn14.43E-920.87 728 2530.9980.911.43E-87neurexin I [Source:MGI Symbol;Acc:MGI:1 096 391]
Plcb11.88E-911.13 264 8610.9510.7486.07E-87phospholipase C, beta 1 [Source:MGI Symbol;Acc:MGI:97 613]
A2m4.93E-90−0.88175570.0650.2981.59E-85alpha-2-macroglobulin [Source:MGI Symbol;Acc:MGI:2 449 119]
Tmeff26.26E-89−0.85731650.1580.3532.02E-84transmembrane protein with EGF-like and two follistatin-like domains 2 [Source:MGI Symbol;Acc:MGI:1 861 735]
Dgki8.89E-87−0.77686950.2210.5362.87E-82diacylglycerol kinase, iota [Source:MGI Symbol;Acc:MGI:2 443 430]
Kcnd21.16E-841.29 103 5480.720.443.74E-80potassium voltage-gated channel, Shal-related family, member 2 [Source:MGI Symbol;Acc:MGI:102 663]
Pdzrn31.83E-84−0.6136950.0840.3725.89E-80PDZ domain containing RING finger 3 [Source:MGI Symbol;Acc:MGI:1 933 157]
Slc24a22.21E-83−0.89372330.3150.4277.15E-79solute carrier family 24 (sodium/potassium/calcium exchanger), member 2 [Source:MGI Symbol;Acc:MGI:1 923 626]
Gria25.83E-830.91 744 6170.7750.4931.88E-78glutamate receptor, ionotropic, AMPA2 (alpha 2) [Source:MGI Symbol;Acc:MGI:95 809]
Grm71.28E-82−0.85193080.2120.4364.12E-78glutamate receptor, metabotropic 7 [Source:MGI Symbol;Acc:MGI:1 351 344]
Gm207132.19E-810.85 012 0780.7270.2837.08E-77predicted gene 20 713 [Source:MGI Symbol;Acc:MGI:5 313 160]
Cadps1.18E-80−0.81690650.2990.5713.79E-76Ca2+-dependent secretion activator [Source:MGI Symbol;Acc:MGI:1 350 922]
Rora2.23E-780.80 516 0940.9910.9597.20E-74RAR-related orphan receptor alpha [Source:MGI Symbol;Acc:MGI:104 661]
Kcnj31.93E-77−0.69385630.1580.4536.24E-73potassium inwardly-rectifying channel, subfamily J, member 3 [Source:MGI Symbol;Acc:MGI:104 742]
Slc6a112.45E-770.82 740 9090.5970.3027.92E-73solute carrier family 6 (neurotransmitter transporter, GABA), member 11 [Source:MGI Symbol;Acc:MGI:95 630]
Gm149645.63E-76−0.58123850.1540.4031.82E-71predicted gene 14 964 [Source:MGI Symbol;Acc:MGI:3 641 621]
Slc7a108.30E-750.80 503 3510.570.1722.68E-70solute carrier family 7 (cationic amino acid transporter, y + system), member 10 [Source:MGI Symbol;Acc:MGI:1 858 261]
Ccdc31.94E-73−0.56467980.020.2446.25E-69coiled-coil domain containing 3 [Source:MGI Symbol;Acc:MGI:1 921 436]
Prickle28.03E-73−0.7091480.3450.6072.59E-68prickle planar cell polarity protein 2 [Source:MGI Symbol;Acc:MGI:1 925 144]
Brinp31.40E-700.82 937 7710.7160.3534.52E-66bone morphogenetic protein/retinoic acid inducible neural specific 3 [Source:MGI Symbol;Acc:MGI:2 443 035]
Pex5l1.61E-70−0.83276840.1830.3295.20E-66peroxisomal biogenesis factor 5-like [Source:MGI Symbol;Acc:MGI:1 916 672]
Prkca2.52E-70−0.77768890.5510.7528.12E-66protein kinase C, alpha [Source:MGI Symbol;Acc:MGI:97 595]
Asap37.08E-70−0.45261050.0250.2392.29E-65ArfGAP with SH3 domain, ankyrin repeat and PH domain 3 [Source:MGI Symbol;Acc:MGI:2 684 986]
St188.32E-70−0.70185880.0630.2252.69E-65suppression of tumorigenicity 18 [Source:MGI Symbol;Acc:MGI:2 446 700]
Ldb21.58E-69−0.57966620.1140.3595.09E-65LIM domain binding 2 [Source:MGI Symbol;Acc:MGI:894 670]
Edil32.54E-69−0.689130.1780.3628.21E-65EGF-like repeats and discoidin I-like domains 3 [Source:MGI Symbol;Acc:MGI:1 329 025]
Unc5c5.97E-68−0.73579040.1820.421.93E-63unc-5 netrin receptor C [Source:MGI Symbol;Acc:MGI:1 095 412]
Gm122399.70E-681.08 440 5170.5810.2423.13E-63predicted gene 12 239 [Source:MGI Symbol;Acc:MGI:3 651 547]
C4b1.35E-67−0.51007120.0660.3124.35E-63complement component 4B (Chido blood group) [Source:MGI Symbol;Acc:MGI:88 228]
Tmem1082.42E-67−0.5227890.0430.2457.80E-63transmembrane protein 108 [Source:MGI Symbol;Acc:MGI:1 932 411]
Dock102.55E-66−0.6171340.1050.2668.24E-62dedicator of cytokinesis 10 [Source:MGI Symbol;Acc:MGI:2 146 320]
Gm48761.07E-65−0.61758020.1280.3683.45E-61predicted gene 4876 [Source:MGI Symbol;Acc:MGI:3 647 654]
Sulf21.90E-64−0.42984590.0340.2386.14E-60sulfatase 2 [Source:MGI Symbol;Acc:MGI:1 919 293]
Col23a12.45E-64−0.8123560.1120.347.92E-60collagen, type XXIII, alpha 1 [Source:MGI Symbol;Acc:MGI:2 653 243]
Prkag26.39E-63−0.56851360.1560.3762.06E-58protein kinase, AMP-activated, gamma 2 non-catalytic subunit [Source:MGI Symbol;Acc:MGI:1 336 153]
Ctnna22.00E-61−0.85708440.6690.8096.45E-57catenin (cadherin associated protein), alpha 2 [Source:MGI Symbol;Acc:MGI:88 275]
Myoc1.78E-60−0.57942840.0110.1885.74E-56myocilin [Source:MGI Symbol;Acc:MGI:1 202 864]
Enpp22.58E-60−0.52837730.2120.4538.33E-56ectonucleotide pyrophosphatase/phosphodiesterase 2 [Source:MGI Symbol;Acc:MGI:1 321 390]
Frmd56.05E-60−0.67540120.1030.2551.95E-55FERM domain containing 5 [Source:MGI Symbol;Acc:MGI:2 442 557]
Sema6a9.70E-60−0.41414330.0590.2833.13E-55sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6A [Source:MGI Symbol;Acc:MGI:1 203 727]
Arhgef41.15E-59−0.73589960.5650.6973.70E-55Rho guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:2 442 507]
Zfp5365.69E-59−0.52649440.0440.2041.84E-54zinc finger protein 536 [Source:MGI Symbol;Acc:MGI:1 926 102]
Enox11.09E-58−0.71177450.2490.5043.51E-54ecto-NOX disulfide-thiol exchanger 1 [Source:MGI Symbol;Acc:MGI:2 444 896]
Pakap8.14E-57−0.4203850.0330.2142.63E-52paralemmin A kinase anchor protein [Source:MGI Symbol;Acc:MGI:5 141 924]
Man1c11.77E-56−0.46972530.0590.2565.71E-52mannosidase, alpha, class 1C, member 1 [Source:MGI Symbol;Acc:MGI:2 446 214]
Nrp22.58E-56−0.39141450.0430.2368.32E-52neuropilin 2 [Source:MGI Symbol;Acc:MGI:1 100 492]
Csmd14.93E-56−0.59264430.3860.5441.59E-51CUB and Sushi multiple domains 1 [Source:MGI Symbol;Acc:MGI:2 137 383]
Nhsl17.81E-560.7 363 4140.7370.4432.52E-51NHS-like 1 [Source:MGI Symbol;Acc:MGI:106 390]
Cd443.70E-55−0.4325580.0220.1981.19E-50CD44 antigen [Source:MGI Symbol;Acc:MGI:88 338]
Dnm31.96E-54−0.56683620.2810.5116.32E-50dynamin 3 [Source:MGI Symbol;Acc:MGI:1 341 299]
Pde4b2.27E-54−0.7656010.5480.5067.32E-50phosphodiesterase 4B, cAMP specific [Source:MGI Symbol;Acc:MGI:99 557]
Atp1a26.26E-540.67 797 4270.9380.8112.02E-49ATPase, Na+/K + transporting, alpha 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 106]
Pacrg7.92E-54−0.61658490.2790.5472.56E-49PARK2 co-regulated [Source:MGI Symbol;Acc:MGI:1 916 560]
Rgs71.69E-530.75 771 7180.6530.3425.44E-49regulator of G protein signaling 7 [Source:MGI Symbol;Acc:MGI:1 346 089]
Pitpnc11.79E-530.77 375 0720.9160.7615.79E-49phosphatidylinositol transfer protein, cytoplasmic 1 [Source:MGI Symbol;Acc:MGI:1 919 045]
Pde7b2.22E-530.75 004 2570.7130.3797.18E-49phosphodiesterase 7B [Source:MGI Symbol;Acc:MGI:1 352 752]
Sorbs14.64E-53−0.70896350.6330.7791.50E-48sorbin and SH3 domain containing 1 [Source:MGI Symbol;Acc:MGI:700 014]
Kif21a6.38E-53−0.4973930.3880.6232.06E-48kinesin family member 21A [Source:MGI Symbol;Acc:MGI:109 188]
Ccser19.85E-53−0.65703470.2760.4463.18E-48coiled-coil serine rich 1 [Source:MGI Symbol;Acc:MGI:3 045 354]
Adgrb31.78E-520.71 451 4760.960.895.76E-48adhesion G protein-coupled receptor B3 [Source:MGI Symbol;Acc:MGI:2 441 837]
Sntg24.21E-52−0.34334370.0150.1911.36E-47syntrophin, gamma 2 [Source:MGI Symbol;Acc:MGI:1 919 541]
Mbp6.86E-52−0.5974130.3760.5132.21E-47myelin basic protein [Source:MGI Symbol;Acc:MGI:96 925]
Tmem132b3.47E-51−0.34043890.0620.2641.12E-46transmembrane protein 132B [Source:MGI Symbol;Acc:MGI:3 609 245]
Phyhd12.24E-50−0.50595120.2210.4527.24E-46phytanoyl-CoA dioxygenase domain containing 1 [Source:MGI Symbol;Acc:MGI:3 612 860]
Glis33.59E-50−0.62542110.5240.7151.16E-45GLIS family zinc finger 3 [Source:MGI Symbol;Acc:MGI:2 444 289]
Elmo17.87E-50−0.52881910.1040.2682.54E-45engulfment and cell motility 1 [Source:MGI Symbol;Acc:MGI:2 153 044]
Car102.40E-490.85 983 3940.4940.2827.75E-45carbonic anhydrase 10 [Source:MGI Symbol;Acc:MGI:1 919 855]
Ptch13.37E-490.70 455 4390.5810.2851.09E-44patched 1 [Source:MGI Symbol;Acc:MGI:105 373]
Aebp11.40E-48−0.34100280.0110.1824.52E-44AE binding protein 1 [Source:MGI Symbol;Acc:MGI:1 197 012]
Pcdh72.00E-480.5 983 1060.8860.7446.47E-44protocadherin 7 [Source:MGI Symbol;Acc:MGI:1 860 487]
Dok66.61E-48−0.54490440.1560.3822.13E-43docking protein 6 [Source:MGI Symbol;Acc:MGI:3 639 495]
Garnl31.52E-47−0.37356950.0830.2664.90E-43GTPase activating RANGAP domain-like 3 [Source:MGI Symbol;Acc:MGI:2 139 309]
Robo21.53E-47−0.67838390.5650.7284.95E-43roundabout guidance receptor 2 [Source:MGI Symbol;Acc:MGI:1 890 110]
Synpo24.98E-47−0.62419530.1620.3931.61E-42synaptopodin 2 [Source:MGI Symbol;Acc:MGI:2 153 070]
Zeb25.73E-46−0.54897780.5140.6571.85E-41zinc finger E-box binding homeobox 2 [Source:MGI Symbol;Acc:MGI:1 344 407]
Padi25.77E-46−0.45318580.1240.3361.86E-41peptidyl arginine deiminase, type II [Source:MGI Symbol;Acc:MGI:1 338 892]
C530044C16Rik5.84E-46−0.34399180.0110.1621.89E-41RIKEN cDNA C530044C16 gene [Source:MGI Symbol;Acc:MGI:2 443 109]
Reep12.13E-44−0.44857350.0710.2396.88E-40receptor accessory protein 1 [Source:MGI Symbol;Acc:MGI:1 098 827]
Map76.02E-44−0.46314340.1470.2981.94E-39microtubule-associated protein 7 [Source:MGI Symbol;Acc:MGI:1 328 328]
Atp13a46.00E-430.52 133 6030.4980.2191.94E-38ATPase type 13A4 [Source:MGI Symbol;Acc:MGI:1 924 456]
Cpne83.12E-42−0.29628670.0350.1921.01E-37copine VIII [Source:MGI Symbol;Acc:MGI:1 914 121]
Tagln33.76E-42−0.45100630.2970.4871.21E-37transgelin 3 [Source:MGI Symbol;Acc:MGI:1 926 784]
Frmd4a4.71E-420.63 758 1730.9350.7821.52E-37FERM domain containing 4A [Source:MGI Symbol;Acc:MGI:1 919 850]
Sema3a7.94E-42−0.37426410.0310.1742.56E-37sema domain, immunoglobulin domain (Ig), short basic domain, secreted, (semaphorin) 3A [Source:MGI Symbol;Acc:MGI:107 558]
Tnc1.52E-41−0.28987480.0190.1774.89E-37tenascin C [Source:MGI Symbol;Acc:MGI:101 922]
Cacnb45.46E-41−0.55386590.2310.4231.76E-36calcium channel, voltage-dependent, beta 4 subunit [Source:MGI Symbol;Acc:MGI:103 301]
Neat16.65E-41−0.64808040.5210.6272.15E-36nuclear paraspeckle assembly transcript 1 (non-protein coding) [Source:MGI Symbol;Acc:MGI:1 914 211]
Ano43.04E-40−0.37170070.0740.2099.82E-36anoctamin 4 [Source:MGI Symbol;Acc:MGI:2 443 344]
Adamts94.01E-40−0.51521880.1950.4191.29E-35a disintegrin-like and metallopeptidase (reprolysin type) with thrombospondin type 1 motif, 9 [Source:MGI Symbol;Acc:MGI:1 916 320]
Luzp24.27E-400.98 895 0870.9030.6811.38E-35leucine zipper protein 2 [Source:MGI Symbol;Acc:MGI:1 889 615]
March16.66E-40−0.4157750.0850.2212.15E-35NA
Igfbp57.96E-40−0.40115060.0920.2812.57E-35insulin-like growth factor binding protein 5 [Source:MGI Symbol;Acc:MGI:96 440]
Hecw29.58E-40−0.39168580.090.2153.09E-35HECT, C2 and WW domain containing E3 ubiquitin protein ligase 2 [Source:MGI Symbol;Acc:MGI:2 685 817]
Ank21.52E-39−0.69756270.9540.9494.92E-35ankyrin 2, brain [Source:MGI Symbol;Acc:MGI:88 025]
Trp632.59E-390.64 506 9460.3240.1118.35E-35transformation related protein 63 [Source:MGI Symbol;Acc:MGI:1 330 810]
Adgrl32.95E-390.53 274 2270.9060.7969.52E-35adhesion G protein-coupled receptor L3 [Source:MGI Symbol;Acc:MGI:2 441 950]
9530026P05Rik1.12E-38−0.59699570.2250.4223.61E-34RIKEN cDNA 9530026P05 gene [Source:MGI Symbol;Acc:MGI:1 924 659]
Fmn12.01E-38−0.57518580.1950.3586.49E-34formin 1 [Source:MGI Symbol;Acc:MGI:101 815]
D7Ertd443e3.39E-38−0.29014660.0260.161.09E-33DNA segment, Chr 7, ERATO Doi 443, expressed [Source:MGI Symbol;Acc:MGI:1 196 431]
Tex117.26E-38−0.25602360.0110.152.34E-33testis expressed gene 11 [Source:MGI Symbol;Acc:MGI:1 933 237]
Sema6d1.10E-37−0.73744820.5280.6643.54E-33sema domain, transmembrane domain (TM), and cytoplasmic domain, (semaphorin) 6D [Source:MGI Symbol;Acc:MGI:2 387 661]
Tulp42.02E-37−0.44931220.3790.5636.51E-33tubby like protein 4 [Source:MGI Symbol;Acc:MGI:1 916 092]
Aqp43.92E-37−0.4956280.4040.5931.27E-32aquaporin 4 [Source:MGI Symbol;Acc:MGI:107 387]
Dscaml16.17E-37−0.32478570.0310.1451.99E-32DS cell adhesion molecule like 1 [Source:MGI Symbol;Acc:MGI:2 150 309]
Eya49.63E-37−0.36639930.0930.2683.11E-32EYA transcriptional coactivator and phosphatase 4 [Source:MGI Symbol;Acc:MGI:1 337 104]
Thbs42.03E-36−0.28644410.0070.1286.56E-32thrombospondin 4 [Source:MGI Symbol;Acc:MGI:1 101 779]
Apbb1ip2.03E-36−0.27603990.0120.1646.57E-32amyloid beta (A4) precursor protein-binding, family B, member 1 interacting protein [Source:MGI Symbol;Acc:MGI:1 861 354]
Ank32.07E-36−0.43101190.2380.3666.67E-32ankyrin 3, epithelial [Source:MGI Symbol;Acc:MGI:88 026]
Slc4a42.32E-360.53 869 8480.9270.8467.47E-32solute carrier family 4 (anion exchanger), member 4 [Source:MGI Symbol;Acc:MGI:1 927 555]
Syne12.48E-360.48 914 0070.8840.7748.02E-32spectrin repeat containing, nuclear envelope 1 [Source:MGI Symbol;Acc:MGI:1 927 152]
Cadm28.59E-360.47 857 2720.9920.922.77E-31cell adhesion molecule 2 [Source:MGI Symbol;Acc:MGI:2 442 722]
Pxdn3.14E-35−0.29168010.0710.2221.02E-30peroxidasin [Source:MGI Symbol;Acc:MGI:1 916 925]
Cmya54.19E-35−0.33401310.0930.2721.35E-30cardiomyopathy associated 5 [Source:MGI Symbol;Acc:MGI:1 923 719]
4930402H24Rik5.42E-35−0.48683070.830.861.75E-30NA
Reln6.39E-35−0.43203110.110.2952.06E-30reelin [Source:MGI Symbol;Acc:MGI:103 022]
Retreg19.38E-35−0.29235920.0960.2663.03E-30reticulophagy regulator 1 [Source:MGI Symbol;Acc:MGI:1 913 520]
Gpld11.38E-340.46 185 2080.3950.1514.47E-30glycosylphosphatidylinositol specific phospholipase D1 [Source:MGI Symbol;Acc:MGI:106 604]
Plp11.47E-34−0.4348560.5990.7314.76E-30proteolipid protein (myelin) 1 [Source:MGI Symbol;Acc:MGI:97 623]
Mapt2.50E-34−0.44176690.4270.568.06E-30microtubule-associated protein tau [Source:MGI Symbol;Acc:MGI:97 180]
Eps82.62E-340.47 960 3480.5370.2748.46E-30epidermal growth factor receptor pathway substrate 8 [Source:MGI Symbol;Acc:MGI:104 684]
Tab23.98E-34−0.38333140.2510.451.28E-29TGF-beta activated kinase 1/MAP3K7 binding protein 2 [Source:MGI Symbol;Acc:MGI:1 915 902]
Dock44.61E-340.53 604 3730.8150.6411.49E-29dedicator of cytokinesis 4 [Source:MGI Symbol;Acc:MGI:1 918 006]
Ptprk2.18E-33−0.32661880.0860.2197.02E-29protein tyrosine phosphatase, receptor type, K [Source:MGI Symbol;Acc:MGI:103 310]
Airn4.11E-33−0.31793050.0540.1841.33E-28antisense Igf2r RNA [Source:MGI Symbol;Acc:MGI:1 353 471]
Erbin2.15E-32−0.41815980.2990.466.94E-28Erbb2 interacting protein [Source:MGI Symbol;Acc:MGI:1 890 169]
Plxdc22.72E-32−0.43980.2670.4438.77E-28plexin domain containing 2 [Source:MGI Symbol;Acc:MGI:1 914 698]
Vav33.24E-320.49 950 3790.4460.1871.05E-27vav 3 oncogene [Source:MGI Symbol;Acc:MGI:1 888 518]
Sh3d194.83E-32−0.25908980.0410.1711.56E-27SH3 domain protein D19 [Source:MGI Symbol;Acc:MGI:1 350 923]
Gm106356.44E-32−0.31841620.0230.152.08E-27predicted gene 10 635 [Source:MGI Symbol;Acc:MGI:3 641 740]
Itih31.22E-310.46 778 9670.3420.1283.95E-27inter-alpha trypsin inhibitor, heavy chain 3 [Source:MGI Symbol;Acc:MGI:96 620]
Kcnma11.29E-310.58 278 3970.6720.4164.18E-27potassium large conductance calcium-activated channel, subfamily M, alpha member 1 [Source:MGI Symbol;Acc:MGI:99 923]
Acsbg11.66E-310.46 229 4430.6060.4065.36E-27acyl-CoA synthetase bubblegum family member 1 [Source:MGI Symbol;Acc:MGI:2 385 656]
Naaladl22.22E-31−0.50596970.3140.5287.16E-27N-acetylated alpha-linked acidic dipeptidase-like 2 [Source:MGI Symbol;Acc:MGI:2 685 867]
Rps6ka52.78E-31−0.35757310.2040.3958.99E-27ribosomal protein S6 kinase, polypeptide 5 [Source:MGI Symbol;Acc:MGI:1 920 336]
Mobp3.94E-31−0.3479790.1350.2581.27E-26myelin-associated oligodendrocytic basic protein [Source:MGI Symbol;Acc:MGI:108 511]
Cdh109.07E-310.49 836 4990.7380.5362.93E-26cadherin 10 [Source:MGI Symbol;Acc:MGI:107 436]
Cadm11.31E-300.50 571 3360.8350.6484.24E-26cell adhesion molecule 1 [Source:MGI Symbol;Acc:MGI:1 889 272]
Arhgap61.40E-30−0.25423430.0340.1444.51E-26Rho GTPase activating protein 6 [Source:MGI Symbol;Acc:MGI:1 196 332]
Dner2.35E-30−0.3441610.1730.337.57E-26delta/notch-like EGF repeat containing [Source:MGI Symbol;Acc:MGI:2 152 889]
Disp32.80E-30−0.30234690.0770.1999.04E-26dispatched RND transporter family member 3 [Source:MGI Symbol;Acc:MGI:2 444 403]
Npas34.84E-300.46 551 2690.9850.9431.56E-25neuronal PAS domain protein 3 [Source:MGI Symbol;Acc:MGI:1 351 610]
Id36.28E-30−0.3400750.1340.3122.03E-25inhibitor of DNA binding 3 [Source:MGI Symbol;Acc:MGI:96 398]
Kalrn6.35E-300.44 370 4620.5660.3212.05E-25kalirin, RhoGEF kinase [Source:MGI Symbol;Acc:MGI:2 685 385]
Fgfr31.96E-290.41 311 4010.6340.4576.32E-25fibroblast growth factor receptor 3 [Source:MGI Symbol;Acc:MGI:95 524]
Agap12.08E-29−0.34621550.1980.3436.72E-25ArfGAP with GTPase domain, ankyrin repeat and PH domain 1 [Source:MGI Symbol;Acc:MGI:2 653 690]
Bin12.61E-29−0.29684230.130.2628.41E-25bridging integrator 1 [Source:MGI Symbol;Acc:MGI:108 092]
Tspan73.06E-290.46 649 1080.7840.639.89E-25tetraspanin 7 [Source:MGI Symbol;Acc:MGI:1 298 407]
Cables13.75E-290.43 697 1520.470.2181.21E-24CDK5 and Abl enzyme substrate 1 [Source:MGI Symbol;Acc:MGI:1 927 065]
Ddr14.57E-29−0.29183040.1340.2881.47E-24discoidin domain receptor family, member 1 [Source:MGI Symbol;Acc:MGI:99 216]
Ano14.74E-29−0.32992270.0030.1441.53E-24anoctamin 1, calcium activated chloride channel [Source:MGI Symbol;Acc:MGI:2 142 149]
Grin2c7.34E-290.38 585 4430.4280.1882.37E-24glutamate receptor, ionotropic, NMDA2C (epsilon 3) [Source:MGI Symbol;Acc:MGI:95 822]
Slco1c18.32E-290.44 635 9410.4590.2352.69E-24solute carrier organic anion transporter family, member 1c1 [Source:MGI Symbol;Acc:MGI:1 889 679]
Trim29.96E-29−0.37651730.3080.4913.21E-24tripartite motif-containing 2 [Source:MGI Symbol;Acc:MGI:1 933 163]
Fat31.02E-280.48 826 9490.6850.5263.29E-24FAT atypical cadherin 3 [Source:MGI Symbol;Acc:MGI:2 444 314]
Spock11.36E-28−0.30109010.1110.2284.39E-24sparc/osteonectin, cwcv and kazal-like domains proteoglycan 1 [Source:MGI Symbol;Acc:MGI:105 371]
Grin3a1.95E-28−0.39370810.1380.2936.30E-24glutamate receptor ionotropic, NMDA3A [Source:MGI Symbol;Acc:MGI:1 933 206]
Ptprg2.33E-280.48 924 4260.6420.4967.51E-24NA
Nwd12.35E-280.41 679 6270.7050.5067.59E-24NACHT and WD repeat domain containing 1 [Source:MGI Symbol;Acc:MGI:2 442 268]
Wwox3.10E-28−0.5667150.5260.6781.00E-23WW domain-containing oxidoreductase [Source:MGI Symbol;Acc:MGI:1 931 237]
Cep85l6.31E-280.4 097 8750.5780.3822.04E-23centrosomal protein 85-like [Source:MGI Symbol;Acc:MGI:3 642 684]
Gria46.44E-280.59 105 0450.4260.2582.08E-23glutamate receptor, ionotropic, AMPA4 (alpha 4) [Source:MGI Symbol;Acc:MGI:95 811]
Nxn9.83E-28−0.47264220.4210.5953.17E-23nucleoredoxin [Source:MGI Symbol;Acc:MGI:109 331]
2610307P16Rik1.27E-27−0.31659830.0640.1984.11E-23RIKEN cDNA 2610307P16 gene [Source:MGI Symbol;Acc:MGI:1 919 768]
Ccdc85a1.29E-270.47 682 1040.5240.2824.16E-23coiled-coil domain containing 85A [Source:MGI Symbol;Acc:MGI:2 445 069]
Grid22.01E-270.48 400 7850.910.7616.50E-23glutamate receptor, ionotropic, delta 2 [Source:MGI Symbol;Acc:MGI:95 813]
Nrbp23.89E-27−0.3131650.1840.3551.25E-22nuclear receptor binding protein 2 [Source:MGI Symbol;Acc:MGI:2 385 017]
Etv46.28E-270.34 377 1190.2810.0732.03E-22ets variant 4 [Source:MGI Symbol;Acc:MGI:99 423]
Cep1126.56E-27−0.25664220.0720.2252.12E-22centrosomal protein 112 [Source:MGI Symbol;Acc:MGI:1 923 673]
Rnf2201.42E-26−0.38293090.1610.2424.60E-22ring finger protein 220 [Source:MGI Symbol;Acc:MGI:1 913 993]
Rtn43.75E-26−0.35591380.5030.6521.21E-21reticulon 4 [Source:MGI Symbol;Acc:MGI:1 915 835]
Klhl294.42E-26−0.28145850.1230.2781.43E-21kelch-like 29 [Source:MGI Symbol;Acc:MGI:2 683 857]
Sorcs17.06E-26−0.32927210.1120.2262.28E-21sortilin-related VPS10 domain containing receptor 1 [Source:MGI Symbol;Acc:MGI:1 929 666]
App8.22E-26−0.36787750.5210.6422.65E-21amyloid beta (A4) precursor protein [Source:MGI Symbol;Acc:MGI:88 059]
Grk31.23E-250.38 379 0140.5720.3393.97E-21G protein-coupled receptor kinase 3 [Source:MGI Symbol;Acc:MGI:87 941]
Atp1b21.53E-250.45 621 0180.5410.4264.95E-21ATPase, Na+/K + transporting, beta 2 polypeptide [Source:MGI Symbol;Acc:MGI:88 109]
Bmp61.82E-25−0.25663580.0390.165.88E-21bone morphogenetic protein 6 [Source:MGI Symbol;Acc:MGI:88 182]
Ndrg21.93E-250.40 022 6160.730.626.22E-21N-myc downstream regulated gene 2 [Source:MGI Symbol;Acc:MGI:1 352 498]
Mgat4c3.09E-250.47 103 3120.5650.4799.97E-21MGAT4 family, member C [Source:MGI Symbol;Acc:MGI:1 914 819]
Pdgfd5.25E-25−0.43084350.390.5281.69E-20platelet-derived growth factor, D polypeptide [Source:MGI Symbol;Acc:MGI:1 919 035]
Nav26.00E-25−0.42033420.5210.641.94E-20neuron navigator 2 [Source:MGI Symbol;Acc:MGI:2 183 691]
Shc39.06E-250.35 170 7430.3870.1722.92E-20src homology 2 domain-containing transforming protein C3 [Source:MGI Symbol;Acc:MGI:106 179]
Plscr41.07E-24−0.26351470.0990.2513.44E-20phospholipid scramblase 4 [Source:MGI Symbol;Acc:MGI:2 143 267]
Dgkb1.55E-240.41 451 4060.8990.7885.02E-20diacylglycerol kinase, beta [Source:MGI Symbol;Acc:MGI:2 442 474]
Fry1.97E-240.38 056 9650.6770.5676.35E-20FRY microtubule binding protein [Source:MGI Symbol;Acc:MGI:2 443 895]
Tnik2.85E-240.39 465 1720.9260.8529.19E-20TRAF2 and NCK interacting kinase [Source:MGI Symbol;Acc:MGI:1 916 264]
Slc1a24.57E-240.38 376 7960.9990.9761.47E-19solute carrier family 1 (glial high affinity glutamate transporter), member 2 [Source:MGI Symbol;Acc:MGI:101 931]
Tmc74.76E-240.36 285 4910.3430.1521.54E-19transmembrane channel-like gene family 7 [Source:MGI Symbol;Acc:MGI:2 443 317]
Nrcam5.21E-240.38 906 2530.8310.6841.68E-19neuronal cell adhesion molecule [Source:MGI Symbol;Acc:MGI:104 750]
Pgm51.33E-23−0.26781540.0340.1614.28E-19phosphoglucomutase 5 [Source:MGI Symbol;Acc:MGI:1 925 668]
Rapgef41.55E-23−0.30338410.1230.2365.00E-19Rap guanine nucleotide exchange factor (GEF) 4 [Source:MGI Symbol;Acc:MGI:1 917 723]
Adipor22.96E-23−0.29242370.1520.2419.56E-19adiponectin receptor 2 [Source:MGI Symbol;Acc:MGI:93 830]
Gabbr28.65E-230.40 045 0430.330.1512.79E-18gamma-aminobutyric acid (GABA) B receptor, 2 [Source:MGI Symbol;Acc:MGI:2 386 030]
Phactr31.14E-220.36 083 1550.5180.2853.68E-18phosphatase and actin regulator 3 [Source:MGI Symbol;Acc:MGI:1 921 439]
Dst1.39E-22−0.36711630.6210.7184.49E-18dystonin [Source:MGI Symbol;Acc:MGI:104 627]
Gjb61.94E-220.31 796 4270.3470.1646.27E-18gap junction protein, beta 6 [Source:MGI Symbol;Acc:MGI:107 588]
Dip2b2.13E-22−0.3137080.3440.4876.89E-18disco interacting protein 2 homolog B [Source:MGI Symbol;Acc:MGI:2 145 977]
Ntng13.12E-22−0.31572520.0620.1771.01E-17netrin G1 [Source:MGI Symbol;Acc:MGI:1 934 028]
Frmpd43.81E-22−0.26677090.1360.2341.23E-17FERM and PDZ domain containing 4 [Source:MGI Symbol;Acc:MGI:3 042 378]
Kcnip33.99E-220.37 212 3660.3770.1871.29E-17Kv channel interacting protein 3, calsenilin [Source:MGI Symbol;Acc:MGI:1 929 258]
Ppp1r16b4.87E-22−0.26358730.0940.1741.57E-17protein phosphatase 1, regulatory subunit 16B [Source:MGI Symbol;Acc:MGI:2 151 841]
Slc6a17.68E-220.35 533 7630.6010.4422.48E-17solute carrier family 6 (neurotransmitter transporter, GABA), member 1 [Source:MGI Symbol;Acc:MGI:95 627]
Sorcs28.98E-220.31 923 2460.3490.1612.90E-17sortilin-related VPS10 domain containing receptor 2 [Source:MGI Symbol;Acc:MGI:1 932 289]
Mpdz1.18E-21−0.264380.1550.2993.81E-17multiple PDZ domain crumbs cell polarity complex component [Source:MGI Symbol;Acc:MGI:1 343 489]
Tsc22d11.35E-21−0.27447680.2610.4154.35E-17TSC22 domain family, member 1 [Source:MGI Symbol;Acc:MGI:109 127]
Xylt11.69E-210.39 333 3490.5110.2885.45E-17xylosyltransferase 1 [Source:MGI Symbol;Acc:MGI:2 451 073]
Ski2.22E-21−0.2875370.1710.3127.18E-17ski sarcoma viral oncogene homolog (avian) [Source:MGI Symbol;Acc:MGI:98 310]
Tenm42.83E-210.39 167 5450.4230.2519.12E-17teneurin transmembrane protein 4 [Source:MGI Symbol;Acc:MGI:2 447 063]
Ablim12.84E-210.35 555 5790.5170.3159.15E-17actin-binding LIM protein 1 [Source:MGI Symbol;Acc:MGI:1 194 500]
Ahcyl13.24E-210.36 060 6420.6680.5041.05E-16S-adenosylhomocysteine hydrolase-like 1 [Source:MGI Symbol;Acc:MGI:2 385 184]
Shroom35.82E-210.39 782 5920.4570.3191.88E-16shroom family member 3 [Source:MGI Symbol;Acc:MGI:1 351 655]
Mertk1.09E-200.43 718 9990.7980.6383.51E-16MER proto-oncogene tyrosine kinase [Source:MGI Symbol;Acc:MGI:96 965]
Wasf31.16E-200.33 069 6330.5510.3623.75E-16WASP family, member 3 [Source:MGI Symbol;Acc:MGI:2 658 986]
Myo162.10E-20−0.26815250.0950.2096.78E-16myosin XVI [Source:MGI Symbol;Acc:MGI:2 685 951]
9630028H03Rik2.28E-200.32 473 4260.3040.1257.38E-16RIKEN cDNA 9630028H03 gene [Source:MGI Symbol;Acc:MGI:2 444 526]
Plekha54.64E-20−0.27234810.2040.3521.50E-15pleckstrin homology domain containing, family A member 5 [Source:MGI Symbol;Acc:MGI:1 923 802]
Npas24.88E-200.38 493 5470.5710.3891.58E-15neuronal PAS domain protein 2 [Source:MGI Symbol;Acc:MGI:109 232]
St3gal41.26E-190.3 840 1030.5460.3434.07E-15ST3 beta-galactoside alpha-2,3-sialyltransferase 4 [Source:MGI Symbol;Acc:MGI:1 316 743]
Dmd1.92E-190.42 285 6190.8240.6986.19E-15dystrophin, muscular dystrophy [Source:MGI Symbol;Acc:MGI:94 909]
Myo5a1.96E-19−0.26387170.2090.3356.32E-15myosin VA [Source:MGI Symbol;Acc:MGI:105 976]
Ralgps23.83E-19−0.25903480.1680.3161.24E-14Ral GEF with PH domain and SH3 binding motif 2 [Source:MGI Symbol;Acc:MGI:1 925 505]
Tprkb5.94E-19−0.34531490.360.5041.92E-14Tp53rk binding protein [Source:MGI Symbol;Acc:MGI:1 917 036]
Plcl16.13E-19−0.40963640.5850.5211.98E-14phospholipase C-like 1 [Source:MGI Symbol;Acc:MGI:3 036 262]
Mgat56.17E-19−0.31846110.3260.4861.99E-14mannoside acetylglucosaminyltransferase 5 [Source:MGI Symbol;Acc:MGI:894 701]
Htra17.27E-190.36 090 7440.6620.4722.35E-14HtrA serine peptidase 1 [Source:MGI Symbol;Acc:MGI:1 929 076]
Vegfa7.45E-190.35 819 2410.5390.3732.41E-14vascular endothelial growth factor A [Source:MGI Symbol;Acc:MGI:103 178]
Nim1k1.14E-180.321 9310.4130.2413.68E-14NIM1 serine/threonine protein kinase [Source:MGI Symbol;Acc:MGI:2 442 399]
Nrg21.19E-18−0.30421890.2230.3733.84E-14neuregulin 2 [Source:MGI Symbol;Acc:MGI:1 098 246]
Hif1a1.93E-180.27 065 1160.2740.1386.25E-14hypoxia inducible factor 1, alpha subunit [Source:MGI Symbol;Acc:MGI:106 918]
Mical22.68E-180.32 752 0130.6480.4838.64E-14microtubule associated monooxygenase, calponin and LIM domain containing 2 [Source:MGI Symbol;Acc:MGI:2 444 947]
Lhfpl33.27E-18−0.39838020.2910.3751.05E-13lipoma HMGIC fusion partner-like 3 [Source:MGI Symbol;Acc:MGI:1 925 076]
Ntm3.91E-180.2 944 4280.9950.971.26E-13neurotrimin [Source:MGI Symbol;Acc:MGI:2 446 259]
Tafa14.53E-180.48 678 1360.3110.1651.46E-13TAFA chemokine like family member 1 [Source:MGI Symbol;Acc:MGI:2 443 695]
Arid5b5.38E-18−0.26222790.1420.2621.74E-13AT rich interactive domain 5B (MRF1-like) [Source:MGI Symbol;Acc:MGI:2 175 912]
Esrrg6.07E-180.36 245 5160.4910.3681.96E-13estrogen-related receptor gamma [Source:MGI Symbol;Acc:MGI:1 347 056]
Ankrd286.58E-18−0.29471650.3410.4832.13E-13ankyrin repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 145 661]
Wdr177.20E-180.40 737 0870.8440.7512.32E-13WD repeat domain 17 [Source:MGI Symbol;Acc:MGI:1 924 662]
Fus7.50E-18−0.27191570.3640.5112.42E-13fused in sarcoma [Source:MGI Symbol;Acc:MGI:1 353 633]
Dpyd8.99E-18−0.297580.2540.3852.90E-13dihydropyrimidine dehydrogenase [Source:MGI Symbol;Acc:MGI:2 139 667]
Stard131.30E-17−0.37483710.3750.5414.20E-13StAR-related lipid transfer (START) domain containing 13 [Source:MGI Symbol;Acc:MGI:2 385 331]
Adcy81.36E-17−0.30606340.2410.3494.41E-13adenylate cyclase 8 [Source:MGI Symbol;Acc:MGI:1 341 110]
Ptprd1.76E-17−0.3245270.8480.8485.68E-13protein tyrosine phosphatase, receptor type, D [Source:MGI Symbol;Acc:MGI:97 812]
9630014M24Rik2.04E-170.26 701 2950.2730.1056.58E-13RIKEN cDNA 9630014M24 gene [Source:MGI Symbol;Acc:MGI:3 588 234]
Btbd92.29E-17−0.28980790.3360.4867.39E-13BTB (POZ) domain containing 9 [Source:MGI Symbol;Acc:MGI:1 916 625]
Auts22.68E-170.3 804 8110.9110.8028.65E-13autism susceptibility candidate 2 [Source:MGI Symbol;Acc:MGI:1 919 847]
Arhgap233.14E-17−0.27142860.2340.3221.01E-12Rho GTPase activating protein 23 [Source:MGI Symbol;Acc:MGI:3 697 726]
Pde10a3.38E-170.58 969 9390.4040.2341.09E-12phosphodiesterase 10A [Source:MGI Symbol;Acc:MGI:1 345 143]
Grip14.32E-170.31 380 7160.2810.1341.40E-12glutamate receptor interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 921 303]
St6galnac57.24E-170.32 665 3220.2550.1042.34E-12ST6 (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase 5 [Source:MGI Symbol;Acc:MGI:1 349 471]
Ctnnd27.33E-170.29 063 9440.9810.9592.37E-12catenin (cadherin associated protein), delta 2 [Source:MGI Symbol;Acc:MGI:1 195 966]
Map2k67.54E-170.2 867 0680.3820.2052.43E-12mitogen-activated protein kinase kinase 6 [Source:MGI Symbol;Acc:MGI:1 346 870]
Gm351881.00E-160.33 492 2850.6420.4773.23E-12predicted gene, 35 188 [Source:MGI Symbol;Acc:MGI:5 594 347]
Kmt2c1.20E-160.32 629 1870.6490.5433.89E-12lysine (K)-specific methyltransferase 2C [Source:MGI Symbol;Acc:MGI:2 444 959]
Eda1.43E-16−0.31566060.210.3564.62E-12ectodysplasin-A [Source:MGI Symbol;Acc:MGI:1 195 272]
Egfr1.70E-160.3 217 7370.4580.2585.49E-12epidermal growth factor receptor [Source:MGI Symbol;Acc:MGI:95 294]
Negr12.09E-160.37 537 6390.8530.6976.76E-12neuronal growth regulator 1 [Source:MGI Symbol;Acc:MGI:2 444 846]
Chd92.70E-160.31 204 8060.7730.668.72E-12chromodomain helicase DNA binding protein 9 [Source:MGI Symbol;Acc:MGI:1 924 001]
4930545L23Rik3.15E-160.2 525 5620.2130.0751.02E-11RIKEN cDNA 4930545L23 gene [Source:MGI Symbol;Acc:MGI:1 926 055]
Mbnl23.57E-16−0.29711720.5840.6871.15E-11muscleblind like splicing factor 2 [Source:MGI Symbol;Acc:MGI:2 145 597]
Cdc42bpa3.90E-16−0.28820290.5660.6451.26E-11CDC42 binding protein kinase alpha [Source:MGI Symbol;Acc:MGI:2 441 841]
Rgs7bp5.91E-160.28 765 1370.3440.2141.91E-11regulator of G-protein signalling 7 binding protein [Source:MGI Symbol;Acc:MGI:106 334]
Hip16.79E-160.31 045 9310.4820.3022.19E-11huntingtin interacting protein 1 [Source:MGI Symbol;Acc:MGI:1 099 804]
Kcnj107.30E-160.28 764 8760.3580.2382.36E-11potassium inwardly-rectifying channel, subfamily J, member 10 [Source:MGI Symbol;Acc:MGI:1 194 504]
Gab18.69E-16−0.25106650.2290.3392.80E-11growth factor receptor bound protein 2-associated protein 1 [Source:MGI Symbol;Acc:MGI:108 088]
Limch11.22E-150.3 424 3420.6760.5073.95E-11LIM and calponin homology domains 1 [Source:MGI Symbol;Acc:MGI:1 924 819]
Gm303821.52E-150.27 365 5450.1680.0584.92E-11predicted gene, 30 382 [Source:MGI Symbol;Acc:MGI:5 589 541]
Aldoc1.70E-150.27 040 7730.4890.3565.48E-11aldolase C, fructose-bisphosphate [Source:MGI Symbol;Acc:MGI:101 863]
Wwc11.81E-150.30 910 5710.5530.4035.85E-11WW, C2 and coiled-coil domain containing 1 [Source:MGI Symbol;Acc:MGI:2 388 637]
Phka11.91E-150.35 229 3050.6470.5216.17E-11phosphorylase kinase alpha 1 [Source:MGI Symbol;Acc:MGI:97 576]
Map4k41.93E-15−0.26654580.4050.5246.22E-11mitogen-activated protein kinase kinase kinase kinase 4 [Source:MGI Symbol;Acc:MGI:1 349 394]
Stk32a2.16E-15−0.42537670.2270.3436.99E-11serine/threonine kinase 32A [Source:MGI Symbol;Acc:MGI:2 442 403]
Igsf112.48E-15−0.2698380.3420.488.01E-11immunoglobulin superfamily, member 11 [Source:MGI Symbol;Acc:MGI:2 388 477]
Utrn2.56E-15−0.35209440.5960.6478.26E-11utrophin [Source:MGI Symbol;Acc:MGI:104 631]
Prkn2.62E-15−0.356710.5920.7158.46E-11parkin RBR E3 ubiquitin protein ligase [Source:MGI Symbol;Acc:MGI:1 355 296]
Syn23.73E-150.29 810 5870.520.3921.21E-10synapsin II [Source:MGI Symbol;Acc:MGI:103 020]
Dbx24.19E-150.25 917 6930.370.2261.35E-10developing brain homeobox 2 [Source:MGI Symbol;Acc:MGI:107 445]
Gm61454.52E-150.30 080 3970.6410.51.46E-10predicted gene 6145 [Source:MGI Symbol;Acc:MGI:3 779 559]
Id44.92E-15−0.29273950.2740.4291.59E-10inhibitor of DNA binding 4 [Source:MGI Symbol;Acc:MGI:99 414]
Dpf35.68E-150.2 822 1580.4370.2831.83E-10double PHD fingers 3 [Source:MGI Symbol;Acc:MGI:1 917 377]
F38.81E-150.30 629 6780.5420.4232.84E-10coagulation factor III [Source:MGI Symbol;Acc:MGI:88 381]
Sat12.02E-140.28 493 3810.4240.2886.51E-10spermidine/spermine N1-acetyl transferase 1 [Source:MGI Symbol;Acc:MGI:98 233]
Pbx12.05E-14−0.32819210.90.8976.62E-10pre B cell leukemia homeobox 1 [Source:MGI Symbol;Acc:MGI:97 495]
Tmem178b2.22E-14−0.34648750.3980.4847.18E-10transmembrane protein 178B [Source:MGI Symbol;Acc:MGI:3 647 581]
Ghr2.76E-140.30 505 4690.4920.3388.90E-10growth hormone receptor [Source:MGI Symbol;Acc:MGI:95 708]
Ptprz12.79E-140.29 632 4440.8980.8399.02E-10protein tyrosine phosphatase, receptor type Z, polypeptide 1 [Source:MGI Symbol;Acc:MGI:97 816]
Gm161682.81E-14−0.25244130.1990.3069.08E-10predicted gene 16 168 [Source:MGI Symbol;Acc:MGI:3 802 010]
Arhgap263.02E-140.30 202 1830.5340.49.74E-10Rho GTPase activating protein 26 [Source:MGI Symbol;Acc:MGI:1 918 552]
Etnppl3.68E-140.32 550 8230.4010.2491.19E-09ethanolamine phosphate phospholyase [Source:MGI Symbol;Acc:MGI:1 919 010]
Slc7a23.76E-14−0.26928090.3050.4171.22E-09solute carrier family 7 (cationic amino acid transporter, y + system), member 2 [Source:MGI Symbol;Acc:MGI:99 828]
Ube2e24.03E-14−0.30365550.4780.6011.30E-09ubiquitin-conjugating enzyme E2E 2 [Source:MGI Symbol;Acc:MGI:2 384 997]
Gli34.62E-140.28 367 6840.6990.5731.49E-09GLI-Kruppel family member GLI3 [Source:MGI Symbol;Acc:MGI:95 729]
Ccdc1414.83E-140.2 782 9790.4670.3381.56E-09coiled-coil domain containing 141 [Source:MGI Symbol;Acc:MGI:1 919 735]
Tmtc24.83E-140.36 794 5040.5730.3691.56E-09transmembrane and tetratricopeptide repeat containing 2 [Source:MGI Symbol;Acc:MGI:1 914 057]
Immp2l6.36E-14−0.26882140.1850.3122.05E-09IMP2 inner mitochondrial membrane peptidase-like (S. cerevisiae) [Source:MGI Symbol;Acc:MGI:2 135 611]
Tenm37.88E-14−0.32306420.5270.6572.54E-09teneurin transmembrane protein 3 [Source:MGI Symbol;Acc:MGI:1 345 183]
Agl8.71E-140.25 181 8080.4210.2892.81E-09amylo-1,6-glucosidase, 4-alpha-glucanotransferase [Source:MGI Symbol;Acc:MGI:1 924 809]
Phkg18.88E-140.27 904 1170.6790.5732.87E-09phosphorylase kinase gamma 1 [Source:MGI Symbol;Acc:MGI:97 579]
Nbea9.70E-14−0.25885620.5130.6113.13E-09neurobeachin [Source:MGI Symbol;Acc:MGI:1 347 075]
Smyd31.16E-13−0.28255640.350.4973.74E-09SET and MYND domain containing 3 [Source:MGI Symbol;Acc:MGI:1 916 976]
Chst111.30E-13−0.26105280.2590.374.21E-09carbohydrate sulfotransferase 11 [Source:MGI Symbol;Acc:MGI:1 927 166]
Ptgds1.42E-13−0.27257340.3860.4694.57E-09prostaglandin D2 synthase (brain) [Source:MGI Symbol;Acc:MGI:99 261]
Bmpr1b1.51E-13−0.31688010.670.7414.86E-09bone morphogenetic protein receptor, type 1B [Source:MGI Symbol;Acc:MGI:107 191]
Rmst1.63E-13−0.38929720.7550.7955.26E-09rhabdomyosarcoma 2 associated transcript (non-coding RNA) [Source:MGI Symbol;Acc:MGI:1 099 806]
Camk1d1.68E-130.30 376 0590.6740.5195.42E-09calcium/calmodulin-dependent protein kinase ID [Source:MGI Symbol;Acc:MGI:2 442 190]
Ttc281.69E-13−0.26126680.3640.4865.45E-09tetratricopeptide repeat domain 28 [Source:MGI Symbol;Acc:MGI:2 140 873]
Zfp4621.76E-13−0.27398350.3250.4465.67E-09zinc finger protein 462 [Source:MGI Symbol;Acc:MGI:107 690]
Pde8b2.74E-130.29 540 4520.430.2718.84E-09phosphodiesterase 8B [Source:MGI Symbol;Acc:MGI:2 443 999]
Slc25a213.38E-13−0.2738290.1370.2821.09E-08solute carrier family 25 (mitochondrial oxodicarboxylate carrier), member 21 [Source:MGI Symbol;Acc:MGI:2 445 059]
Arhgef285.58E-130.27 161 2430.4410.3621.80E-08Rho guanine nucleotide exchange factor (GEF) 28 [Source:MGI Symbol;Acc:MGI:1 346 016]
Pla2g76.34E-130.28 317 9970.6010.4572.05E-08phospholipase A2, group VII (platelet-activating factor acetylhydrolase, plasma) [Source:MGI Symbol;Acc:MGI:1 351 327]
Prr161.04E-120.30 343 2770.3070.1753.34E-08proline rich 16 [Source:MGI Symbol;Acc:MGI:1 918 623]
Spred11.39E-120.25 156 3280.4630.3194.48E-08sprouty protein with EVH-1 domain 1, related sequence [Source:MGI Symbol;Acc:MGI:2 150 016]
Atp2b21.40E-120.25 015 0340.5860.4274.53E-08ATPase, Ca++ transporting, plasma membrane 2 [Source:MGI Symbol;Acc:MGI:105 368]
Exoc6b1.53E-12−0.25067150.4340.5244.93E-08exocyst complex component 6B [Source:MGI Symbol;Acc:MGI:1 923 164]
Itpr21.56E-120.25 815 6070.490.3455.02E-08inositol 1,4,5-triphosphate receptor 2 [Source:MGI Symbol;Acc:MGI:99 418]
Serpine21.96E-120.27 511 2770.4960.3486.32E-08serine (or cysteine) peptidase inhibitor, clade E, member 2 [Source:MGI Symbol;Acc:MGI:101 780]
Irak21.97E-120.26 542 0630.4680.3256.36E-08interleukin-1 receptor-associated kinase 2 [Source:MGI Symbol;Acc:MGI:2 429 603]
Fgf142.41E-12−0.27184350.760.8237.79E-08fibroblast growth factor 14 [Source:MGI Symbol;Acc:MGI:109 189]
2610035D17Rik3.32E-12−0.27191880.4060.5341.07E-07RIKEN cDNA 2610035D17 gene [Source:MGI Symbol;Acc:MGI:1 919 636]
Gli23.49E-120.25 442 8620.4650.3231.13E-07GLI-Kruppel family member GLI2 [Source:MGI Symbol;Acc:MGI:95 728]
Map46.20E-12−0.25090260.4780.5612.00E-07microtubule-associated protein 4 [Source:MGI Symbol;Acc:MGI:97 178]
Ptprj6.24E-120.31 704 5660.430.2882.02E-07protein tyrosine phosphatase, receptor type, J [Source:MGI Symbol;Acc:MGI:104 574]
Nnat7.56E-12−0.33234990.1710.2112.44E-07neuronatin [Source:MGI Symbol;Acc:MGI:104 716]
Fut98.43E-120.28 325 3660.6640.5642.72E-07fucosyltransferase 9 [Source:MGI Symbol;Acc:MGI:1 330 859]
Cpq1.19E-110.26 741 0010.5240.4343.83E-07carboxypeptidase Q [Source:MGI Symbol;Acc:MGI:1 889 205]
Pigk1.20E-110.25 920 6470.2630.1423.86E-07phosphatidylinositol glycan anchor biosynthesis, class K [Source:MGI Symbol;Acc:MGI:1 913 863]
Grid11.20E-110.25 653 8330.4520.3093.88E-07glutamate receptor, ionotropic, delta 1 [Source:MGI Symbol;Acc:MGI:95 812]
Plpp32.08E-110.27 305 6680.7940.7116.72E-07phospholipid phosphatase 3 [Source:MGI Symbol;Acc:MGI:1 915 166]
Tbc1d52.18E-11−0.25629020.3960.4637.05E-07TBC1 domain family, member 5 [Source:MGI Symbol;Acc:MGI:1 919 488]
Znrf32.20E-110.25 537 2480.5420.4127.12E-07zinc and ring finger 3 [Source:MGI Symbol;Acc:MGI:3 039 616]
Zfhx33.18E-11−0.28845420.3670.4521.03E-06zinc finger homeobox 3 [Source:MGI Symbol;Acc:MGI:99 948]
Hivep34.73E-110.2 583 2130.7320.6171.53E-06human immunodeficiency virus type I enhancer binding protein 3 [Source:MGI Symbol;Acc:MGI:106 589]
Nr3c25.97E-110.28 553 2910.6330.5211.93E-06nuclear receptor subfamily 3, group C, member 2 [Source:MGI Symbol;Acc:MGI:99 459]
Nav36.01E-110.32 715 6190.5190.3691.94E-06neuron navigator 3 [Source:MGI Symbol;Acc:MGI:2 183 703]
Rfx46.35E-11−0.32866310.5220.6242.05E-06regulatory factor X, 4 (influences HLA class II expression) [Source:MGI Symbol;Acc:MGI:1 918 387]
Ank7.92E-11−0.25649490.4180.4932.56E-06progressive ankylosis [Source:MGI Symbol;Acc:MGI:3 045 421]
Rorb8.58E-110.28 096 1340.8630.7662.77E-06RAR-related orphan receptor beta [Source:MGI Symbol;Acc:MGI:1 343 464]
Paqr89.40E-100.26 548 7410.680.5853.03E-05progestin and adipoQ receptor family member VIII [Source:MGI Symbol;Acc:MGI:1 921 479]
Dlgap11.02E-090.25 343 1480.850.7583.28E-05DLG associated protein 1 [Source:MGI Symbol;Acc:MGI:1 346 065]
Pcdh91.62E-090.30 264 9330.9920.9595.25E-05protocadherin 9 [Source:MGI Symbol;Acc:MGI:1 306 801]
Grm32.89E-090.43 138 1540.5690.4699.32E-05glutamate receptor, metabotropic 3 [Source:MGI Symbol;Acc:MGI:1 351 340]
Cdh201.24E-080.27 398 5620.7170.650.000 399 728cadherin 20 [Source:MGI Symbol;Acc:MGI:1 346 069]
Fam155a1.75E-08−0.4497730.2930.3960.00 056 492NA
Lhfp5.61E-080.30 326 9220.560.460.001 810 805lipoma HMGIC fusion partner [Source:MGI Symbol;Acc:MGI:1 920 048]

To interrogate the inner variability of AG3, we performed an individual similarity test using CFS metric by sub-setting the clusters from AG3 cells and performing a community analysis on the resulting graph. Results revealed three distinct sub-groups (Fig. 5A), that once annotated, showed similar sources of variability on the merged data of AG3 cells as a second test (Fig. 5B). We decided to include cluster 2 from sample sc.699 on AG3 group 3 as the number of inward edges was higher from subgroup 3 than from the assigned community group 2. We hypothesized these sub-populations corresponded to transient astrocytic states. To test this, we computed pseudotime scores using Monocle2 [36] for these three distinct groups using the merged data (Fig. 5B). Top genes found differentially expressed as a function of pseudotime were linked by similar terms related with cell junction, cell-cell and synapse signaling, glutamatergic synapse, and transmembrane transport (Fig. 5D). Cell-cell communication analysis using the motor cortex expression data from the tree mice found Contactin (CNTN) and Neural Cell Adhesion Molecule (NCAM) signaling pathways exclusively active between AG3 and neuronal subclusters (Fig. 5C). CNTN family of cell recognition molecules are involved in the maintenance of the nervous system [99]. NCAM mediates neural cell–cell interactions and neurite outgrowth [100] and facilitates the interaction between astrocytes and synapses, modulating neuronal communication [101].

Detailed analysis of AG 3. (A) Similarity of clusters within AG3 subpopulation. Community analysis over the graph showed three distinct groups. (B) UMAP of AG3 subgroups and the computed pseudotime across these subgroups. Expression data from AG3 from all mice was previously merge and processed. (C) Cell-cell signaling pathways CNTN and NEGR with an active role of AG3 with various neuron subclusters. (D) Gene expression of relevant biological functions that showed significant differential expression as function of pseudotime.
Figure 5.

Detailed analysis of AG 3. (A) Similarity of clusters within AG3 subpopulation. Community analysis over the graph showed three distinct groups. (B) UMAP of AG3 subgroups and the computed pseudotime across these subgroups. Expression data from AG3 from all mice was previously merge and processed. (C) Cell-cell signaling pathways CNTN and NEGR with an active role of AG3 with various neuron subclusters. (D) Gene expression of relevant biological functions that showed significant differential expression as function of pseudotime.

Discussion

Single cell sequencing represents a powerful approach offering an unprecedent resolution at molecular level. Here we introduce ClusterFoldSimilarity, a novel methodology designed to analyze collections of independent datasets including multimodal, multi-tissue or multi-species experiments, without data integration. Due to its interpretability, CFS enhance reproducibility and comparability of single cell studies, and can be easily integrated into the existing bioinformatics ecosystem. Our novel metric successfully identifies similar cell groups across any number of independent datasets, encompassing different sequencing technologies, achieving similar benchmarking scores at cell type labeling as other state of the art integrative methods, although with a higher accuracy when the number of overlapping features between single cell studies is low. Importantly, it achieves this without the need for an integrative step or batch effect removal over the sequencing signal, both of which can be strongly influenced by noise and inherent partial stochasticity in the data, potentially resulting in the loss of information. It first computes FCs using a Bayesian approach to estimate differential abundance, adapting and expanding previous statistical frameworks, to construct a comparable frame of reference between groups and datasets. The similarity can be understood as a cumulative score across all features, in which concordant FCs in the same vector space point at a similar phenotype. A potential limitation of our method arises when cell-level resolution is needed, as our metric operates at cell-group level, information at individual-cell level is not available. To partially mitigate this, incrementing the granularity and the number of groups could be desirable. Although, we show that our metric captures information related with the heterogeneity of cell groups, and the feature selection ability of our method can help identifying distinct markers of the composing members of the clusters on downstream analysis.

We demonstrate the effective comparison of diverse omics datasets, first by benchmarking cell labeling accuracy using a complex mice gastrulation dataset, and a multi-species pancreatic assay. Secondly, we show how our methodology is capable of matching conserved cell groups across different species, using pancreatic single-cell RNA-seq from human and mouse. In a third example, we expand the multimodality to include single-cell proteomics (CyTOF), bulk-sorted RNA-Seq and single-cell RNA-Seq from synovial tissue of RA and OA patients from B cells, T cells, monocytes, and stromal fibroblast populations. The similarity scores correctly associated cell groups with the same phenotype, even with a small number of common features available (n = 33). An additional multimodal assay was tested employing gene activity scores derived from ATAC-seq and a reference RNA-Seq data, matching populations across peripheral blood mononuclear cells (PBMC) datasets.

Finally, to exemplify a real use case, we sequence and analyze single-nuclei RNA-Seq data obtained from the spinal cord and motor cortex of adult mice, with a focus on exploring astrocytes as a disease-relevant glial cell subpopulation. By utilizing our similarity score, we identify three distinct subpopulations that are present in both tissues, each associated with diverse functionalities: a small population enriched in neurogenesis markers, a medium-size group of activated Gfap-positive astrocytes, and a large group of mature astrocytes with three additional sub-phenotypes. These findings will allow to further explore the roles of different astrocyte types or activation states depending, for example, on age or disease.

We believe that ClusterFoldSimilarity presents a valuable contribution to the ecosystem of bioinformatic tools for single-cell analysis, providing easily interpretable results, and solutions for the construction and exploitation of future cell atlases, which will be indispensable for gaining a comprehensive understanding of cell and tissue heterogeneity.

Acknowledgements

Author contributions: Conceptualization, O.G.V.; Data curation, O.G.V., M.S., and R.Y.; Formal analysis, O.G.V. and M.S.; Funding acquisition, B.B. and J.W.; Methodology, O.G.V.; Project administration, B.B., C.D.I., and O.G.V.; Resources, R.P., R.Y., and J.W.; Software, O.G.V.; Supervision, C.D.I.; Writing – original draft, O.G.V.; Writing – review & editing, J.W., C.D.I., R.P., and B.B.

Supplementary data

Supplementary data is available at NAR Genomics & Bioinformatics online.

Conflict of interest

None declared.

Funding

This publication was supported through state funds approved by the State Parliament of Baden-Württemberg for the Innovation Campus Health + Life Science Alliance Heidelberg Mannheim.

Data availability

The algorithm ClusterFoldSimilariy is implemented in R language and freely available for download from Bioconductor repository (https://www.bioconductor.org/) as an R package (DOI: 10.18129/B9.bioc.ClusterFoldSimilarity), and on GitHub: https://github.com/OscarGVelasco/ClusterFoldSimilarity.

Data from the pancreatic single-cell RNA-Seq datasets used for validation are available from Gene Expression Omnibus (GEO) under accession numbers: GSE84133 [102], GSE86469 [103], GSE81608 [104], and ArrayExpress: E-MTAB-5061 [105]. PBMC ATAC-Seq and RNA-Seq data from 10x was downloaded from 10x genomic website: https://www.10xgenomics.com/resources/datasets/10k-human-pbmcs-atac-v2-chromium-controller-2-standard for unimodal ATAC-Seq. CITE-seq atlas of the circulating human immune system, comprising 160k cells with 26 annotated cell types was downloaded from GEO database under the accession number GEO: GSE164378. RA and OA single-cell RNA-seq data, bulk RNA-seq data and mass cytometry data were downloaded from ImmPort (https://www.immport.org/shared/study/SDY998) under study accession code SDY998.

CellRanger output and Seurat objects with the processed data, including astrocyte subpopulation annotation, from the mouse single-nuclei RNA-Seq data from spinal cord and cortex generated for this analysis, as well as some of the processed test public datasets, are openly available in Zenodo (doi: 10.5281/zenodo.14843698). All the R script to generate the results, benchmarks and figures can be found on the Zenodo repository: 10.5281/zenodo.15082356.

References

1.

Kashima
 
Y
,
Sakamoto
 
Y
,
Kaneko
 
K
 et al. .  
Single-cell sequencing techniques from individual to multiomics analyses
.
Exp Mol Med
.
2020
;
52
:
1419
27
..

2.

Elmentaite
 
R
,
Domínguez
 
Conde C
,
Yang
 
L
 et al. .  
Single-cell atlases: shared and tissue-specific cell types across human organs
.
Nat Rev Genet
.
2022
;
23
:
395
410
..

3.

Regev
 
A
,
Teichmann
 
SA
,
Lander
 
ES
 et al. .  
The human cell Atlas
.
eLife
.
2017
;
6
:
e27041
.

4.

Svensson
 
V
,
da
 
Veiga Beltrame E
,
Pachter
 
L
 
A curated database reveals trends in single-cell transcriptomics
.
Database
.
2020
;
2020
:
baaa073
.

5.

Andrews
 
TS
,
Kiselev
 
VY
,
McCarthy
 
D
 et al. .  
Tutorial: guidelines for the computational analysis of single-cell RNA sequencing data
.
Nat Protoc
.
2021
;
16
:
1
9
..

6.

Heumos
 
L
,
Schaar
 
AC
,
Lance
 
C
 et al. .  
Best practices for single-cell analysis across modalities
.
Nat Rev Genet
.
2023
;
24
:
550
72
.
2023 24:8
.

7.

Flynn
 
E
,
Almonte-Loya
 
A
,
Fragiadakis
 
GK
 
Single-cell multiomics
.
Annu Rev Biomed Data Sci
.
2023
;
6
:
313
37
..

8.

Tran
 
HTN
,
Ang
 
KS
,
Chevrier
 
M
 et al. .  
A benchmark of batch-effect correction methods for single-cell RNA sequencing data
.
Genome Biol
.
2020
;
21
:
12
.

9.

Clark
 
NM
,
Elmore
 
JM
,
Walley
 
JW
 
To the proteome and beyond: advances in single-cell omics profiling for plant systems
.
Plant Physiol
.
2022
;
188
:
726
37
..

10.

Miao
 
Z
,
Humphreys
 
BD
,
McMahon
 
AP
 et al. .  
Multi-omics integration in the age of million single-cell data
.
Nat Rev Nephrol
.
2021
;
17
:
710
24
..

11.

Kharchenko
 
PV
 
The triumphs and limitations of computational methods for scRNA-seq
.
Nat Methods
.
2021
;
18
:
723
32
..

12.

Chari
 
T
,
Pachter
 
L
 
The specious art of single-cell genomics
.
PLoS Comput Biol
.
2023
;
19
:
e1011288
.

13.

Yang
 
KD
,
Belyaeva
 
A
,
Venkatachalapathy
 
S
 et al. .  
Multi-domain translation between single-cell imaging and sequencing data using autoencoders
.
Nat Commun
.
2021
;
12
:
31
.

14.

Ginhoux
 
F
,
Yalin
 
A
,
Dutertre
 
CA
 et al. .  
Single-cell immunology: past, present, and future
.
Immunity
.
2022
;
55
:
393
404
..

15.

Hao
 
Y
,
Stuart
 
T
,
Kowalski
 
MH
 et al. .  
Dictionary learning for integrative, multimodal and scalable single-cell analysis
.
Nat Biotechnol
.
2024
;
42
:
293
304
..

16.

Ghazanfar
 
S
,
Guibentif
 
C
,
Marioni
 
JC
 
Stabilized mosaic single-cell data integration using unshared features
.
Nat Biotechnol
.
2024
;
42
:
284
92
..

17.

Luecken
 
MD
,
Büttner
 
M
,
Chaichoompu
 
K
 et al. .  
Benchmarking atlas-level data integration in single-cell genomics
.
Nat Methods
.
2022
;
19
:
41
50
..

18.

Lähnemann
 
D
,
Köster
 
J
,
Szczurek
 
E
 et al. .  
Eleven grand challenges in single-cell data science
.
Genome Biol
.
2020
;
21
:
31
.

19.

Gibson
 
G
 
Perspectives on rigor and reproducibility in single cell genomics
.
PLoS Genet
.
2022
;
18
:
e1010210
.

20.

Mou
 
T
,
Deng
 
W
,
Gu
 
F
 et al. .  
Reproducibility of methods to detect differentially expressed genes from single-cell RNA sequencing
.
Front Genet
.
2020
;
10
:
486248
.

21.

Vieth
 
B
,
Parekh
 
S
,
Ziegenhain
 
C
 et al. .  
A systematic evaluation of single cell RNA-seq analysis pipelines
.
Nat Commun
.
2019
;
10
:
4667
.

22.

Jones
 
RC
,
Karkanias
 
J
,
Krasnow
 
MA
 et al. .  
The Tabula Sapiens: a multiple-organ, single-cell transcriptomic atlas of humans
.
Science
.
2022
;
376
:
eabl4896
.

23.

Elmentaite
 
R
,
Domínguez
 
Conde C
,
Yang
 
L
 et al. .  
Single-cell atlases: shared and tissue-specific cell types across human organs
.
Nat Rev Genet
.
2022
;
23
:
395
410
..

24.

Flynn
 
E
,
Almonte-Loya
 
A
,
Fragiadakis
 
GK
 
Single-cell multiomics
.
Annu Rev Biomed Data Sci
.
2023
;
6
:
313
37
..

25.

Lun
 
A
 
Overcoming systematic errors caused by log-transformation of normalized single-cell RNA sequencing data
.
31 August 2018, preprint: not peer reviewed
.

26.

Townes
 
FW
,
Hicks
 
SC
,
Aryee
 
MJ
 et al. .  
Feature selection and dimension reduction for single-cell RNA-Seq based on a multinomial model
.
Genome Biol
.
2019
;
20
:
295
.

27.

Johnson
 
KA
,
Krishnan
 
A
 
Robust normalization and transformation techniques for constructing gene coexpression networks from RNA-seq data
.
Genome Biol
.
2022
;
23
:
1
.

28.

Erhard
 
F
 
Estimating pseudocounts and fold changes for digital expression measurements
.
Bioinformatics
.
2018
;
34
:
4054
63
..

29.

Erhard
 
F
,
Zimmer
 
R
 
Count ratio model reveals bias affecting NGS fold changes
.
Nucleic Acids Res
.
2015
;
43
:
e136
.

30.

Hoffman
 
MM
,
Buske
 
OJ
,
Wang
 
J
 et al. .  
Unsupervised pattern discovery in human chromatin structure through genomic segmentation
.
Nat Methods
.
2012
;
9
:
473
6
..

31.

Anders
 
S
,
Huber
 
W
 
Differential expression analysis for sequence count data
.
Genome Biol
.
2010
;
11
:
R106
.

32.

Gabor
 
C
,
Tamas
 
N
 
The igraph software package for complex network research
.
Complex Syst
.
2006
;
5
:
1695
.

33.

Frick
 
A
,
Ludwig
 
A
,
Mehldau
 
H
 
A fast adaptive layout algorithm for undirected graphs (extended abstract and system demonstration)
.
Lecture Notes in Computer Science (including subseries Lecture Notes in Artificial Intelligence and Lecture Notes in Bioinformatics)
.
1995
;
894
:
388
403
.

34.

Jin
 
S
,
Guerrero-Juarez
 
CF
,
Zhang
 
L
 et al. .  
Inference and analysis of cell-cell communication using CellChat
.
Nat Commun
.
2021
;
12
:
1
20
..

35.

Jin
 
S
,
Plikus
 
MV
,
Nie
 
Q
 
CellChat for systematic analysis of cell–cell communication from single-cell transcriptomics
.
Nat Protoc
.
2024
;
20
:
180
219
..

36.

Trapnell
 
C
,
Cacchiarelli
 
D
,
Grimsby
 
J
 et al. .  
The dynamics and regulators of cell fate decisions are revealed by pseudotemporal ordering of single cells
.
Nat Biotechnol
.
2014
;
32
:
381
6
..

37.

Baron
 
M
,
Veres
 
A
,
Wolock
 
SL
 et al. .  
A single-cell transcriptomic map of the human and mouse pancreas reveals inter- and intra-cell population structure
.
Cell Syst
.
2016
;
3
:
346
60
..

38.

Pijuan-Sala
 
B
,
Griffiths
 
JA
,
Guibentif
 
C
 et al. .  
A single-cell molecular map of mouse gastrulation and early organogenesis
.
Nature
.
2019
;
566
:
490
5
..

39.

Griffiths
 
JA
,
Guibentif
 
C
 et al. .  
A single-cell molecular map of mouse gastrulation and early organogenesis
.
Nature
.
2019
;
566
:
490
5
..

40.

González-Velasco
 
Ó
 
LotOfCells: data visualization and statistics of single cell metadata
.
bioRxiv
28 May 2024, preprint: not peer reviewed
.

41.

Sun
 
T
,
Song
 
D
,
Li
 
WV
 et al. .  
scDesign2: a transparent simulator that generates high-fidelity single-cell gene expression count data with gene correlations captured
.
Genome Biol
.
2021
;
22
:
163
.

42.

Benjamin
 
DJ
,
Berger
 
JO
,
Johannesson
 
M
 et al. .  
Redefine statistical significance
.
Nat Hum Behav
.
2018
;
2
:
6
10
..

43.

Johnson
 
VE
 
Revised standards for statistical evidence
.
Proc Natl Acad Sci USA
.
2013
;
110
:
19313
7
..

44.

Hao
 
Y
,
Hao
 
S
,
Andersen-Nissen
 
E
 et al. .  
Integrated analysis of multimodal single-cell data
.
Cell
.
2021
;
184
:
3573
87
..

45.

Amezquita
 
RA
,
Lun
 
ATL
,
Becht
 
E
 et al. .  
Orchestrating single-cell analysis with bioconductor
.
Nat Methods
.
2020
;
17
:
137
45
..

46.

Muraro
 
MJ
,
Dharmadhikari
 
G
,
Grün
 
D
 et al. .  
A single-cell transcriptome atlas of the human pancreas
.
Cell Syst
.
2016
;
3
:
385
94
..

47.

Kordes
 
C
,
Sawitza
 
I
,
Götze
 
S
 et al. .  
Stellate cells are mesenchymal stem cells
.
Eur J Med Res
.
2014
;
19
:
S6
.

48.

Baran
 
Y
,
Bercovich
 
A
,
Sebe-Pedros
 
A
 et al. .  
MetaCell: analysis of single-cell RNA-seq data using K-nn graph partitions
.
Genome Biol
.
2019
;
20
:
206
.

49.

Persad
 
S
,
Choo
 
ZN
,
Dien
 
C
 et al. .  
SEACells infers transcriptional and epigenomic cellular states from single-cell genomics data
.
Nat Biotechnol
.
2023
;
41
:
1746
1757
..

50.

Ben-Kiki
 
O
,
Bercovich
 
A
,
Lifshitz
 
A
 et al. .  
Metacell-2: a divide-and-conquer metacell algorithm for scalable scRNA-seq analysis
.
Genome Biol
.
2022
;
23
:
1746
57
..

51.

Zhang
 
F
,
Wei
 
K
,
Slowikowski
 
K
 et al. .  
Defining inflammatory cell states in rheumatoid arthritis joint synovial tissues by integrating single-cell transcriptomics and mass cytometry
.
Nat Immunol
.
2019
;
20
:
928
42
..

52.

Wu
 
M
,
Mei
 
F
,
Liu
 
W
 et al. .  
Comprehensive characterization of tumor infiltrating natural killer cells and clinical significance in hepatocellular carcinoma based on gene expression profiles
.
Biomed Pharmacother
.
2020
;
121
:
109637
.

53.

Hidalgo
 
LG
,
Einecke
 
G
,
Allanach
 
K
 et al. .  
The transcriptome of human cytotoxic T Cells: similarities and disparities among allostimulated CD4+ CTL, CD8+ CTL and NK cells
.
Am J Transplant
.
2008
;
8
:
627
36
..

54.

Dou
 
X
,
Peng
 
M
,
Jiang
 
R
 et al. .  
Upregulated CD8+ MAIT cell differentiation and KLRD1 gene expression after inactivated SARS-CoV-2 vaccination identified by single-cell sequencing
.
Front Immunol
.
2023
;
14
:
1174406
.

55.

Burkard
 
T
,
Herrero
 
M
,
Juan
 
S
 et al. .  
Differential expression of CD8 defines phenotypically distinct cytotoxic T cells in cancer and multiple sclerosis
.
Clin Trans Med
.
2022
;
12
:
e1068
.

56.

Dossi
 
E
,
Vasile
 
F
,
Rouach
 
N
 
Human astrocytes in the diseased brain
.
Brain Res Bull
.
2018
;
136
:
139
56
..

57.

Palmer
 
AL
,
Ousman
 
SS
 
Astrocytes and aging
.
Front Aging Neurosci
.
2018
;
10
:
419245
.

58.

Sofroniew
 
MV
,
Vinters
 
HV
 
Astrocytes: biology and pathology
.
Acta Neuropathol
.
2010
;
119
:
7
35
..

59.

Giusti
 
V
,
Kaur
 
G
,
Giusto
 
E
 et al. .  
Brain clearance of protein aggregates: a close-up on astrocytes
.
Mol Neurodegener
.
2024
;
19
:
5
.

60.

Pehar
 
M
,
Harlan
 
BA
,
Killoy
 
KM
 et al. .  
Role and therapeutic potential of astrocytes in amyotrophic lateral sclerosis
.
Curr Pharm Des
.
2017
;
23
:
5010
21
.

61.

Stoklund
 
Dittlau K
,
Van
 
Den Bosch L
 
Why should we care about astrocytes in a motor neuron disease?
.
Front Mol Med
.
2023
;
3
:
1047540
.

62.

Vaz
 
SH
,
Pinto
 
S
,
Sebastião
 
AM
 et al. .  
Astrocytes in amyotrophic lateral sclerosis
.
Exon Publications
.
2021
;
3
:
978-0-6450017-7-8
.

63.

Matias
 
I
,
Morgado
 
J
,
Gomes
 
FCA
 
Astrocyte heterogeneity: impact to brain aging and disease
.
Front Aging Neurosci
.
2019
;
11
:
447123
.

64.

Jurga
 
AM
,
Paleczna
 
M
,
Kadluczka
 
J
 et al. .  
Beyond the GFAP-astrocyte protein markers in the brain
.
Biomolecules
.
2021
;
11
:
1361
.

65.

Eng
 
LF
,
Ghirnikar
 
RS
,
Lee
 
YL
 
Glial fibrillary acidic protein: GFAP-thirty-one years (1969-2000)
.
Neurochem Res
.
2000
;
25
:
1439
51
..

66.

Hol
 
EM
,
Pekny
 
M
 
Glial fibrillary acidic protein (GFAP) and the astrocyte intermediate filament system in diseases of the central nervous system
.
Curr Opin Cell Biol
.
2015
;
32
:
121
30
..

67.

Escartin
 
C
,
Galea
 
E
,
Lakatos
 
A
 et al. .  
Reactive astrocyte nomenclature, definitions, and future directions
.
Nat Neurosci
.
2021
;
24
:
312
25
.

68.

Bondurand
 
N
,
Sham
 
MH
 
The role of SOX10 during enteric nervous system development
.
Dev Biol
.
2013
;
382
:
330
43
..

69.

Pingault
 
V
,
Zerad
 
L
,
Bertani-Torres
 
W
 et al. .  
SOX10: 20 years of phenotypic plurality and current understanding of its developmental function
.
J Med Genet
.
2022
;
59
:
105
14
..

70.

Bhattarai
 
C
,
Poudel
 
PP
,
Ghosh
 
A
 et al. .  
Comparative role of SOX10 gene in the gliogenesis of central, peripheral, and enteric nervous systems
.
Differentiation
.
2022
;
128
:
13
25
..

71.

Ning
 
Y
,
Huang
 
J
,
Kalionis
 
B
 et al. .  
Oleanolic acid induces differentiation of neural stem cells to neurons: an involvement of transcription factor Nkx-2.5
.
Stem Cell Int
.
2015
;
2015
:
672312
.

72.

Qin
 
Z
,
Ren
 
F
,
Xu
 
X
 et al. .  
ZNF536, a novel zinc finger protein specifically expressed in the brain, negatively regulates neuron differentiation by repressing retinoic acid-induced gene transcription
.
Mol Cell Biol
.
2009
;
29
:
3633
43
..

73.

Epifanova
 
E
,
Babaev
 
A
,
Newman
 
AG
 et al. .  
Role of Zeb2/Sip1 in neuronal development
.
Brain Res
.
2019
;
1705
:
24
31
.

74.

McKinsey
 
GL
,
Lindtner
 
S
,
Trzcinski
 
B
 et al. .  
Dlx1&2-dependent expression of Zfhx1b (Sip1, Zeb2) regulates the fate switch between cortical and striatal interneurons
.
Neuron
.
2013
;
77
:
83
98
.

75.

Rousso
 
DL
,
Gaber
 
ZB
,
Wellik
 
D
 et al. .  
Coordinated actions of the forkhead protein Foxp1 and Hox proteins in the columnar organization of spinal motor neurons
.
Neuron
.
2008
;
59
:
226
40
..

76.

Palmesino
 
E
,
Rousso
 
DL
,
Kao
 
TJ
 et al. .  
Foxp1 and Lhx1 coordinate motor neuron migration with axon trajectory choice by gating reelin signalling
.
PLoS Biol
.
2010
;
8
:
e1000446
.

77.

Dasen
 
JS
,
De
 
Camilli A
,
Wang
 
B
 et al. .  
Hox repertoires for motor neuron diversity and connectivity gated by a single accessory factor, FoxP1
.
Cell
.
2008
;
134
:
304
16
.

78.

Magnusson
 
JP
,
Göritz
 
C
,
Tatarishvili
 
J
 et al. .  
A latent neurogenic program in astrocytes regulated by Notch signaling in the mouse
.
Science(1979)
.
2014
;
346
:
237
41
.

79.

Garcia
 
ADR
,
Doan
 
NB
,
Imura
 
T
 et al. .  
GFAP-expressing progenitors are the principal source of constitutive neurogenesis in adult mouse forebrain
.
Nat Neurosci
.
2004
;
7
:
1233
41
..

80.

Batiuk
 
MY
,
Martirosyan
 
A
,
Wahis
 
J
 et al. .  
Identification of region-specific astrocyte subtypes at single cell resolution
.
Nat Commun
.
2020
;
11
:
1220
.

81.

Hagihara
 
H
,
Murano
 
T
,
Ohira
 
K
 et al. .  
Expression of progenitor cell/immature neuron markers does not present definitive evidence for adult neurogenesis
.
Mol Brain
.
2019
;
12
:
108
.

82.

Suto
 
F
,
Ito
 
K
,
Uemura
 
M
 et al. .  
Plexin-a4 mediates axon-repulsive activities of both secreted and transmembrane semaphorins and plays roles in nerve fiber guidance
.
J Neurosci
.
2005
;
25
:
3628
37
..

83.

Hatanaka
 
Y
,
Kawasaki
 
T
,
Abe
 
T
 et al. .  
Semaphorin 6A–Plexin A2/A4 interactions with radial glia regulate migration termination of superficial layer cortical neurons
.
iScience
.
2019
;
21
:
359
74
..

84.

Limoni
 
G
,
Niquille
 
M
 
Semaphorins and Plexins in central nervous system patterning: the key to it all?
.
Curr Opin Neurobiol
.
2021
;
66
:
224
32
..

85.

Mei
 
L
,
Nave
 
KA
 
Neuregulin-ERBB signaling in nervous system development and neuropsychiatric diseases
.
Neuron
.
2014
;
83
:
27
49
..

86.

Ledonne
 
A
,
Mercuri
 
NB
 
On the modulatory roles of neuregulins/ErbB signaling on synaptic plasticity
.
Int J Mol Sci
.
2019
;
21
:
275
.

87.

Yau
 
H
,
Wang
 
H
,
Lai
 
C
 et al. .  
Neural development of the neuregulin receptor ErbB4 in the cerebral cortex and the hippocampus: Preferential expression by interneurons tangentially migrating from t
.
Cereb Cortex
.
2003
;
13
:
252
64
..

88.

Kataria
 
H
,
Alizadeh
 
A
,
Karimi-Abdolrezaee
 
S
 
Neuregulin-1/ErbB network: an emerging modulator of nervous system injury and repair
.
Prog Neurobiol
.
2019
;
180
:
101643
.

89.

Niu
 
W
,
Zang
 
T
,
Zou
 
Y
 et al. .  
In vivo reprogramming of astrocytes to neuroblasts in the adult brain
.
Nat Cell Biol
.
2013
;
15
:
1164
75
..

90.

Gascón
 
S
,
Murenu
 
E
,
Masserdotti
 
G
 et al. .  
Identification and successful negotiation of a metabolic checkpoint in direct neuronal reprogramming
.
Cell Stem Cell
.
2016
;
18
:
396
409
..

91.

Chen
 
YC
,
Ma
 
NX
,
Pei
 
ZF
 et al. .  
A NeuroD1 AAV-based gene therapy for functional brain repair after ischemic injury through in vivo astrocyte-to-neuron conversion
.
Mol Ther
.
2020
;
28
:
217
34
..

92.

Zamboni
 
M
,
Llorens-Bobadilla
 
E
,
Magnusson
 
JP
 et al. .  
A widespread neurogenic potential of neocortical astrocytes is induced by injury
.
Cell Stem Cell
.
2020
;
27
:
605
17
..

93.

Hu
 
X
,
Qin
 
S
,
Huang
 
X
 et al. .  
Region-restrict astrocytes exhibit heterogeneous susceptibility to neuronal reprogramming
.
Stem Cell Rep
.
2019
;
12
:
290
304
..

94.

Bocchi
 
R
,
Masserdotti
 
G
,
GöTz
 
M
 
Direct neuronal reprogramming: fast forward from new concepts toward therapeutic approaches
.
Neuron
.
2022
;
3
:
366
93
..

95.

Mathys
 
H
,
Adaikkan
 
C
,
Gao
 
F
 et al. .  
Temporal tracking of microglia activation in neurodegeneration at single-cell resolution
.
Cell Rep.
 
2017
;
21
:
366
80
..

96.

Liddelow
 
SA
,
Guttenplan
 
KA
,
Clarke
 
LE
 et al. .  
Neurotoxic reactive astrocytes are induced by activated microglia
.
Nature
.
2017
;
541
:
481
7
.

97.

Verkhratsky
 
A
,
Nedergaard
 
M
 
Physiology of astroglia
.
Physiol Rev
.
2018
;
98
:
239
389
..

98.

de Majo
 
M
,
Koontz
 
M
,
Rowitch
 
D
 et al. .  
An update on human astrocytes and their role in development and disease
.
Glia
.
2020
;
68
:
685
704
..

99.

Mohebiany
 
AN
,
Harroch
 
S
,
Bouyain
 
S
 
New insights into the roles of the contactin cell adhesion molecules in neural development
.
Adv Neurobiol
.
2014
;
8
:
165
94
..

100.

Weledji
 
EPa
,
Assob
 
JC
 
The ubiquitous neural cell adhesion molecule (N-CAM)
.
Ann Med Surg
.
2014
;
3
:
77
81
.

101.

Hillen
 
AEJ
,
Burbach
 
JPH
,
Hol
 
EM
 
Cell adhesion and matricellular support by astrocytes of the tripartite synapse
.
Prog Neurobiol
.
2018
;
165–167
:
66
86
..

102.

Baron
 
M
,
Veres
 
A
,
Wolock
 
SL
 et al. .  
A single-cell transcriptomic map of the human and mouse pancreas reveals inter- and intra-cell population structure
.
Cell Syst
.
2016
;
3
:
346
60
..

103.

Lawlor
 
N
,
George
 
J
,
Bolisetty
 
M
 et al. .  
Single-cell transcriptomes identify human islet cell signatures and reveal cell-type-specific expression changes in type 2 diabetes
.
Genome Res
.
2017
;
27
:
208
22
..

104.

Xin
 
Y
,
Kim
 
J
,
Okamoto
 
H
 et al. .  
RNA sequencing of single human islet cells reveals type 2 diabetes genes
.
Cell Metab
.
2016
;
24
:
608
15
..

105.

Segerstolpe
 
Å
,
Palasantza
 
A
,
Eliasson
 
P
 et al. .  
Single-cell transcriptome profiling of human pancreatic islets in health and type 2 diabetes
.
Cell Metab
.
2016
;
24
:
593
607
..

This is an Open Access article distributed under the terms of the Creative Commons Attribution License (https://creativecommons.org/licenses/by/4.0/), which permits unrestricted reuse, distribution, and reproduction in any medium, provided the original work is properly cited.

Supplementary data

Comments

0 Comments
Submit a comment
You have entered an invalid code
Thank you for submitting a comment on this article. Your comment will be reviewed and published at the journal's discretion. Please check for further notifications by email.